Integrate-and-Fire (IF) neuron models

This category contains all iaf, gif, mat, and aeif models.

class aeif_cond_alpha : public Archiving_Node
#include <aeif_cond_alpha.h>

Name: aeif_cond_alpha - Conductance based exponential integrate-and-fire neuron model according to Brette and Gerstner (2005). Description:

aeif_cond_alpha is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005). Synaptic conductances are modelled as alpha-functions.

This implementation uses the embedded 4th order Runge-Kutta-Fehlberg solver with adaptive step size to integrate the differential equation.

The membrane potential is given by the following differential equation:

\[\begin{split} C_m \frac{dV}{dt} = -g_L(V-E_L)+g_L\Delta_T\exp\left(\frac{V-V_{th}}{\Delta_T}\right) - g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]

and

\[ \tau_w \frac{dw}{dt} = a(V-E_L) - w \]

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

g_ex

nS

Excitatory synaptic conductance

dg_ex

nS/ms

First derivative of g_ex

g_in

nS

Inhibitory synaptic conductance

dg_in

nS/ms

First derivative of g_in

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Synaptic parameters

E_ex

mV

Excitatory reversal potential

tau_syn_ex

ms

Rise time of excitatory synaptic conductance (alpha function)

E_in

mV

Inhibitory reversal potential

tau_syn_in

ms

Rise time of the inhibitory synaptic conductance (alpha function)

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Authors: Marc-Oliver Gewaltig; full revision by Tanguy Fardet on December 2016

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642 DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_cond_alpha, aeif_cond_exp

class aeif_cond_alpha_multisynapse : public Archiving_Node
#include <aeif_cond_alpha_multisynapse.h>

Name: aeif_cond_alpha_multisynapse - Conductance based adaptive exponential integrate-and-fire neuron model according to Brette and Gerstner (2005) with multiple synaptic rise time and decay time constants, and synaptic conductance modeled by an alpha function.

Description:

aeif_cond_alpha_multisynapse is a conductance-based adaptive exponential integrate-and-fire neuron model. It allows an arbitrary number of synaptic time constants. Synaptic conductance is modeled by an alpha function, as described by A. Roth and M.C.W. van Rossum in Computational Modeling Methods for Neuroscientists, MIT Press 2013, Chapter 6.

The time constants are supplied by an array, “tau_syn”, and the pertaining synaptic reversal potentials are supplied by the array “E_rev”. Port numbers are automatically assigned in the range from 1 to n_receptors. During connection, the ports are selected with the property “receptor_type”.

The membrane potential is given by the following differential equation:

\[ C dV/dt = -g_L(V-E_L) + g_L*\Delta_T*\exp((V-V_T)/\Delta_T) + I_{syn_{tot}}(V, t)- w + I_e \]
where

\[ I_{syn_{tot}}(V,t) = \sum_i g_i(t) (V - E_{rev,i}) , \]

the synapse i is excitatory or inhibitory depending on the value of \( E_{rev,i}\) and the differential equation for the spike-adaptation current w is:

\[ \tau_w * dw/dt = a(V - E_L) - w \]

When the neuron fires a spike, the adaptation current w <- w + b.

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Delta_T

mV

Slope factor

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

tau_w

ms

Adaptation time constant

Synaptic parameters

E_rev

list of mV

Reversal potential

tau_syn

list of ms

Time constant of synaptic conductance

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Examples:

import nest
import numpy as np

neuron = nest.Create('aeif_cond_alpha_multisynapse')
nest.SetStatus(neuron, {"V_peak": 0.0, "a": 4.0, "b":80.5})
nest.SetStatus(neuron, {'E_rev':[0.0, 0.0, 0.0, -85.0],
                        'tau_syn':[1.0, 5.0, 10.0, 8.0]})

spike = nest.Create('spike_generator', params = {'spike_times':
                                                np.array([10.0])})

voltmeter = nest.Create('voltmeter', 1, {'withgid': True})

delays=[1.0, 300.0, 500.0, 700.0]
w=[1.0, 1.0, 1.0, 1.0]
for syn in range(4):
    nest.Connect(spike, neuron, syn_spec={'model': 'static_synapse',
                                          'receptor_type': 1 + syn,
                                          'weight': w[syn],
                                          'delay': delays[syn]})

nest.Connect(voltmeter, neuron)

nest.Simulate(1000.0)
dmm = nest.GetStatus(voltmeter)[0]
Vms = dmm["events"]["V_m"]
ts = dmm["events"]["times"]
import pylab
pylab.figure(2)
pylab.plot(ts, Vms)
pylab.show()

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: Hans Ekkehard Plesser, based on aeif_cond_beta_multisynapse

SeeAlso: aeif_cond_alpha_multisynapse

class aeif_cond_alpha_RK5 : public Archiving_Node
#include <aeif_cond_alpha_RK5.h>

Name: aeif_cond_alpha_RK5 - Conductance based exponential integrate-and-fire neuron model according to Brette and Gerstner (2005)

Description:

aeif_cond_alpha_RK5 is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005). Synaptic conductances are modelled as alpha-functions.

This implementation uses a 5th order Runge-Kutta solver with adaptive stepsize to integrate the differential equation (see Numerical Recipes 3rd Edition, Press et al. 2007, Ch. 17.2).

The membrane potential is given by the following differential equation:

\[\begin{split} C dV/dt= -g_L(V-E_L)+g_L*\Delta_T*\exp((V-V_T)/\Delta_T)-g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]
and

\[ \tau_w * dw/dt= a(V-E_L) -w \]

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

g_ex

nS

Excitatory synaptic conductance

dg_ex

nS/ms

First derivative of g_ex

g_in

nS

Inhibitory synaptic conductance

dg_in

nS/ms

First derivative of g_in

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Synaptic parameters

E_ex

mV

Excitatory reversal potential

tau_syn_ex

ms

Rise time of excitatory synaptic conductance (alpha function)

E_in

mV

Inhibitory reversal potential

tau_syn_in

ms

Rise time of the inhibitory synaptic conductance (alpha function)

Numerical integration parameters

HMIN

ms

Minimal stepsize for numerical integration (default 0.001ms)

MAXERR

mV

Error estimate tolerance for adaptive stepsize control (steps accepted if err<=MAXERR). Note that the error refers to the difference between the 4th and 5th order RK terms. Default 1e-10 mV.

  • Authors: Stefan Bucher, Marc-Oliver Gewaltig.

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642. DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_cond_alpha, aeif_cond_exp, aeif_cond_alpha

class aeif_cond_beta_multisynapse : public Archiving_Node
#include <aeif_cond_beta_multisynapse.h>

Name: aeif_cond_beta_multisynapse - Conductance based adaptive exponential integrate-and-fire neuron model according to Brette and Gerstner (2005) with multiple synaptic rise time and decay time constants, and synaptic conductance modeled by a beta function.

Description:

aeif_cond_beta_multisynapse is a conductance-based adaptive exponential integrate-and-fire neuron model. It allows an arbitrary number of synaptic rise time and decay time constants. Synaptic conductance is modeled by a beta function, as described by A. Roth and M.C.W. van Rossum in Computational Modeling Methods for Neuroscientists, MIT Press 2013, Chapter 6.

The time constants are supplied by two arrays, “tau_rise” and “tau_decay” for the synaptic rise time and decay time, respectively. The synaptic reversal potentials are supplied by the array “E_rev”. The port numbers are automatically assigned in the range from 1 to n_receptors. During connection, the ports are selected with the property “receptor_type”.

The membrane potential is given by the following differential equation:

\[ C dV/dt = -g_L(V-E_L) + g_L*\Delta_T*\exp((V-V_T)/\Delta_T) + I_{syn_{tot}}(V, t) - w + I_e \]

where:

\[ I_{syn_{tot}}(V,t) = \sum_i g_i(t) (V - E_{rev,i}) , \]

the synapse i is excitatory or inhibitory depending on the value of \( E_{rev,i} \) and the differential equation for the spike-adaptation current w is:

\[ \tau_w * dw/dt = a(V - E_L) - w \]

When the neuron fires a spike, the adaptation current w <- w + b.

Parameters: The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Delta_T

mV

Slope factor

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

tau_w

ms

Adaptation time constant

Synaptic parameters

E_rev

list of mV

Reversal potential

tau_syn

list of ms

Time constant of synaptic conductance

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Examples:

import nest
import numpy as np

neuron = nest.Create('aeif_cond_beta_multisynapse')
nest.SetStatus(neuron, {"V_peak": 0.0, "a": 4.0, "b":80.5})
nest.SetStatus(neuron, {'E_rev':[0.0,0.0,0.0,-85.0],
                        'tau_decay':[50.0,20.0,20.0,20.0],
                        'tau_rise':[10.0,10.0,1.0,1.0]})

spike = nest.Create('spike_generator', params = {'spike_times':
                                                np.array([10.0])})

voltmeter = nest.Create('voltmeter', 1, {'withgid': True})

delays=[1.0, 300.0, 500.0, 700.0]
w=[1.0, 1.0, 1.0, 1.0]
for syn in range(4):
    nest.Connect(spike, neuron, syn_spec={'model': 'static_synapse',
                                          'receptor_type': 1 + syn,
                                          'weight': w[syn],
                                          'delay': delays[syn]})

nest.Connect(voltmeter, neuron)

nest.Simulate(1000.0)
dmm = nest.GetStatus(voltmeter)[0]
Vms = dmm["events"]["V_m"]
ts = dmm["events"]["times"]
import pylab
pylab.figure(2)
pylab.plot(ts, Vms)
pylab.show()

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: Bruno Golosio 07/10/2016

SeeAlso: aeif_cond_alpha_multisynapse

class aeif_cond_exp : public Archiving_Node
#include <aeif_cond_exp.h>

Name: aeif_cond_exp - Conductance based exponential integrate-and-fire neuron model according to Brette and Gerstner (2005).

Description:

aeif_cond_exp is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005), with post-synaptic conductances in the form of truncated exponentials.

This implementation uses the embedded 4th order Runge-Kutta-Fehlberg solver with adaptive stepsize to integrate the differential equation.

The membrane potential is given by the following differential equation:

\[\begin{split} C dV/dt= -g_L(V-E_L)+g_L*\Delta_T*\exp((V-V_T)/\Delta_T)-g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]

and

\[ \tau_w * dw/dt= a(V-E_L) -W \]

Note that the spike detection threshold V_peak is automatically set to \( V_th+10 mV \) to avoid numerical instabilites that may result from setting V_peak too high.

Parameters: The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

g_ex

nS

Excitatory synaptic conductance

g_in

nS

Inhibitory synaptic conductance

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

nS

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Synaptic parameters

E_ex

mV

Excitatory reversal potential

tau_syn_ex

ms

Rise time of excitatory synaptic conductance (alpha function)

E_in

mV

Inhibitory reversal potential

tau_syn_in

ms

Rise time of the inhibitory synaptic conductance (alpha function)

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Author: Adapted from aeif_cond_alpha by Lyle Muller; full revision by Tanguy Fardet on December 2016

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642. DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_cond_exp, aeif_cond_alpha

class aeif_psc_alpha : public Archiving_Node
#include <aeif_psc_alpha.h>

Name: aeif_psc_alpha - Current-based exponential integrate-and-fire neuron model according to Brette and Gerstner (2005).

Description:

aeif_psc_alpha is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005). Synaptic currents are modelled as alpha-functions.

This implementation uses the embedded 4th order Runge-Kutta-Fehlberg solver with adaptive step size to integrate the differential equation.

The membrane potential is given by the following differential equation:

\[\begin{split} C dV/dt= -g_L(V-E_L)+g_L*\Delta_T*\exp((V-V_T)/\Delta_T)-g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]

and

\[ \tau_w * dw/dt= a(V-E_L) -W \]

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

I_ex

pA

Excitatory synaptic current

dI_ex

pA/ms

First derivative of I_ex

I_in

pA

Inhibitory synaptic current

dI_in

pA/ms

First derivative of I_in

w

pA

Spike-adaptation current

g

pa

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Synaptic parameters

tau_syn_ex

ms

Rise time of excitatory synaptic conductance (alpha function)

tau_syn_in

ms

Rise time of the inhibitory synaptic conductance (alpha function)

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities

Author: Tanguy Fardet

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642. DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_psc_alpha, aeif_cond_exp

class aeif_psc_delta : public Archiving_Node
#include <aeif_psc_delta.h>

Name: aeif_psc_delta - Current-based adaptive exponential integrate-and-fire neuron model according to Brette and Gerstner (2005) with delta synapse.

Description:

aeif_psc_delta is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005), with post-synaptic currents in the form of delta spikes.

This implementation uses the embedded 4th order Runge-Kutta-Fehlberg solver with adaptive stepsize to integrate the differential equation.

The membrane potential is given by the following differential equation:

\[\begin{split} C dV/dt= -g_L(V-E_L)+g_L*\Delta_T*\exp((V-V_T)/\Delta_T)-g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]

and

\[ \tau_w * dw/dt= a(V-E_L) -W \]

\[ I(t) = J \sum_k \delta(t - t^k). \]

Here delta is the dirac delta function and k indexes incoming spikes. This is implemented such that V_m will be incremented/decremented by the value of J after a spike.

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables

V_m

mV

Membrane potential

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

tau_w

ms

Adaptation time constant

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_th

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Author: Mikkel Elle Lepperød adapted from aeif_psc_exp and iaf_psc_delta

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642. DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_psc_delta, aeif_cond_exp, aeif_psc_exp

class aeif_psc_delta_clopath : public Clopath_Archiving_Node
#include <aeif_psc_delta_clopath.h>

Name: aeif_psc_delta_clopath - Exponential integrate-and-fire neuron model according to Clopath et al. (2010).

Description:

aeif_psc_delta_clopath is an implementation of the neuron model as it is used in [1]. It is an extension of the aeif_psc_delta model and capable of connecting to a Clopath synapse.

Note that there are two points that are not mentioned in the paper but present in a MATLAB implementation by Claudia Clopath [3]. The first one is the clamping of the membrane potential to a fixed value after a spike occured to mimik a real spike and not just the upswing. This is important since the finite duration of the spike influences the evolution of the convolved versions (u_bar_[plus/minus]) of the membrane potential and thus the change of the synaptic weight. Secondly, there is a delay with which u_bar_[plus/minus] are used to compute the change of the synaptic weight.

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables

V_m

mV

Membrane potential

w

pA

Spike-adaptation current

z

pA

Spike-adaptation current

V_th

mV

Adaptive spike initiation threshold

u_bar_plus

mV

Low-pass filtered Membrane potential

u_bar_minus

mV

Low-pass filtered Membrane potential

u_bar_bar

mV

Low-pass filtered u_bar_minus

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

tau_plus

ms

Time constant of u_bar_plus

tau_minus

ms

Time constant of u_bar_minus

tau_bar_bar

ms

Time constant of u_bar_bar

Spike adaptation parameters

a

nS

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_peak

mV

Spike detection threshold

V_th_max

mV

Value of V_th afer a spike

V_th_rest

mV

Resting value of V_th

Clopath rule parameters

A_LTD

1/mV

Amplitude of depression

A_LTP

1/mV^2

Amplitude of facilitation

theta_plus

mV

Threshold for u

theta_minus

mV

Threshold for u_bar_[plus/minus]

A_LTD_const

boolean

Flag that indicates whether A_LTD_ should be constant (true, default) or multiplied by u_bar_bar^2 / u_ref_squared (false).

delay_u_bars

real

Delay with which u_bar_[plus/minus] are processed to compute the synaptic weights.

U_ref_squared

real

Reference value for u_bar_bar_^2.

Other parameters

t_clamp

ms

Duration of clamping of Membrane potential after a spike

V_clamp

mV

Value to which the Membrane potential is clamped

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

Note:

Neither the clamping nor the delayed processing of u_bar_[plus/minus] are mentioned in [1]. However, they are part of an reference implementation by Claudia Clopath et al. that can be found on ModelDB [3]. The clamping is important to mimic a spike which is otherwise not described by the aeif neuron model.

Author: Jonas Stapmanns, David Dahmen, Jan Hahne

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Clopath et al. (2010). Connectivity reflects coding: a model of voltage-based STDP with homeostasis. Nature Neuroscience 13(3):344-352. DOI: https://doi.org/10.1038/nn.2479

2

Clopath and Gerstner (2010). Voltage and spike timing interact in STDP – a unified model. Frontiers in Synaptic Neuroscience. 2:25 DOI: https://doi.org/10.3389/fnsyn.2010.00025

3

Voltage-based STDP synapse (Clopath et al. 2010) on ModelDB https://senselab.med.yale.edu/ModelDB/showmodel.cshtml?model=144566&file=%2f modeldb_package%2fVoTriCode%2faEIF.m

SeeAlso: aeif_psc_delta, clopath_synapse, hh_psc_alpha_clopath

class aeif_psc_exp : public Archiving_Node
#include <aeif_psc_exp.h>

Name: aeif_psc_exp - Current-based exponential integrate-and-fire neuron model according to Brette and Gerstner (2005).

Description:

aeif_psc_exp is the adaptive exponential integrate and fire neuron according to Brette and Gerstner (2005), with post-synaptic currents in the form of truncated exponentials.

This implementation uses the embedded 4th order Runge-Kutta-Fehlberg solver with adaptive stepsize to integrate the differential equation.

The membrane potential is given by the following differential equation:

\[\begin{split} C dV/dt= -g_L(V-E_L)+g_L*\Delta_T*\exp((V-V_T)/\Delta_T)-g_e(t)(V-E_e) \\ -g_i(t)(V-E_i)-w +I_e \end{split}\]

and

\[ \tau_w * dw/dt= a(V-E_L) -W \]

Note that the spike detection threshold V_peak is automatically set to \( V_th+10 \) mV to avoid numerical instabilites that may result from setting V_peak too high.

Parameters:

The following parameters can be set in the status dictionary.

Dynamic state variables:

V_m

mV

Membrane potential

I_ex

pA

Excitatory synaptic current

I_in

pA

Inhibitory synaptic current

w

pA

Spike-adaptation current

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation parameters

a

ns

Subthreshold adaptation

b

pA

Spike-triggered adaptation

Delta_T

mV

Slope factor

tau_w

ms

Adaptation time constant

V_t

mV

Spike initiation threshold

V_peak

mV

Spike detection threshold

Synaptic parameters

tau_syn_ex

ms

Rise time of excitatory synaptic conductance (alpha function)

tau_syn_in

ms

Rise time of the inhibitory synaptic conductance (alpha function)

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities

Author: Tanguy Fardet

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Brette R and Gerstner W (2005). Adaptive Exponential Integrate-and-Fire Model as an Effective Description of Neuronal Activity. J Neurophysiol 94:3637-3642. DOI: https://doi.org/10.1152/jn.00686.2005

SeeAlso: iaf_psc_exp, aeif_cond_exp

class amat2_psc_exp : public Archiving_Node
#include <amat2_psc_exp.h>

Name: amat2_psc_exp - Non-resetting leaky integrate-and-fire neuron model with exponential PSCs and adaptive threshold.

Description:

amat2_psc_exp is an implementation of a leaky integrate-and-fire model with exponential shaped postsynaptic currents (PSCs). Thus, postsynaptic currents have an infinitely short rise time.

The threshold is lifted when the neuron is fired and then decreases in a fixed time scale toward a fixed level [3].

The threshold crossing is followed by a total refractory period during which the neuron is not allowed to fire, even if the membrane potential exceeds the threshold. The membrane potential is NOT reset, but continuously integrated.

The linear subthresold dynamics is integrated by the Exact Integration scheme [1]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [1]. A flow chart can be found in [2].

Remarks:

  • The default parameter values for this model are different from the corresponding parameter values for mat2_psc_exp.

  • If identical parameters are used, and beta==0, then this model shall behave exactly as mat2_psc_exp.

  • The time constants in the model must fullfill the following conditions:

    • \( \tau_m != {\tau_{syn_{ex}}, \tau_{syn_{in}}} \)

    • \( \tau_v != {\tau_{syn_{ex}}, \tau_{syn_{in}}} \)

    • \( \tau_m != \tau_v \) This is required to avoid singularities in the numerics. This is a problem of implementation only, not a principal problem of the model.

  • Expect unstable numerics if time constants that are required to be different are very close.

Parameters:

The following parameters can be set in the status dictionary:

C_m

pF

Capacity of the membrane

E_L

mV

Resting potential

tau_m

ms

Membrane time constant

tau_syn_ex

ms

Time constant of postsynaptic excitatory currents

tau_syn_in

ms

Time constant of postsynaptic inhibitory currents

t_ref

ms

Duration of absolute refractory period (no spiking)

V_m

mV

Membrane potential

I_e

pA

Constant input current

t_spike

ms

Point in time of last spike

tau_1

ms

Short time constant of adaptive threshold [3, eqs 2-3]

tau_2

ms

Long time constant of adaptive threshold [3, eqs 2-3]

alpha_1

mV

Amplitude of short time threshold adaption [3, eqs 2-3]

alpha_2

mV

Amplitude of long time threshold adaption [3, eqs 2-3]

tau_v

ms

Time constant of kernel for voltage-dependent threshold component [3, eqs 16-17]

beta

1/ms

Scaling coefficient for voltage-dependent threshold component [3, eqs 16-17]

omega

mV

Resting spike threshold (absolute value, not relative to E_L as in [3])

State variables that can be read out with the multimeter device

V_m

mV

Non-resetting membrane potential

V_th

mV

Two-timescale adaptive threshold

Remarks:

\( \tau_m != \tau_{syn_{ex,in}} \) is required by the current implementation to avoid a degenerate case of the ODE describing the model [1]. For very similar values, numerics will be unstable.

References:

1

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

2

Diesmann M, Gewaltig M-O, Rotter S, & Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI: https://doi.org/10.1016/S0925-2312(01)00409-X

3

Kobayashi R, Tsubo Y and Shinomoto S (2009). Made-to-order spiking neuron model equipped with a multi-timescale adaptive threshold. Frontiers in Computational Neuroscience, 3:9. DOI: https://dx.doi.org/10.3389%2Fneuro.10.009.2009

4

Yamauchi S, Kim H, Shinomoto S (2011). Elemental spiking neuron model for reproducing diverse firing patterns and predicting precise firing times. Frontiers in Computational Neuroscience, 5:42. DOI: https://doi.org/10.3389/fncom.2011.00042

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

FirstVersion: April 2013

Author: Thomas Heiberg & Hans E. Plesser (modified mat2_psc_exp model of Thomas Pfeil)

class gif_cond_exp : public Archiving_Node
#include <gif_cond_exp.h>

Name: gif_cond_exp - Conductance-based generalized integrate-and-fire neuron model according to Mensi et al. (2012) and Pozzorini et al. (2015).

Description:

gif_psc_exp is the generalized integrate-and-fire neuron according to Mensi et al. (2012) and Pozzorini et al. (2015), with post-synaptic conductances in the form of truncated exponentials.

This model features both an adaptation current and a dynamic threshold for spike-frequency adaptation. The membrane potential (V) is described by the differential equation:

\[ C*dV(t)/dt = -g_L*(V(t)-E_L) - \eta_1(t) - \eta_2(t) - \ldots - \eta_n(t) + I(t) \]

where each \( \eta_i \) is a spike-triggered current (stc), and the neuron model can have arbitrary number of them. Dynamic of each \( \eta_i \) is described by:

\[ \tau_\eta{_i}*d{\eta_i}/dt = -\eta_i \]

and in case of spike emission, its value increased by a constant (which can be positive or negative):

\[ \eta_i = \eta_i + q_{\eta_i} \text{ (in case of spike emission).} \]

Neuron produces spikes STOCHASTICALLY according to a point process with the firing intensity:

\[ \lambda(t) = \lambda_0 * \exp (V(t)-V_T(t)) / \Delta_V \]

where \( V_T(t) \) is a time-dependent firing threshold:

\[ V_T(t) = V_{T_star} + \gamma_1(t) + \gamma_2(t) + \ldots + \gamma_m(t) \]

where \( \gamma_i \) is a kernel of spike-frequency adaptation (sfa), and the neuron model can have arbitrary number of them. Dynamic of each \( \gamma_i \) is described by:

\[ \tau_{\gamma_i}*d\gamma_i/dt = -\gamma_i \]
and in case of spike emission, its value increased by a constant (which can be positive or negative):
\[ \gamma_i = \gamma_i + q_{\gamma_i} \text{ (in case of spike emission).} \]

Note:

In the current implementation of the model (as described in [1] and [2]), the values of \( \eta_i \) and \( \gamma_i \) are affected immediately after spike emission. However, GIF toolbox (http://wiki.epfl.ch/giftoolbox) which fits the model using experimental data, requires a different set of \( \eta_i \) and \( \gamma_i\) . It applies the jump of \( \eta_i \) and \( \gamma_i \) after the refractory period. One can easily convert between \( q_\eta/\gamma \) of these two approaches: \( q{_\eta}_{giftoolbox} = q_{\eta_{NEST}} * (1 - \exp( -\tau_{ref} / \tau_\eta )) \) The same formula applies for \( q_{\gamma} \).

The shape of synaptic conductance is exponential.

Parameters:

The following parameters can be set in the status dictionary.

Membrane Parameters

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_reset

mV

Reset value for V_m after a spike

E_L

mV

Leak reversal potential

g_L

nS

Leak conductance

I_e

pA

Constant external input current

Spike adaptation and firing intensity parameters

q_stc

list of nA

Values added to spike-triggered currents (stc) after each spike emission

tau_stc

list of ms

Time constants of stc variables

q_sfa

list of mV

Values added to spike-frequency adaptation (sfa) after each spike emission

tau_sfa

list of ms

Time constants of sfa variables

Delta_V

mV

Stochasticity level

lambda_0

real

Stochastic intensity at firing threshold V_T i n 1/s.

V_T_star

mV

Base threshold

Synaptic parameters

E_ex

mV

Excitatory reversal potential

tau_syn_ex

ms

Decay time of excitatory synaptic conductance

E_in

mV

Inhibitory reversal potential

tau_syn_in

ms

Decay time of the inhibitory synaptic conductance

Integration parameters

gsl_error_tol

real

This parameter controls the admissible error of the GSL integrator. Reduce it if NEST complains about numerical instabilities.

References:

1

Mensi S, Naud R, Pozzorini C, Avermann M, Petersen CC, Gerstner W (2012) Parameter extraction and classification of three cortical neuron types reveals two distinct adaptation mechanisms. Journal of Neurophysiology, 107(6):1756-1775. DOI: https://doi.org/10.1152/jn.00408.2011

2

Pozzorini C, Mensi S, Hagens O, Naud R, Koch C, Gerstner W (2015). Automated high-throughput characterization of single neurons by means of simplified spiking models. PLoS Computational Biology, 11(6), e1004275. DOI: https://doi.org/10.1371/journal.pcbi.1004275

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: March 2016, Setareh

SeeAlso: pp_psc_delta, gif_cond_exp_multisynapse, gif_psc_exp, gif_psc_exp_multisynapse

class iaf_chs_2007 : public Archiving_Node
#include <iaf_chs_2007.h>

Name: iaf_chs_2007 - Spike-response model used in Carandini et al 2007.

Description:

The membrane potential is the sum of stereotyped events: the postsynaptic potentials (V_syn), waveforms that include a spike and the subsequent after-hyperpolarization (V_spike) and Gaussian-distributed white noise.

The postsynaptic potential is described by alpha function where U_epsp is the maximal amplitude of the EPSP and tau_epsp is the time to peak of the EPSP.

The spike waveform is described as a delta peak followed by a membrane potential reset and exponential decay. U_reset is the magnitude of the reset/after-hyperpolarization and tau_reset is the time constant of recovery from this hyperpolarization.

The linear subthresold dynamics is integrated by the Exact Integration scheme [1]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

Remarks: The way the noise term was implemented in the original model makes it unsuitable for simulation in NEST. The workaround was to prepare the noise signal externally prior to simulation. The noise signal, if present, has to be at least as long as the simulation.

Parameters:

The following parameters can be set in the status dictionary.

tau_epsp

ms

Membrane time constant

tau_reset

ms

Refractory time constant

U_epsp

real

Maximum amplitude of the EPSP, normalized

U_reset

real

Reset value of the membrane potential, normalized

U_noise

real

Noise scale, normalized

noise

list of real

Noise signal

References:

1

Carandini M, Horton JC, Sincich LC (2007). Thalamic filtering of retinal spike trains by postsynaptic summation. Journal of Vision 7(14):20,1-11. DOI: https://doi.org/10.1167/7.14.20

2

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

Sends: SpikeEvent

Receives: SpikeEvent, DataLoggingRequest

FirstVersion: May 2012

Author: Thomas Heiberg, Birgit Kriener

class iaf_chxk_2008 : public Archiving_Node
#include <iaf_chxk_2008.h>

Name: iaf_chxk_2008 - Conductance based leaky integrate-and-fire neuron model used in Casti et al 2008.

Description:

iaf_chxk_2008 is an implementation of a spiking neuron using IAF dynamics with conductance-based synapses [1]. It is modeled after iaf_cond_alpha with the addition of after hyper-polarization current instead of a membrane potential reset. Incoming spike events induce a post-synaptic change of conductance modeled by an alpha function. The alpha function is normalized such that an event of weight 1.0 results in a peak current of 1 nS at \( t = tau_{syn} \).

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Leak reversal potential

C_m

pF

Capacity of the membrane

V_th

mV

Spike threshold

E_ex

mV

Excitatory reversal potential

E_in

mV

Inhibitory reversal potential

g_L

nS

Leak conductance

tau_ex

ms

Rise time of the excitatory synaptic alpha function

tau_in

ms

Rise time of the inhibitory synaptic alpha function

I_e

pA

Constant input current

tau_ahp

ms

Afterhyperpolarization (AHP) time constant

E_ahp

mV

AHP potential

g_ahp

nS

AHP conductance

ahp_bug

boolean

Defaults to false. If true, behaves like original model implementation

References:

1

Casti A, Hayot F, Xiao Y, Kaplan E (2008) A simple model of retina-LGN transmission. Journal of Computational Neuroscience 24:235-252. DOI: https://doi.org/10.1007/s10827-007-0053-7

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent

Author: Heiberg

SeeAlso: iaf_cond_alpha

class iaf_cond_alpha : public Archiving_Node
#include <iaf_cond_alpha.h>

Name: iaf_cond_alpha - Simple conductance based leaky integrate-and-fire neuron model.

Description:

iaf_cond_alpha is an implementation of a spiking neuron using IAF dynamics with conductance-based synapses. Incoming spike events induce a post-synaptic change of conductance modelled by an alpha function. The alpha function is normalised such that an event of weight 1.0 results in a peak current of 1 nS at \( t = tau_{syn} \).

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Leak reversal potential

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

E_ex

mV

Excitatory reversal potential

E_in

mV

Inhibitory reversal potential

g_L

nS

Leak conductance

tau_syn_ex

ms

Rise time of the excitatory synaptic alpha function

tau_syn_in

ms

Rise time of the inhibitory synaptic alpha function

I_e

pA

Constant input current

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Remarks:

References:

Note

Per 2009-04-17, this class has been revised to our newest insights into class design. Please use THIS CLASS as a reference when designing your own models with nonlinear dynamics. One weakness of this class is that it distinguishes between inputs to the two synapses by the sign of the synaptic weight. It would be better to use receptor_types, cf iaf_cond_alpha_mc.

1

Meffin H, Burkitt AN, Grayden DB (2004). An analytical model for the large, fluctuating synaptic conductance state typical of neocortical neurons in vivo. Journal of Computational Neuroscience, 16:159-175. DOI: https://doi.org/10.1023/B:JCNS.0000014108.03012.81

2

Bernander O, Douglas RJ, Martin KAC, Koch C (1991). Synaptic background activity influences spatiotemporal integration in single pyramidal cells. Proceedings of the National Academy of Science USA, 88(24):11569-11573. DOI: https://doi.org/10.1073/pnas.88.24.11569

3

Kuhn A, Rotter S (2004) Neuronal integration of synaptic input in the fluctuation- driven regime. Journal of Neuroscience, 24(10):2345-2356 DOI: https://doi.org/10.1523/JNEUROSCI.3349-03.2004

Author: Schrader, Plesser

SeeAlso: iaf_cond_exp, iaf_cond_alpha_mc

class iaf_cond_alpha_mc : public Archiving_Node
#include <iaf_cond_alpha_mc.h>

Name: iaf_cond_alpha_mc - PROTOTYPE Multi-compartment conductance-based leaky integrate-and-fire neuron model.

Description:

THIS MODEL IS A PROTOTYPE FOR ILLUSTRATION PURPOSES. IT IS NOT YET FULLY TESTED. USE AT YOUR OWN PERIL!

iaf_cond_alpha_mc is an implementation of a multi-compartment spiking neuron using IAF dynamics with conductance-based synapses. It serves mainly to illustrate the implementation of multicompartment models in NEST.

The model has three compartments: soma, proximal and distal dendrite, labeled as s, p, and d, respectively. Compartments are connected through passive conductances as follows

\[\begin{split} C_{m.s} d/dt V_{m.s} = \ldots - g_{sp} ( V_{m.s} - V_{m.p} ) \\ C_{m.p} d/dt V_{m.p} = \ldots - g_{sp} ( V_{m.p} - V_{m.s} ) - g_{pd} ( V_{m.p} - V_{m.d} ) \\ C_{m.d} d/dt V_{m.d} = \ldots \qquad - g_{pd} ( V_{m.d} - V_{m.p} ) \end{split}\]
A spike is fired when the somatic membrane potential exceeds threshold, \( V_{m.s} >= V_{th} \). After a spike, somatic membrane potential is clamped to a reset potential, \( V_{m.s} == V_{reset} \), for the refractory period. Dendritic membrane potentials are not manipulated after a spike.

There is one excitatory and one inhibitory conductance-based synapse onto each compartment, with alpha-function time course. The alpha function is normalised such that an event of weight 1.0 results in a peak current of 1 nS at t = tau_syn. Each compartment can also receive current input from a current generator, and an external (rheobase) current can be set for each compartment.

Synapses, including those for injection external currents, are addressed through the receptor types given in the receptor_types entry of the state dictionary. Note that in contrast to the single-compartment iaf_cond_alpha model, all synaptic weights must be positive numbers!

Parameters:

The following parameters can be set in the status dictionary. Parameters for each compartment are collected in a sub-dictionary; these sub-dictionaries are called “soma”, “proximal”, and “distal”, respectively. In the list below, these parameters are marked with an asterisk.

V_m*

mV

Membrane potential

E_L*

mV

Leak reversal potential

C_m*

pF

Capacity of the membrane

E_ex*

mV

Excitatory reversal potential

E_in*

mV

Inhibitory reversal potential

g_L*

nS

Leak conductance

tau_syn_ex*

ms

Rise time of the excitatory synaptic alpha function

tau_syn_in*

ms

Rise time of the inhibitory synaptic alpha function

I_e*

pA

Constant input current

g_sp

nS

Conductance connecting soma and proximal dendrite

g_pd

nS

Conductance connecting proximal and distal dendrite

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold in mV

V_reset

mV

Reset potential of the membrane

Example: See pynest/examples/mc_neuron.py.

Remarks:

This is a prototype for illustration which has undergone only limited testing. Details of the implementation and user-interface will likely change. USE AT YOUR OWN PERIL!

Sends: SpikeEvent

Note

All parameters that occur for both compartments and dendrite are stored as C arrays, with index 0 being soma.

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Meffin H, Burkitt AN, Grayden DB (2004). An analytical model for the large, fluctuating synaptic conductance state typical of neocortical neurons in vivo. Journal of Computational Neuroscience, 16:159-175. DOI: https://doi.org/10.1023/B:JCNS.0000014108.03012.81

2

Bernander O, Douglas RJ, Martin KAC, Koch C (1991). Synaptic background activity influences spatiotemporal integration in single pyramidal cells. Proceedings of the National Academy of Science USA, 88(24):11569-11573. DOI: https://doi.org/10.1073/pnas.88.24.11569

Author: Plesser

SeeAlso: iaf_cond_alpha

class iaf_cond_beta : public Archiving_Node
#include <iaf_cond_beta.h>

Name: iaf_cond_beta - Simple conductance based leaky integrate-and-fire neuron model.

Description:

iaf_cond_beta is an implementation of a spiking neuron using IAF dynamics with conductance-based synapses. Incoming spike events induce a post-synaptic change of conductance modelled by an beta function. The beta function is normalised such that an event of weight 1.0 results in a peak current of 1 nS at t = tau_rise_[ex|in].

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Leak reversal potential

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

E_ex

mV

Excitatory reversal potential

E_in

mV

Inhibitory reversal potential

g_L

nS

Leak conductance

tau_syn_ex

ms

Rise time of the excitatory synaptic alpha function

tau_decay_ex

ms

Rise time of the excitatory synaptic beta function

tau_syn_in

ms

Rise time of the inhibitory synaptic alpha function

tau_decay_in

ms

Rise time of the inhibitory synaptic beta function

I_e

pA

Constant input current

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Remarks:

References:

Note

Per 2009-04-17, this class has been revised to our newest insights into class design. Please use THIS CLASS as a reference when designing your own models with nonlinear dynamics. One weakness of this class is that it distinguishes between inputs to the two synapses by the sign of the synaptic weight. It would be better to use receptor_types, cf iaf_cond_alpha_mc.

1

Meffin H, Burkitt AN, Grayden DB (2004). An analytical model for the large, fluctuating synaptic conductance state typical of neocortical neurons in vivo. Journal of Computational Neuroscience, 16:159-175. DOI: https://doi.org/10.1023/B:JCNS.0000014108.03012.81

2

Bernander O, Douglas RJ, Martin KAC, Koch C (1991). Synaptic background activity influences spatiotemporal integration in single pyramidal cells. Proceedings of the National Academy of Science USA, 88(24):11569-11573. DOI: https://doi.org/10.1073/pnas.88.24.11569

3

Kuhn A, Rotter S (2004) Neuronal integration of synaptic input in the fluctuation- driven regime. Journal of Neuroscience, 24(10):2345-2356 DOI: https://doi.org/10.1523/JNEUROSCI.3349-03.2004

4

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

5

Roth A and van Rossum M (2010). Chapter 6: Modeling synapses. in De Schutter, Computational Modeling Methods for Neuroscientists, MIT Press.

Author: Daniel Naoumenko (modified iaf_cond_alpha by Schrader, Plesser)

SeeAlso: iaf_cond_exp, iaf_cond_alpha, iaf_cond_alpha_mc

class iaf_cond_exp : public Archiving_Node
#include <iaf_cond_exp.h>

Name: iaf_cond_exp - Simple conductance based leaky integrate-and-fire neuron model.

Description:

iaf_cond_exp is an implementation of a spiking neuron using IAF dynamics with conductance-based synapses. Incoming spike events induce a post-synaptic change of conductance modelled by an exponential function. The exponential function is normalised such that an event of weight 1.0 results in a peak conductance of 1 nS.

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Leak reversal potential

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

E_ex

mV

Excitatory reversal potential

E_in

mV

Inhibitory reversal potential

g_L

nS

Leak conductance

tau_syn_ex

ms

Rise time of the excitatory synaptic alpha function

tau_syn_in

ms

Rise time of the inhibitory synaptic alpha function

I_e

pA

Constant input current

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Meffin H, Burkitt AN, Grayden DB (2004). An analytical model for the large, fluctuating synaptic conductance state typical of neocortical neurons in vivo. Journal of Computational Neuroscience, 16:159-175. DOI: https://doi.org/10.1023/B:JCNS.0000014108.03012.81

Author: Sven Schrader

SeeAlso: iaf_psc_delta, iaf_psc_exp, iaf_cond_exp

class iaf_cond_exp_sfa_rr : public Archiving_Node
#include <iaf_cond_exp_sfa_rr.h>

Name: iaf_cond_exp_sfa_rr - Simple conductance based leaky integrate-and-fire neuron model.

Description:

iaf_cond_exp_sfa_rr is an iaf_cond_exp_sfa_rr i.e. an implementation of a spiking neuron using IAF dynamics with conductance-based synapses, with additional spike-frequency adaptation and relative refractory mechanisms as described in Dayan+Abbott, 2001, page 166.

As for the iaf_cond_exp_sfa_rr, Incoming spike events induce a post-synaptic change of conductance modelled by an exponential function. The exponential function is normalised such that an event of weight 1.0 results in a peak current of 1 nS.

Outgoing spike events induce a change of the adaptation and relative refractory conductances by q_sfa and q_rr, respectively. Otherwise these conductances decay exponentially with time constants tau_sfa and tau_rr, respectively.

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Leak reversal potential

C_m

pF

Capacity of the membrane

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

E_ex

mV

Excitatory reversal potential

E_in

mV

Inhibitory reversal potential

g_L

nS

Leak conductance

tau_syn_ex

ms

Rise time of the excitatory synaptic alpha function

tau_syn_in

ms

Rise time of the inhibitory synaptic alpha function

q_sfa

nS

Outgoing spike activated quantal spike-frequency adaptation conductance increase in nS

q_rr

nS

Outgoing spike activated quantal relative refractory conductance increase in nS

tau_sfa

ms

Time constant of spike-frequency adaptation in ms

tau_rr

ms

Time constant of the relative refractory mechanism in ms

E_sfa

mV

Spike-frequency adaptation conductance reversal potential in mV

E_rr

mV

Relative refractory mechanism conductance reversal potential in mV

I_e

pA

Constant input current

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

References:

1

Meffin H, Burkitt AN, Grayden DB (2004). An analytical model for the large, fluctuating synaptic conductance state typical of neocortical neurons in vivo. Journal of Computational Neuroscience, 16:159-175. DOI: https://doi.org/10.1023/B:JCNS.0000014108.03012.81

2

Dayan P, Abbott LF (2001). Theoretical neuroscience: Computational and mathematical modeling of neural systems. Cambridge, MA: MIT Press. https://pure.mpg.de/pubman/faces/ViewItemOverviewPage.jsp?itemId=

item_3006127

Author: Sven Schrader, Eilif Muller

SeeAlso: iaf_cond_exp_sfa_rr, aeif_cond_alpha, iaf_psc_delta, iaf_psc_exp, iaf_cond_alpha

class iaf_psc_alpha : public Archiving_Node
#include <iaf_psc_alpha.h>

Name: iaf_psc_alpha - Leaky integrate-and-fire neuron model.

Description:

iaf_psc_alpha is an implementation of a leaky integrate-and-fire model with alpha-function shaped synaptic currents. Thus, synaptic currents and the resulting post-synaptic potentials have a finite rise time.

The threshold crossing is followed by an absolute refractory period during which the membrane potential is clamped to the resting potential.

The linear subthresold dynamics is integrated by the Exact Integration scheme [][1]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [1]. A flow chart can be found in [2].

Critical tests for the formulation of the neuron model are the comparisons of simulation results for different computation step sizes. sli/testsuite/nest contains a number of such tests.

The iaf_psc_alpha is the standard model used to check the consistency of the nest simulation kernel because it is at the same time complex enough to exhibit non-trivial dynamics and simple enough compute relevant measures analytically.

Remarks:

The present implementation uses individual variables for the components of the state vector and the non-zero matrix elements of the propagator. Because the propagator is a lower triangular matrix no full matrix multiplication needs to be carried out and the computation can be done “in place” i.e. no temporary state vector object is required.

The template support of recent C++ compilers enables a more succinct formulation without loss of runtime performance already at minimal optimization levels. A future version of iaf_psc_alpha will probably address the problem of efficient usage of appropriate vector and matrix objects.

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Resting membrane potenial

C_m

pF

Capacity of the membrane

tau_m

ms

Membrane time constant

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

tau_syn_ex

ms

Rise time of the excitatory synaptic alpha function

tau_syn_in

ms

Rise time of the inhibitory synaptic alpha function

I_e

pA

Constant input current

V_min

mV

Absolute lower value for the membrane potenial

Remarks:

If tau_m is very close to tau_syn_ex or tau_syn_in, the model will numerically behave as if tau_m is equal to tau_syn_ex or tau_syn_in, respectively, to avoid numerical instabilities. For details, please see IAF_neurons_singularity.ipynb in the NEST source code (docs/model_details).

References:

1

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

2

Diesmann M, Gewaltig M-O, Rotter S, & Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI: https://doi.org/10.1016/S0925-2312(01)00409-X

3

Morrison A, Straube S, Plesser H E, Diesmann M (2006). Exact subthreshold integration with continuous spike times in discrete time neural network simulations. Neural Computation, in press DOI: https://doi.org/10.1162/neco.2007.19.1.47

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

FirstVersion: September 1999

Author: Diesmann, Gewaltig

SeeAlso: iaf_psc_delta, iaf_psc_exp, iaf_cond_exp

class iaf_psc_alpha_multisynapse : public Archiving_Node
#include <iaf_psc_alpha_multisynapse.h>

Name: iaf_psc_alpha_multisynapse - Leaky integrate-and-fire neuron model with multiple ports.

Description:

iaf_psc_alpha_multisynapse is a direct extension of iaf_psc_alpha. On the postsynapic side, there can be arbitrarily many synaptic time constants (iaf_psc_alpha has exactly two: tau_syn_ex and tau_syn_in).

This can be reached by specifying separate receptor ports, each for a different time constant. The port number has to match the respective “receptor_type” in the connectors.

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: Schrader, adapted from iaf_psc_alpha

SeeAlso: iaf_psc_alpha, iaf_psc_delta, iaf_psc_exp, iaf_cond_exp, iaf_psc_exp_multisynapse

class iaf_psc_delta : public Archiving_Node
#include <iaf_psc_delta.h>

Name: iaf_psc_delta - Leaky integrate-and-fire neuron model.

Description:

iaf_psc_delta is an implementation of a leaky integrate-and-fire model where the potential jumps on each spike arrival.

The threshold crossing is followed by an absolute refractory period during which the membrane potential is clamped to the resting potential.

Spikes arriving while the neuron is refractory, are discarded by default. If the property “refractory_input” is set to true, such spikes are added to the membrane potential at the end of the refractory period, dampened according to the interval between arrival and end of refractoriness.

The linear subthresold dynamics is integrated by the Exact Integration scheme [1]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [1]. A flow chart can be found in [2].

Critical tests for the formulation of the neuron model are the comparisons of simulation results for different computation step sizes. sli/testsuite/nest contains a number of such tests.

The iaf_psc_delta is the standard model used to check the consistency of the nest simulation kernel because it is at the same time complex enough to exhibit non-trivial dynamics and simple enough compute relevant measures analytically.

Remarks:

The present implementation uses individual variables for the components of the state vector and the non-zero matrix elements of the propagator. Because the propagator is a lower triangular matrix no full matrix multiplication needs to be carried out and the computation can be done “in place” i.e. no temporary state vector object is required.

The template support of recent C++ compilers enables a more succinct formulation without loss of runtime performance already at minimal optimization levels. A future version of iaf_psc_delta will probably address the problem of efficient usage of appropriate vector and matrix objects.

Parameters:

The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

E_L

mV

Resting membrane potential

C_m

pF

Capacity of the membrane

tau_m

ms

Membrane time constant

t_ref

ms

Duration of refractory period

V_th

mV

Spike threshold

V_reset

mV

Reset potential of the membrane

I_e

pA

Constant input current

V_min

mV

Absolute lower value for the membrane potenial

refractory_input

boolean

If true, do not discard input during refractory period. Default: false

References:

1

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

2

Diesmann M, Gewaltig M-O, Rotter S, & Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI: https://doi.org/10.1016/S0925-2312(01)00409-X

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: September 1999, Diesmann, Gewaltig

SeeAlso: iaf_psc_alpha, iaf_psc_exp, iaf_psc_delta_ps

class iaf_psc_exp : public Archiving_Node
#include <iaf_psc_exp.h>

Name: iaf_psc_exp - Leaky integrate-and-fire neuron model with exponential PSCs.

Description:

iaf_psc_exp is an implementation of a leaky integrate-and-fire model with exponential shaped postsynaptic currents (PSCs) according to [1]. Thus, postsynaptic currents have an infinitely short rise time.

The threshold crossing is followed by an absolute refractory period (t_ref) during which the membrane potential is clamped to the resting potential and spiking is prohibited.

The linear subthresold dynamics is integrated by the Exact Integration scheme [2]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [2]. A flow chart can be found in [3].

Spiking in this model can be either deterministic (delta=0) or stochastic (delta model with escape noise [4, 5].

Remarks:

The present implementation uses individual variables for the components of the state vector and the non-zero matrix elements of the propagator. Because the propagator is a lower triangular matrix no full matrix multiplication needs to be carried out and the computation can be done “in place” i.e. no temporary state vector object is required.

The template support of recent C++ compilers enables a more succinct formulation without loss of runtime performance already at minimal optimization levels. A future version of iaf_psc_exp will probably address the problem of efficient usage of appropriate vector and matrix objects.

Parameters:

The following parameters can be set in the status dictionary.

E_L

mV

Resting membrane potential

C_m

pF

Capacity of the membrane

tau_m

ms

Membrane time constant

tau_syn_ex

ms

Time constant of postsynaptic excitatory currents

tau_syn_in

ms

Time constant of postsynaptic inhibitory currents

t_ref

ms

Duration of refractory period (V_m = V_reset)

V_m

mV

Membrane potential in mV

V_th

mV

Spike threshold in mV

V_reset

mV

Reset membrane potential after a spike

I_e

pA

Constant input current

t_spike

ms

Point in time of last spike

Remarks:

If tau_m is very close to tau_syn_ex or tau_syn_in, the model will numerically behave as if tau_m is equal to tau_syn_ex or tau_syn_in, respectively, to avoid numerical instabilities. For details, please see IAF_neurons_singularity.ipynb in the NEST source code (docs/model_details).

iaf_psc_exp can handle current input in two ways: Current input through receptor_type 0 are handled as stepwise constant current input as in other iaf models, i.e., this current directly enters the membrane potential equation. Current input through receptor_type 1, in contrast, is filtered through an exponential kernel with the time constant of the excitatory synapse, tau_syn_ex. For an example application, see [6].

References:

1

Tsodyks M, Uziel A, Markram H (2000). Synchrony generation in recurrent networks with frequency-dependent synapses. The Journal of Neuroscience, 20,RC50:1-5. URL: https://infoscience.epfl.ch/record/183402

2

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

3

Diesmann M, Gewaltig M-O, Rotter S, & Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI: https://doi.org/10.1016/S0925-2312(01)00409-X

4

Schuecker J, Diesmann M, Helias M (2015). Modulated escape from a metastable state driven by colored noise. Physical Review E 92:052119 DOI: https://doi.org/10.1103/PhysRevE.92.052119

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

SeeAlso: iaf_psc_exp_ps

FirstVersion: March 2006

Author: Moritz Helias

class iaf_psc_exp_multisynapse : public Archiving_Node
#include <iaf_psc_exp_multisynapse.h>

psc

Name: iaf_psc_exp_multisynapse - Leaky integrate-and-fire neuron model with multiple ports.

Description:

iaf_psc_exp_multisynapse is a direct extension of iaf_psc_exp. On the postsynapic side, there can be arbitrarily many synaptic time constants (iaf_psc_exp has exactly two: tau_syn_ex and tau_syn_in).

This can be reached by specifying separate receptor ports, each for a different time constant. The port number has to match the respective “receptor_type” in the connectors.

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

Author: Plesser, adapted from iaf_psc_alpha_multisynapse

SeeAlso: iaf_psc_alpha, iaf_psc_delta, iaf_psc_exp, iaf_cond_exp, iaf_psc_alpha_multisynapse

class iaf_tum_2000 : public Archiving_Node
#include <iaf_tum_2000.h>

Name: iaf_tum_2000 - Leaky integrate-and-fire neuron model with exponential PSCs.

Description:

iaf_tum_2000 is an implementation of a leaky integrate-and-fire model with exponential shaped postsynaptic currents (PSCs) according to [1]. The postsynaptic currents have an infinitely short rise time. In particular, this model allows setting an absolute and relative refractory time separately, as required by [1].

The threshold crossing is followed by an absolute refractory period (t_ref_abs) during which the membrane potential is clamped to the resting potential. During the total refractory period (t_ref_tot), the membrane potential evolves, but the neuron will not emit a spike, even if the membrane potential reaches threshold. The total refractory time must be larger or equal to the absolute refractory time. If equal, the refractoriness of the model if equivalent to the other models of NEST.

The linear subthreshold dynamics is integrated by the Exact Integration scheme [2]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [2]. A flow chart can be found in [3].

Remarks:

The present implementation uses individual variables for the components of the state vector and the non-zero matrix elements of the propagator. Because the propagator is a lower triangular matrix no full matrix multiplication needs to be carried out and the computation can be done “in place” i.e. no temporary state vector object is required.

The template support of recent C++ compilers enables a more succinct formulation without loss of runtime performance already at minimal optimization levels. A future version of iaf_tum_2000 will probably address the problem of efficient usage of appropriate vector and matrix objects.

Parameters:

The following parameters can be set in the status dictionary.

E_L

mV

Resting membrane potenial

C_m

pF

Capacity of the membrane

tau_m

ms

Membrane time constant

tau_syn_ex

ms

Time constant of postsynaptic excitatory currents

tau_syn_in

ms

Time constant of postsynaptic inhibitory currents

t_ref_abs

ms

Duration of absolute refractory period (V_m = V_reset)

t_ref_tot

ms

Duration of total refractory period (no spiking)

V_m

mV

Membrane potential

V_th

mV

Spike threshold

V_reset

mV

Reset membrane potential after a spike

I_e

pA

Constant input current

t_spike

ms

Point in time of last spike

Remarks:

If tau_m is very close to tau_syn_ex or tau_syn_in, the model will numerically behave as if tau_m is equal to tau_syn_ex or tau_syn_in, respectively, to avoid numerical instabilities. For details, please see IAF_neurons_singularity.ipynb in the NEST source code (docs/model_details).

References:

1

Tsodyks M, Uziel A, Markram H (2000). Synchrony generation in recurrent networks with frequency-dependent synapses. The Journal of Neuroscience, 20,RC50:1-5. URL: https://infoscience.epfl.ch/record/183402

2

Rotter S, Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

3

Diesmann M, Gewaltig M-O, Rotter S, & Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI: https://doi.org/10.1016/S0925-2312(01)00409-X

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

FirstVersion: March 2006

Author: Moritz Helias

class izhikevich : public Archiving_Node
#include <izhikevich.h>

Name: izhikevich - Izhikevich neuron model

Description: Implementation of the simple spiking neuron model introduced by Izhikevich [1]. The dynamics are given by:

\[\begin{split} dv/dt = 0.04*v^2 + 5*v + 140 - u + I \\ du/dt = a*(b*v - u)] \end{split}\]

if \( v >= V_{th} \): v is set to c u is incremented by d

v jumps on each spike arrival by the weight of the spike.

As published in [1], the numerics differs from the standard forward Euler technique in two ways: 1) the new value of u is calculated based on the new value of v, rather than the previous value 2) the variable v is updated using a time step half the size of that used to update variable u.

This model offers both forms of integration, they can be selected using the boolean parameter consistent_integration. To reproduce some results published on the basis of this model, it is necessary to use the published form of the dynamics. In this case, consistent_integration must be set to false. For all other purposes, it is recommended to use the standard technique for forward Euler integration. In this case, consistent_integration must be set to true (default).

Parameters: The following parameters can be set in the status dictionary.

V_m

mV

Membrane potential

U_m

mV

Membrane potential recovery variable

V_th

mV

Spike threshold

I_e

pA

Constant input current (R=1)

V_min

mV

Absolute lower value for the membrane potential

a

real

Describes time scale of recovery variable

b

real

Sensitivity of recovery variable

c

mV

After-spike reset value of V_m

d

mV

After-spike reset value of U_m

consistent_integration

boolean

Use standard integration technique

References:

1

Izhikevich EM (2003). Simple model of spiking neurons. IEEE Transactions on Neural Networks, 14:1569-1572. DOI: https://doi.org/10.1109/TNN.2003.820440

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

FirstVersion: 2009

Author: Hanuschkin, Morrison, Kunkel

SeeAlso: iaf_psc_delta, mat2_psc_exp

class mat2_psc_exp : public Archiving_Node
#include <mat2_psc_exp.h>

Name: mat2_psc_exp - Non-resetting leaky integrate-and-fire neuron model with exponential PSCs and adaptive threshold.

Description:

mat2_psc_exp is an implementation of a leaky integrate-and-fire model with exponential shaped postsynaptic currents (PSCs). Thus, postsynaptic currents have an infinitely short rise time.

The threshold is lifted when the neuron is fired and then decreases in a fixed time scale toward a fixed level [3].

The threshold crossing is followed by a total refractory period during which the neuron is not allowed to fire, even if the membrane potential exceeds the threshold. The membrane potential is NOT reset, but continuously integrated.

The linear subthresold dynamics is integrated by the Exact Integration scheme [1]. The neuron dynamics is solved on the time grid given by the computation step size. Incoming as well as emitted spikes are forced to that grid.

An additional state variable and the corresponding differential equation represents a piecewise constant external current.

The general framework for the consistent formulation of systems with neuron like dynamics interacting by point events is described in [1]. A flow chart can be found in [2].

Remarks:

The present implementation uses individual variables for the components of the state vector and the non-zero matrix elements of the propagator. Because the propagator is a lower triangular matrix no full matrix multiplication needs to be carried out and the computation can be done “in place” i.e. no temporary state vector object is required.

Parameters:

The following parameters can be set in the status dictionary:

C_m

pF

Capacity of the membrane

E_L

mV

Resting potential

tau_m

ms

Membrane time constant

tau_syn_ex

ms

Time constant of postsynaptic excitatory currents

tau_syn_in

ms

Time constant of postsynaptic inhibitory currents

t_ref

ms

Duration of absolute refractory period (no spiking)

V_m

mV

Membrane potential

I_e

pA

Constant input current

t_spike

ms

Point in time of last spike

tau_1

ms

Short time constant of adaptive threshold

tau_2

ms

Long time constant of adaptive threshold

alpha_1

mV

Amplitude of short time threshold adaption [3]

alpha_2

mV

Amplitude of long time threshold adaption [3]

omega

mV

Resting spike threshold (absolute value, not relative to E_L as in [3])

The following state variables can be read out with the multimeter device:

V_m

mV

Non-resetting membrane potential

V_th

mV

Two-timescale adaptive threshold

Remarks:

tau_m != tau_syn_{ex,in} is required by the current implementation to avoid a degenerate case of the ODE describing the model [1]. For very similar values, numerics will be unstable.

References:

1

Rotter S and Diesmann M (1999). Exact simulation of time-invariant linear systems with applications to neuronal modeling. Biologial Cybernetics 81:381-402. DOI: https://doi.org/10.1007/s004220050570

2

Diesmann M, Gewaltig M-O, Rotter S, Aertsen A (2001). State space analysis of synchronous spiking in cortical neural networks. Neurocomputing 38-40:565-571. DOI:https://doi.org/10.1016/S0925-2312(01)00409-X

3

Kobayashi R, Tsubo Y and Shinomoto S (2009). Made-to-order spiking neuron model equipped with a multi-timescale adaptive threshold. Frontiers in Computuational Neuroscience 3:9. DOI: https://doi.org/10.3389/neuro.10.009.2009

Sends: SpikeEvent

Receives: SpikeEvent, CurrentEvent, DataLoggingRequest

FirstVersion: Mai 2009

Author: Thomas Pfeil (modified iaf_psc_exp model of Moritz Helias)