SCZ-associated variant effects on L5 pyr cell NN activity and delta osc. (Maki-Marttunen et al 2018)

 Download zip file   Auto-launch 
Help downloading and running models
Accession:237469
" … Here, using computational modeling, we show that a common biomarker of schizophrenia, namely, an increase in delta-oscillation power, may be a direct consequence of altered expression or kinetics of voltage-gated ion channels or calcium transporters. Our model of a circuit of layer V pyramidal cells highlights multiple types of schizophrenia-related variants that contribute to altered dynamics in the delta frequency band. Moreover, our model predicts that the same membrane mechanisms that increase the layer V pyramidal cell network gain and response to delta-frequency oscillations may also cause a decit in a single-cell correlate of the prepulse inhibition, which is a behavioral biomarker highly associated with schizophrenia."
Reference:
1 . Mäki-Marttunen T, Krull F, Bettella F, Hagen E, Næss S, Ness TV, Moberget T, Elvsåshagen T, Metzner C, Devor A, Edwards AG, Fyhn M, Djurovic S, Dale AM, Andreassen OA, Einevoll GT (2019) Alterations in Schizophrenia-Associated Genes Can Lead to Increased Power in Delta Oscillations. Cereb Cortex 29:875-891 [PubMed]
Citations  Citation Browser
Model Information (Click on a link to find other models with that property)
Model Type: Neuron or other electrically excitable cell;
Brain Region(s)/Organism: Neocortex;
Cell Type(s): Neocortex L5/6 pyramidal GLU cell;
Channel(s): Ca pump; I A, slow; I h; I K; I K,Ca; I K,leak; I L high threshold; I M; I Na,p; I Na,t; I T low threshold;
Gap Junctions: Gap junctions;
Receptor(s): AMPA; NMDA; Gaba;
Gene(s): Cav1.2 CACNA1C; Cav1.3 CACNA1D; Cav3.3 CACNA1I; HCN1; Kv2.1 KCNB1; Nav1.1 SCN1A; PMCA ATP2B2;
Transmitter(s): Glutamate; Gaba;
Simulation Environment: NEURON; Python; LFPy;
Model Concept(s): Schizophrenia; Oscillations;
Implementer(s): Maki-Marttunen, Tuomo [tuomomm at uio.no];
Search NeuronDB for information about:  Neocortex L5/6 pyramidal GLU cell; AMPA; NMDA; Gaba; I Na,p; I Na,t; I L high threshold; I T low threshold; I K; I K,leak; I M; I h; I K,Ca; I A, slow; Ca pump; Gaba; Glutamate;
/
scznet
approxhaynet
models
README.html
Ca_HVA.mod *
Ca_LVAst.mod *
CaDynamics_E2.mod *
Ih.mod *
Im.mod *
K_Pst.mod *
K_Tst.mod *
Nap_Et2.mod *
NaTa_t.mod *
ProbAMPANMDA2.mod
ProbAMPANMDA2group.mod
ProbAMPANMDA2groupdet.mod
ProbUDFsyn2.mod *
ProbUDFsyn2group.mod *
ProbUDFsyn2groupdet.mod *
SK_E2.mod *
SKv3_1.mod *
approxhaynetstuff.py
calcEEG.py
calcEEG_uncombined.py
calcmutgains.py
calcmutgains_comb.py
calcmutoscs.py
calcmutoscs_comb.py
calcspectra.py
calcspectra_comb.py
combinemutgains_parallel.py
combinemutgains_parallel_comb.py
combinemutgains_parallel_withLFP.py
combinemutoscs_parallel.py
combinemutoscs_parallel_comb.py
drawfig1ab.py
drawfig1c.py
drawfig2ab.py
drawfig2c.py
drawstationary_EEG.py
drawstationary_EEG_pop.py
mutation_stuff.py *
mytools.py
pars_withmids_combfs_final.sav *
runmanycellsLFP.py
runsinglecellLFP.py
saveisidists.py
savespikesshufflephases.py
scalings_cs.sav
simosc_parallel.py
simosc_parallel_comb_varconn.py
simseedburst_func.py
simseedburst_func_comb_varconn.py
simseedburst_func_withLFP.py
simseedburst_func_withLFP.pyc
                            
import matplotlib
matplotlib.use('Agg')
import mytools
from pylab import *
from neuron import h
import pickle
from os.path import exists
import numpy
import scipy.io
import time

rates = [0.1*x for x in range(4,17)]
gsyn = 1.07
gNoise = 1.07

irate_chosen = 6

cols = ['#666666','#012345','#cc00aa','#bbaa00','#ee6600','#ff0000', '#00aaaa','#772277','#00cc00']
col_control = '#2222ff'  

seeds = [1,2,3,4,5]
gauss_std = 25 #ms

f,axarr = subplots(2,1)
for irate in range(0,len(rates)):
  myrate = rates[irate]
  foundOne = False
  for iseed in range(0,len(seeds)):
    myseed = seeds[iseed]
    mutIDs = [0]
    if irate == irate_chosen:
      mutIDs = [0,70]
    for imut in range(0,len(mutIDs)):
      mutID = mutIDs[imut]
      mycolor = col_control
      mystyle = 'b-'
      if imut == 1:
        mycolor = cols[2]
        mystyle = 'b--'
      if exists('spikes_parallel150_mutID'+str(mutID)+'_'+str(myrate)+'_gNoise'+str(gNoise)+'_gsyn'+str(gsyn)+'_seed'+str(myseed)+'.sav'):
        print 'loading spikes_parallel150_mutID'+str(mutID)+'_'+str(myrate)+'_gNoise'+str(gNoise)+'_gsyn'+str(gsyn)+'_seed'+str(myseed)+'.sav'
        unpicklefile = open('spikes_parallel150_mutID'+str(mutID)+'_'+str(myrate)+'_gNoise'+str(gNoise)+'_gsyn'+str(gsyn)+'_seed'+str(myseed)+'.sav', 'r')
        unpickledlist = pickle.load(unpicklefile)
        unpicklefile.close()
        Nplaced = 0
        spikedCells_all = []
        for j in range(0,len(unpickledlist[1])):
          spikedCells = unpickledlist[1][j]
          spikedCellsUnique = unique(spikedCells)
          spikedCells2 = zeros(spikedCells.shape)
          for i in range(0,len(spikedCellsUnique)):
            spikedCells2[spikedCells == spikedCellsUnique[i]] = Nplaced + i
          Nplaced = Nplaced + len(spikedCellsUnique)
          spikedCells_all = hstack([spikedCells_all, spikedCells2])
        spikes = [hstack(unpickledlist[0]),spikedCells_all]
        if irate == irate_chosen:
          axarr[0].plot(spikes[0][::5],[x+irate*150 for x in spikes[1]][::5],'b.',color='#000000',markersize=0.5)
        else:
          axarr[0].plot(spikes[0][::5],[x+irate*150 for x in spikes[1]][::5],'b.',markersize=0.5)
        foundOne = True
      else:
        print 'spikes_parallel150_mutID'+str(mutID)+'_'+str(myrate)+'_gNoise'+str(gNoise)+'_gsyn'+str(gsyn)+'_seed'+str(myseed)+'.sav not found'
      if irate == irate_chosen:
        nSpikesBins = zeros([11001,])
        nSpikesBins_conv = zeros([11001,])
        tBins = [0.5+x for x in range(0,11001)]
        print "Calculating nSpikes"
        for ispike in range(0,len(spikes[0])):
          nSpikesBins[int(spikes[0][ispike])] = nSpikesBins[int(spikes[0][ispike])] + 1
        for ibin in range(0,len(nSpikesBins)):
          nSpikesBins_conv[ibin] = sum(exp(-1/2*(tBins[ibin]-spikes[0])**2/gauss_std**2))/sqrt(pi*gauss_std**2)
        print "Done"

        axarr[1].plot(tBins, nSpikesBins_conv/150*1000, mystyle, color=mycolor)
    if foundOne:
      break
axarr[0].set_xlim([0,11000])
axarr[0].set_xticks([0,2000,4000,6000,8000,10000])
axarr[0].set_xlabel('$t$ (ms)')
axarr[0].set_yticks([])
axarr[0].set_ylabel('neurons')
for irate in range(0,len(rates)):
      axarr[0].plot([0,11000],[irate*150,irate*150],'b-',linewidth=0.25,color='#777777')
      axarr[0].text(-670+10017,irate*150+38,'r = '+str(rates[irate]),fontsize=8,color='#ffffff',fontweight='bold')
      axarr[0].text(-670+10017,irate*150+52,'r = '+str(rates[irate]),fontsize=8,color='#ffffff',fontweight='bold')
      axarr[0].text(-670+10000-17,irate*150+38,'r = '+str(rates[irate]),fontsize=8,color='#ffffff',fontweight='bold')
      axarr[0].text(-670+10000-17,irate*150+52,'r = '+str(rates[irate]),fontsize=8,color='#ffffff',fontweight='bold')
      axarr[0].text(-670+10000,irate*150+45,'r = '+str(rates[irate]),fontsize=8,color='#ff0000',fontweight='bold')
axarr[0].set_ylim([0,150*13])

axarr[1].set_xlim([0,11000])
axarr[1].set_ylim([0,16])
axarr[1].set_yticks([0,5,10,15])
axarr[1].set_xlabel('$t$ (ms)')
axarr[1].set_ylabel('$f$ (Hz)')
axarr[0].set_position([0.125, 0.536363636364, 0.375, 0.9-0.536363636364])
axarr[1].set_position([0.125, 0.1, 0.375, 0.463636363636-0.1])
          
print 'saving fig1ab.eps'
          
f.text(0.05, 0.86, 'A', fontsize=28)
f.text(0.05, 0.45, 'B', fontsize=28)
f.savefig('fig1ab.eps')