Skip to main content
Sensors (Basel, Switzerland) logoLink to Sensors (Basel, Switzerland)
. 2022 Nov 16;22(22):8845. doi: 10.3390/s22228845

Implementation of Kalman Filtering with Spiking Neural Networks

Alejandro Juárez-Lora 1,*,, Luis M García-Sebastián 1,, Victor H Ponce-Ponce 1, Elsa Rubio-Espino 1, Herón Molina-Lozano 1, Humberto Sossa 1
Editor: Miguel Ángel Conde1
PMCID: PMC9695172  PMID: 36433442

Abstract

A Kalman filter can be used to fill space–state reconstruction dynamics based on knowledge of a system and partial measurements. However, its performance relies on accurate modeling of the system dynamics and a proper characterization of the uncertainties, which can be hard to obtain in real-life scenarios. In this work, we explore how the values of a Kalman gain matrix can be estimated by using spiking neural networks through a combination of biologically plausible neuron models with spike-time-dependent plasticity learning algorithms. The performance of proposed neural architecture is verified with simulations of some representative nonlinear systems, which show promising results. This approach traces a path for its implementation in neuromorphic analog hardware that can learn and reconstruct partial and changing dynamics of a system without the massive power consumption that is typically needed in a Von Neumann-based computer architecture.

Keywords: Kalman filter, artificial intelligence, spiking neural networks, robotics, dynamics

1. Introduction

System dynamics can be represented as a set of differential equations in a space–state manner, and they are defined by using several techniques that explore the system’s energetic relationships, such as Newtonian, Lagrangian, or Hamiltonian mechanics. However, trying to describe some phenomena correctly without knowing the governing modeling equations or without a proper selection of the space–state variables results in inaccurate representations or a complex set of equations that could be represented in a more straightforward but unknown form [1]. Data-driven system modeling refers to a set of optimization techniques intended to obtain a system’s description based on data observations and measurements of the system’s evolution. For example, the sparse identification of nonlinear dynamics (SINDY) [2,3] creates a matrix filled with proposed functions and a coefficient matrix, which must be obtained by using well-documented optimization techniques, such as least-square optimization, to replicate the proportionated data as closely as possible.

Artificial neural networks (ANNs) have tackled this challenge on multiple frontiers. Physics-informed neural networks (PINNs) use prior knowledge of the laws of general physics as a regularization agent during their training process, thus limiting the space of admissible solutions [4]. For instance, a Kalman filter (KF) is a model-based technique that allows sensor fusion in order to construct a full space–state recovery based on preliminary knowledge of the system’s model and the nature of perturbation noise, which is useful for unknown perturbances or noisy sensor measurements [5,6]. In [7], the proposal of KalmanNet replaced parts of the equations of the extended Kalman filter (EKF) with an ANN with gated recurrent units (GRUs) to find the proper Kalman gain matrix that would allow a full state recovery.

For example, robotic systems exhibit changing dynamics during their lifespan due to the attrition of joints or their interactions within a changing environment. Therefore, compact and energy-efficient learning platforms are required for any autonomous robotic solution [8]. However, the Von Neumann computer architecture, which is present in all commercially available computing solutions, separates processing and storage into different functional units. Emulating an ANN, a computing strategy that inherently performs storage and processing as closely as possible creates a data bottleneck, as the interactions of neurons and synapses are represented in terms of massive matrix multiplication. The state-of-the-art research on ANNs is performed with sizable graphic processing units (GPUs) or multiple-core computing solutions, the power consumption of which is estimated to surpass humans’ current energy generation capacity if this rate continues [9].

It is necessary to rethink how to perform computing in a move away from the Turing machine, which requires many layers of abstraction, into parallel hardware with distributed memory [10]. Spiking neural networks (SNNs) are considered the third generation of ANNs. These models reflect complex biological and temporal dynamics in order to construct artificial software/hardware counterparts with the same behaviors as those of neurons and synapses [11]. Neuromorphic computing has emerged as a branch in computer science that aims to create computer architectures that resemble the brain’s energy efficiency, learning plasticity, and computing capacity [12]. This has become the inherited hardware platform for SNNs, which usually dictate the design of the building blocks for hardware solutions [13] that are usable for robotic platforms. For instance, in [14,15], an SNN learned the inverse kinematics (IKs) of a robotic arm manipulator, which are usually hard to obtain. While such networks can be used to reconstruct IK values, the extraction of the specific modeling functions from the network is still a research topic.

On this basis, the development of neuromorphic accelerators based on existing complementary metal-oxide semiconductor (CMOS) digital technology is enabling research in neuromorphic computing. such technologies usually include peripheral devices and software/hardware bridges with conventional computing architectures, thus enabling network analysis, performance measurement, and reconfiguration, such as in Intel’s Loihi 2 chip with 130 million silicon neurons and 256 million synapses [16], which is programmable with the Lava neuromorphic compiler, Truenorth from IBM with 1 million neurons and 256 synapses [17], or BrainChip’s Akida [18], which was built with TSCM’s 28 nm technology, among others. These have been used to obtain remarkable results in robotics [19], sensing, and classification tasks. However, as the construction of these accelerators relies on expensive proprietary CMOS chip technologies, they face the same scaling and energy consumption limits [20] as those of their Von Neumann counterparts.

From the perspective of analog electronics, a passive electric device called a memristor [21], which was theorized by Leon Chua, can be used for in-memory computing. It maintains its internal conductance state based on the current that has flowed through its terminals. These passive devices can be used in high-density crossbar arrays (CBAs), which can perform parallel vector–matrix multiplication with ultra-low energy consumption. Analog neurons and synapses have been assembled to compute values that rely on current summation rather than digital Boolean operations [20,22], resulting in some already-built analog neuromorphic architectures [23,24].

This article explores the concept of KalmanNet by entirely replacing its ANN architecture with a proposed SNN architecture to assemble biologically plausible neuron and synapse models. In addition, we propose a new differentiable function for modeling the encoding/decoding algorithms. The proposed architecture was tested in numerical simulations using two well-known nonlinear systems, which showed the feasibility of the solution. At the same time, its possible construction requirements were explored with the aim of its construction in neuromorphic hardware that would be capable of online learning in a space- and energy-efficient neuromorphic hardware solution.

This article is structured as follows: In Section 2 (Materials and Methods), neurons, synapses, and encoding/decoding models are described, and it is shown how these can be interconnected to create the proposed network solution. Section 3 (Results) shows numerical simulations with the nonlinear canonical Van der Pol and Lorenz systems used to test the capabilities of the architecture. Section 4 discusses the results, while Section 5 closes this work by showing our conclusions and proposing future research.

2. Materials and Methods

In this section, we start by reviewing how neurons, synapses, and learning rules are modeled. Then, we show encoding/decoding algorithms to determine the current input for the neurons in order to represent the signals used in our proposal. Next, the Kalman filter algorithm is illustrated. After the building blocks are introduced, our proposal is shown at the end of this section.

2.1. Neuron Modeling

Leaky Integrate and Fire (LIF) is one of the simplest models available for neuron modeling. It resembles the dynamics of a low-pass filter [25], as it considers a neuron as a switching resistance–capacitance circuit that is governed by:

τmdvm(t)dt=ELvm(t)+RmIsyn(t) (1)

In (1), vm(t) represents the membrane’s potential, EL is the membrane’s potential at rest, τm=RmCm stands for the membrane’s temporal charging constant, Rm is the membrane’s resistance, and Cm is the membrane’s capacitance. Isyn(t) acts as an excitatory input current for the neuron, which charges the membrane’s potential vm(t) until it passes a threshold voltage value vth, at which point a spike is emitted. The spike’s voltage, vs(t), is shaped as follows:

vs(t)=vspkδ(ttf) (2)

where tf is the last moment at which a spike was produced, whereas δ(·)[0,1] is the Dirac delta function that models the impulse’s decay alongside the synapses, which decay from a maximum value vspk at t=tf to zero at the following post-synaptic rate τpstc:

δ(x)=e(xτpstc)2 (3)

Once the spike is produced, vm(t) resets to EL. The neuron will not spike again during a refractory period τref, as it does not admit an excitatory input current. When Isyn(t)=0, vm(t)EL.

Given a connection between the j-th and k-th neuron by a synapse with a certain conductance value wjk (the modeling of which will be reviewed in Section 2.2), the input current for the postsynaptic neuron will be a function of each spike from the presynaptic neuron and its propagation through the corresponding synapse. For j presynaptic neurons, the current Isyn(t) for the k-th neuron is modeled by the following expression:

τsyndIsyndt=Isyn(t)+Csynwjk·vspk·δ(ttpref) (4)

where tpref is the firing time of each presynaptic neuron. Equations (1) and (4) make up the conductance-based LIF model [26], where τsyn is the injection current time decay and Csyn stands for the temporal injection current constant, which models the scale of the current injection of the presynaptic impulses. Figure 1 shows a step impulse of 1.5nA fed to a single neuron, which is modeled by Equation (1), showing its internal state vm(t) and the produced spike voltage vs(t). The parameters used for the neuron that is used are provided in Table 1.

Figure 1.

Figure 1

(a) Membrane voltage vm(t) and spike voltage vs(t) of an LIF neuron for an excitatory input current of Isyn=1.5001nA. (b) Tuning curve of the neuron, which shows the riobase value for the parameters given in Table 1.

Table 1.

Neuron, synapse, and encoding parameters.

LIF Model Parameter Value
Membrane charging constant τm=10 ms
Membrane resistance Rm=10 MΩ
Capacitance of the neuron Cm=1 nF
Threshold voltage of the neuron vth=55 mV
Resting potential of the neuron EL=70 mV
Reset potential of the neuron vreset=70 mV
Spike amplitude vspk= 20 mV
Postsynaptic current decay time τpstc=10 ms
Refractory Period τref=2 ms
Conductance-Based LIF
Time decay of the injection current τsyn=10 ms
Temporal injection current constant Csyn=1×105

Frequency Response of the Neuron

To compute how much current has to be fed into the neuron to obtain a given frequency response, first, we need to compute how much time it will take for the neuron to pass from a resting stage to a firing stage by analytically solving the differential Equation (1):

vm(t)=EL+RmIsyn+C1et/τm (5)

For t=0, we can rewrite C1=vm(0)ELRmIsyn(t). Setting the initial conditions to the values of vm(0)=EL, and vm(t)=vth in Equation (5), we can solve for t to obtain the expression of the membrane’s potential charging time tspk:

tspk=τmlnvthELRmIsyn(t)RmIsyn(t) (6)

As the firing frequency fspk=1/Tspk, where Tspk=τref+tspk, we have:

fspk(t)=1τrefτmlnvthELRmIsyn(t)RmIsyn(t) (7)

Equation (7) computes the frequency response of a neuron given a certain current. The inverse function computes the opposite—the amount of current needed for a given frequency:

Isyn(t)=vthELRm1eτref1fspk(t)τm (8)

Figure 1b shows the firing response of a neuron with respect to the firing frequency response for a given excitatory input current; this is called a tuning curve, and it was obtained using Equation (7) (analytical solution) and a numerical simulation of Equation (1), with a sweep from 0 A to 6 nA, using the neuron parameter values that appeared in Table 1. Setting f=1 Hz, we obtain Ir=1.5 nA. This is called the riobase current of the neuron.

2.2. Synapse Modeling

Spike-time-dependent plasticity (STDP) is a Hebbian learning algorithm that reflects how a synapse’s conductivity increases or decreases according to the neuron spiking activity [27]. Given the j-th layer of N presynaptic neurons and the k-th layer of M postsynaptic neurons, a matrix of W=[wjk]RN×M synapses will form between them, and its weight value will be modified by:

Δw(Δt)=A+eΔtτ+,Δt0AeΔtτ,Δt<0 (9)
wij=tpreftpostfΔw (10)

In Equation (9), Δt=tpostftpref is the difference between the firing times of the postsynaptic and presynaptic neurons. τ+,τ are the long-term potentiation (LTP) and long-term depreciation (LTD) constants, which map the decay effect of a spike in the modification of the weight. For each spike, the synaptic weight is then modified by a learning rate of A+,A. When A+=A and τ+=τ, the response is symmetrical, that is, the synapse modifies its value equally for presynaptic or postsynaptic spikes. STDP is included in the unsupervised learning paradigm [8], as there is no teaching signal involved, rather than the input and output signals to be processed.

2.3. Reward-Modulated STDP (RSTDP)

In order to introduce a teaching signal, some modifications to the STDP algorithm were described in [8] based on dopamine’s modulation of the learning ability in the synapses observed in biological systems. Starting from Equation (9), an eligibility trace E can be defined by taking into account only the last pre- and postsynaptic spike potentials at time t:

dEdt=E(t)τE+A+vspkδ(ttpre)+Avspkδ(ttpost) (11)

The eligibility trace is intended to model the tendency of the change in the synaptic weight value as a transient memory of all of the spiking activity, where τE depicts its decay time. The rate of change in the synaptic weights w is then obtained as follows:

dwdt=R(t)×E(t) (12)

where R(t)[1,1] is a reward signal, which is defined according to the network’s objectives. It is worth mentioning that when R=0, learning is deactivated, as no change in synapses is produced. When R=1, the weights are forced to converge in the opposite direction. Finally, when R=1, the eligibility trace remains unaltered.

Three presynaptic neurons and one postsynaptic neuron were arranged as shown in Figure 2a, and they produced different spiking activities (Figure 2b), showing how the output neuron’s membrane voltage accumulated with each arriving spike (Figure 2d). As each neuron spiked with a different frequency, the synaptic weight evolved into different values (Figure 2c).

Figure 2.

Figure 2

(a) An SNN with three LIF neurons in the input layer and one output layer. (b) Spiking activity of the first layer. (c) Evolution of the weight of the synapse. (d) Neural activity (input current, membrane voltage, and spike voltage) of the output neuron.

2.4. Encoding and Decoding in Spiking Neural Networks

Given an analog input signal that is intended to be processed by an SNN, a proper truly excitatory input current that represents every possible value from the input signal should be computed (encoding). Furthermore, the spiking activity of a neuron must be interpreted back from the spiking domain into the analog domain in order to interact with external systems (decoding).

Encoding Algorithm

There are several encoding and decoding algorithms that have been proposed in the literature. Some of them have the intention of reflecting biological plausibility, or easing the construction of neuromorphic devices. Rate-based encoding takes an input signal x(t)[xmin,xmax] and a minimum and maximum spiking frequency operation of the neuron F=[Fmin,Fmax], and it uses Equations (7) and (8) to encode/decode, respectively. Nonetheless, the encoding process can be performed as a function of the variability of the signal, which can be divided into phase encoding and time-to-first-spike encoding, among others [27,28]. Step-forward encoding, which was described in [29], is a temporal encoding algorithm that harnesses the low-pass filter dynamics of the LIF neuron in conjunction with a temporal encoding methodology. The input signal x(t) is compared with an initial baseline signal xb(t) and a sensibility encoding threshold value xth. If x(t)>xb+xth, a certain current Isyn+ is fed into an LIF neuron, which is denoted as N+. However, if x(t)<xbxth, a fixed current Isyn is then fed into another LIF neuron (denoted as N). Therefore, N+ will only spike for a growing signal, while N will spike for decreasing signals. In this work, the conditional part of this encoding algorithm is replaced with differentiable functions with the aim of easing future mathematical convergence analyses. Setting α=tanh(c·(x(t)xb(t)),

Isyn+(t)=Ir1+α (13)
Isyn=Ir1α (14)

where c is a slope modulation constant, which, for high values, approximates tanh(·) function as closely as the hardlim function. The baseline signal for the encoding is then updated by:

xb(t)=xb(t1)+αxth (15)

For decoding, the output signal x^(t) is computed with the following expression:

x^(t)=x^(t1)+xthδ(ttf+)xthδ(ttf) (16)

where tf+ stands for the spiking time of the N+ neuron and tf is the firing time of the N neuron. Figure 3a shows a simple configuration for reconstructing an input sine signal, which is shown in Figure 3b, by using the spiking activities of two neurons (Figure 3c) that are fed by an encoding block composed of Equations (13) and (14), which feed N+ and N with the current levels shown in Figure 3d.

Figure 3.

Figure 3

Signal reconstruction using neurons and encoding/decoding algorithms. (a) Assembly of the encoding/decoding, which alternate the input currents of two different neurons. (b) Comparison between the original signal x(t) and reconstructed signal x^(t). (c) Spiking activity response for each neuron. (d) Input currents Isyn+,Isyn for the neurons (Blue) versus the riobase (red dotted). (d) Output spikes for each neuron in the assembly.

2.5. Discrete Extended Kalman Filter

The discrete extended Kalman filter (EKF) allows full state estimation of system dynamics based on partial and/or noisy measurements. Given a system represented in a discrete space–state manner [5],

xk=f(xk1,uk)+wk (17)
yk=h(xk)+vk (18)

where xkRn is the state vector of the system, and f(·) is nonlinear and describes the evolution of the dynamics given the state value at the previous timestep xk1 and a control input ukRn. ykRm is the available output of the system, which is described by h(·). wN(0,Q) and vN(0,R) are additive white Gaussian noise (AWGN) with a covariance matrix QRn×n and RRm×m, respectively, representing the system uncertainties given by perturbations or noisy measurements. The EKF algorithm retrieves an estimation x^k|k that ideally tends to x^k|kxk. As f(·),h(·) are nonlinear, the EKF uses a linearized version of the system’s model by obtaining their respective Jacobians:

A=fx|x^k1|k1,uk (19)
C=hx|x^k|k1 (20)

where x^k1|k1 is the estimation of the EKF in the previous timestep. The discrete EKF is a two-step procedure involving a prediction and an update:

  • 1.
    Prediction: First, a preliminary estimation x^k|k1, y^k|k1 is computed by:
    x^k|k1=f(x^k1|k1,uk) (21)
    y^k|k1=h(x^k|k1) (22)
    Then, a covariance estimate Pk|k1,Sk|k1 is computed, and the noise covariance matrices Q,R and the estimate in the previous timestep Pk1|k1 are taken into account:
    Pk|k1=A·Pk1|k1·AT+Q (23)
    Sk|k1=C·Pk|k1·CT+R (24)
  • 2.
    Update: The second step consists of computing the Kalman gain matrix κRn×m with
    κ=Pk|k1·CT·Sk|k11 (25)
    in which the difference between the measurable output and estimated output of the prediction step is used:
    Δyk=yky^k|k1. (26)
    We can obtain a final estimation x^k|k that considers errors in measurement and noise statistics:
    x^k|k=x^k|k1+κ·Δyt (27)
    Finally, the moment of the prediction Pk|k, which will be used for the next timestep in prediction, is computed:
    Pk|k=Pk|k1κ·Sk|k1·κT (28)

In order to successfully reconstruct the full state, both the KF and EKF demand full knowledge of the system dynamics, as the correct characterization of perturbations and measurement noise can become cumbersome or unavailable in real scenarios.

2.6. Proposed Kalman-Filtering SNN Structure

An SNN structure of an EKF that replaces Equations (23), (24), and (28) is shown in Figure 4. First, the error between the current and prior estimations is defined for all of the space–state variables:

Δx^k|k=x^k|kx^k|k1 (29)

Figure 4.

Figure 4

Block diagram of the Kalman filter in which the typical Kalman gain-obtaining procedure is replaced by an SNN.

Then, Δx^ and Δyt are stacked into an input vector sin for the SNN as follows:

sin=[Δx^1,...,Δx^n,Δy1,...,Δym] (30)

This vector is encoded using Equation (13), which produces excitatory input current vectors for two ensembles of neurons inside the SNN, which are called Ens+ and Ens, and they spike for increasing and decreasing input signals, respectively. Both ensembles count with two densely connected LIF neuron layers—the j-th layer with n+m neurons, which is modeled by Equation (1), and the k-th layer with n×m LIF neurons, which is modeled by Equations (1) and (4). These are connected by RSTDP synapses, as depicted in Equations (11) and (12), with the reward signal set to R(t)=1. The spikes of the k-th layer from Ens+ and Ens are finally decoded with Equation (16) to obtain each value of the Kalman gain matrix in order to properly reconstruct the full state vector of the system. Figure 5 shows the described SNN structure.

Figure 5.

Figure 5

Proposed SNN network architecture for finding the values of the Kalman gain matrix.

3. Results

In order to show the performance of the proposal, two nonlinear systems were used. For each system, the nonlinear equations were simulated to create noiseless ground-truth data x(t). Then, the resulting vector was noised as described in (17) and (18) by setting wk,vk with the diagonal covariance matrices Q,R as follows:

Q=I·q2,R=I·r2,ν=q2r2 (31)

where ν=1 would imply that the state noise and the observation noise have the same variance, i.e., q2=r2. The resulting contaminated data then corresponded to a system with noisy measurements and unknown perturbations. The simulation was intended to compare the performance of a standard EKF against the SNN proposal under equal conditions; that is, only noisy measurements were provided. The SNN had to be able to recover this information, while for the EKF, Q,R were set as identity matrices, as these were supposed to be unknown.

To create the system’s synthetic data, as the used models were shaped with x˙=A(x,u)·x, the solution of the nonlinear system could be expressed as a Taylor series expansion with five terms, as in [7], assuming that for a small timestep Δt, f(x(t))f(x(t+Δt)). By doing this, we obtained a system that shaped as described in Equation (17).

For the SNN, the neuron parameters in Table 1 were used. The synapse, encoding/decoding, and simulation parameters are found in Table 2. The synapses were randomly initialized in the range of [wmin,wmax]. To display the neural activity, the observed spike frequency for each neuron fobs was computed as follows:

fobs=nT1Tobs (32)

where nobs counts how many spikes were produced inside a period of length Tobs=50 ms. The procedure was repeated for the whole simulation timeline of t=60 s, with simulation a timestep of Δt=1×104 s.

Table 2.

Encoding/decoding and RSTDP parameters in the simulation.

RSTDP Synapse Model
Long-term potentiation constant A+=1μS/mSeg
Long-term depreciation constant A=1μS/mSeg
Transient memory decay time τE=10 ms
Max. conductance Value wmax=1 ms
Min. conductance Value wmin=1μs
SF Encoding and Decoding
Encoding sensibility threshold value in a Van der Pol test xth=1×104
Encoding sensibility threshold value in a Lorenz test xth=1×105
Decoding sensibility threshold value in both tests xth=1×105
Slope modulation constant c=1
Noise Parameters
Measurement noise’s standard deviation r=0.1
System uncertainties’ standard deviation q=0.0316

The simulation scripts were coded from scratch using Python (v+3.8) [30] and the Numpy (v+1.20) and Sympy (v+1.8) [31] libraries. However, during our testing, the Lorenz system’s SNN network was also coded using the SNNtorch (v+0.5.3) library [32]. The resulting code is available in the Data Availability Statement section.

3.1. Van der Pol Simulation

Proposed by electrical engineer and physicist Balthasar Van der Pol, this nonlinear model is used to find oscillations on electric circuits using vacuum tubes, and it can be written in the x˙=Ax form as follows:

x˙1x˙2=μ113x12μ1μ0x1x2 (33)

where μ=3 refers to the damping strength of the oscillations. For this test, we set our output to y=[1,0]x, that is, only x1 was available for the measurement, while x2 was set to be recovered from the system.

Figure 6a shows a correct estimation of x2. This can also be seen in the difference xx^ shown in Figure 6b. The κR2×1 matrix values estimated by the SNN are displayed in Figure 6c; these were obtained by using the spikes of the output layer. The evolution of the synaptic weight is also shown for both ensembles (Ens+, Ens) in Figure 6d,e, respectively. While the SNN’s estimation became noisier as the time moved forward, it can be seen in Figure 6f that the EKF was not able to properly reconstruct the missing states at any point.

Figure 6.

Figure 6

Time evolution of the reconstruction of the Van der Pol oscillator using the proposed architecture in comparison with the ground truth. (a) Comparison of the ground truth x (blue) with the of the reconstruction x^ (orange) made using the proposed architecture. (b) Time error reconstruction xx^ of the two states of the system. (c) Time evolution of each value of the resulting Kalman gain matrix. (d,e) Weight value evolution over time of the 3×2 synapse set (multiple colors) for Ens+ and Ens, respectively. (f) Time error state estimation of the Van der Pol system using the standard discrete EKF algorithm without knowledge of the covariance matrices Q,R.

3.2. Lorenz System Simulation

A typical dynamic system for testing the obtention of unknown or partial dynamics is the Lorenz attractor, which is composed of the following nonlinear dynamics:

x˙=10100281x10x183x1x2x3 (34)

For this system, the EKF can be implemented by using five Taylor series approximation terms, as in [7]. In this test, we set the output to y=[1,0,0]x, which meant that only the x1 state was available for measurement. Therefore, x2,x3 should be recovered.

Figure 7a shows the estimation of x2,x3. The error xx^ is shown in Figure 7b for the three states. The κR3×1 matrix values estimated by the SNN are displayed in Figure 7c. The weight evolution is also shown for both ensembles (Ens+, Ens) in Figure 7d,e, respectively. In this test, while the error estimation converged to close to zero for the three states (Figure 7b), Figure 7f shows that the EKF quickly diverged to infinity at t=6.9 s due to the missing noise characterization of the system.

Figure 7.

Figure 7

Time evolution of the Lorenz system’s reconstruction when using the proposed architecture in comparison with the ground truth. (a) Comparison of the ground truth x (blue) with the reconstruction x^ (orange) made by using the proposed SNN architecture. (b) Time error reconstruction xx^ of the three states of the Lorenz system. (c) Evolution of each value of the Kalman gain matrix. (d,e) Weight value evolution over time of the 4×3 synapse set (multiple colors) for Ens+ and Ens, respectively. (f) Time estimation of the Lorenz system using the standard discrete EKF algorithm without knowledge of the covariance matrices Q,R.

4. Discussion

A proper full state reconstruction of the space state was achieved. However, some considerations should be addressed. On the one hand, in the KalmanNet structure, the intention being the usage of GRUs is to use them as storage for the internal ANN’s memory in order to jointly track the underlying second-order statistical moments required for implicitly computing the KG [7]. In our SNN proposal, the intention is to replace them with the eligibility traces defined by the RSTDP weight update mechanism (Equation (11)), as E collects the weight changes proposed by STDP; thus, they represent the potentiation/degradation tendency of the synaptic weight [8].

The energy consumption of an SNN relies on the spiking activity. Therefore, only the necessary spikes should be performed to represent our signals. Rate-based encoding mechanisms return a constant excitatory input current for a constant input signal (no matter its magnitude), resulting in spiking activity for non-changing signals. In temporal encoding schemes, such as the one used in this work, the neurons are only excited based on the rate of change in the input signal. The introduction of Equations (13) and (14) is intended to restrain the excitatory input current of the neurons to minimum and maximum values. In the range of tanh(·)[1,1], for high rates of change, the maximum input current is Isyn=2Ir; according to Equation (7) and the neuron parameters in Table 1, this would correspond to a spike frequency of f120 Hz for a maximum input current of Isyn=2(1.5nA)=3nA. This can be seen in the resulting spike frequency graphs for both the Van der Pol and Lorenz tests (see the Data Availability section).

However, while the neuron parameters were selected to resemble biological plausibility, proper selection of the encoding/decoding sensibility and the values of the learning rates is fundamental. xth should proportionate enough to Isyn to produce a suitable spiking activity, though selecting sufficiently high A+,A values should appropriately modify the synaptic weights with the supplied spikes. Low learning rates may require a higher spike frequency but a higher precision, leading to slow convergence. In contrast, high learning rate values require less spiking activity but lead to a lower precision, which may result in divergence. In addition, to translate this SNN structure into a hardware implementation, the min/max synaptic weight values might be restricted to the observed values in available memristive devices.

A mathematical convergence analysis would determine the boundary conditions for selecting proper parameters. However, the LIF reset condition makes this dynamic non-differentiable, which disables this analysis or the adaptation of back-propagation for SNNs. A way to deal with this is to move the analysis to the frequency domain by solving the LIF model and obtaining the tuning curve produced by Equation (7) and its corresponding graph (Figure 1b). It can be seen that the function only is differentiable in the range of [Ir,). In [15], the authors used a polynomial differentiable tuning curve (which can be obtained through least square regression) to avoid this restriction. In this work, the introduction of bounded and differentiable encoding/decoding functions and the usage of two (Ens+,Ens) neuron ensembles allowed the usage of this approximation to be avoided, as the dynamics of Ens+ are only affected by the growth of input signals, while for Ens, only the decay is processed, thus creating a switching dynamical system [33] that might allow us to propose a Lyapunov candidate function whose derivative is negatively defined.

5. Conclusions and Future Work

An SNN-embedded architecture inside the extended Kalman filter algorithm was used to perform the full state recovery of a nonlinear dynamic system based on partial knowledge while assuming unknown but bounded perturbations. Numerical simulations showed the feasibility of the system. While in other works, the encoding/decoding process was performed by using a function approximation relating the input current with the spike frequency, the proposed modifications allow this to be avoided by setting a switched current designation that lets each ensemble of neurons and their respective synapses evolve towards the growth/decay of the SNN input signals while bounding the excitatory input current, thus limiting the spike frequency.

In order to move towards a hardware construction, neuron design with a very large scale of integration (VLSI), the replacement of synapses with memristive devices, and a VLSI design of the encoding/decoding modules would define the building blocks for a system-on-a-chip proposal. However, moving to a hardware implementation in currently available technologies might lead to modifications, such as changes in the values of the memristive range or achievable spike frequencies. Therefore, a framework for mathematical convergence analysis should be defined to study the SNN’s performance with these new parameters. Nonetheless, it was shown that a few resources (in terms of the number of neurons, synapses, and energy consumption) were able to achieve proper performance by taking advantage of existing explainable PINN architectures.

Acknowledgments

The authors are thankful for the support provided by Instituto Politécnico Nacional, Secretaría de Investigación y Posgrado, Comisión de Operación y Fomento de Actividades Académicas, and CONACYT-México for the support to carry out this research.

Abbreviations

The following abbreviations are used in this manuscript:

ANN Artificial Neural Network
AWGN Additive White Gaussian Noise
CBA Crossbar Array
CMOS Complement Metal-Oxide Semiconductor
EKF Extended Kalman Filter
GPU Graphic Processing Unit
GRU Gated Recurrent Unit
IBM International Business Machines
IK Inverse Kinematics
KF Kalman Filter
LIF Leaky Integrate and Fire
LTD Long-Term Depreciation
LTP Long-Term Potentiation
PINN Physics-Informed Neural Networks
RSTDP Reward-Modulated STDP
SINDY Sparse Identification of Nonlinear Dynamics
SNN Spiking Neural Network
STDP Synaptic Time-Dependent Plasticity
TSMC Taiwan Semiconductor Manufacturing Company
VLSI Very Large Scale of Integration

Author Contributions

Conceptualization, A.J.-L., L.M.G.-S., V.H.P.-P., E.R.-E., H.M.-L. and H.S.; methodology, A.J.-L. and L.M.G.-S.; software, A.J.-L. and L.M.G.-S.; validation, A.J.-L., L.M.G.-S., V.H.P.-P. and H.S.; formal analysis, A.J.-L., L.M.G.-S. and E.R.-E.; investigation, A.J.-L. and H.M.-L.; resources, V.H.P.-P., E.R.-E., H.M.-L. and H.S.; data curation, A.J.-L.; writing—original draft preparation, A.J.-L.; writing—review and editing, A.J.-L., L.M.G.-S., V.H.P.-P. and H.S.; visualization, A.J.-L. and L.M.G.-S.; supervision, V.H.P.-P.; project administration, H.S.; funding acquisition, V.H.P.-P., E.R.-E., H.M.-L. and H.S. All authors have read and agreed to the published version of the manuscript.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

All of the scripts used in this article are available on the following Github page: https://github.com/LuisGarcia-S/SNN-Kalman-Filtering (accessed on 14 November 2022).

Conflicts of Interest

The authors declare no conflict of interest.

Funding Statement

The authors are thankful for the financial support of the projects to the Secretería de Investigación y Posgrado del Instituto Politécnico Nacional with grant numbers: 20221780, 20220268, 20221490, and 20220226, as well as the support from Comisión de Operación y Fomento de Actividades Académicas and Consejo Nacional de Ciencia y Tecnología (CONACYT).

Footnotes

Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

References

  • 1.Brunton S.L., Kutz J.N. Data-Driven Science and Engineering: Machine Learning, Dynamical Systems, and Control. 2nd ed. Cambridge University Press; Cambridge, UK: 2022. [DOI] [Google Scholar]
  • 2.Kaiser E., Kutz J.N., Brunton S.L. Sparse identification of nonlinear dynamics for model predictive control in the low-data limit. Proc. R. Soc. A Math. Phys. Eng. Sci. 2018;474:20180335. doi: 10.1098/rspa.2018.0335. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3.Kaheman K., Kutz J.N., Brunton S.L. SINDy-PI: A robust algorithm for parallel implicit sparse identification of nonlinear dynamics. Proc. R. Soc. A Math. Phys. Eng. Sci. 2020;476:20200279. doi: 10.1098/rspa.2020.0279. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4.Teng Q., Zhang L. Data driven nonlinear dynamical systems identification using multi-step CLDNN. AIP Adv. 2019;9:085311. doi: 10.1063/1.5100558. [DOI] [Google Scholar]
  • 5.Kálmán R.E., Bucy R.S. New Results in Linear Filtering and Prediction Theory. J. Basic Eng. 1961;83:95–108. doi: 10.1115/1.3658902. [DOI] [Google Scholar]
  • 6.Haykin S., editor. Kalman Filtering and Neural Networks. John Wiley & Sons, Inc.; New York, NY, USA: 2001. [Google Scholar]
  • 7.Revach G., Shlezinger N., Ni X., Escoriza A.L., van Sloun R.J.G., Eldar Y.C. KalmanNet: Neural Network Aided Kalman Filtering for Partially Known Dynamics. IEEE Trans. Signal Process. 2022;70:1532–1547. doi: 10.1109/TSP.2022.3158588. [DOI] [Google Scholar]
  • 8.Bing Z., Jiang Z., Cheng L., Cai C., Huang K., Knoll A. End to End Learning of a Multi-Layered Snn Based on R-Stdp for a Target Tracking Snake-Like Robot; Proceedings of the 2019 International Conference on Robotics and Automation (ICRA); Montreal, AB, Canada. 20–24 May 2019; pp. 9645–9651. [DOI] [Google Scholar]
  • 9.Thompson N.C., Greenewald K.H., Lee K., Manso G.F. The Computational Limits of Deep Learning. arXiv. 20202007.05558 [Google Scholar]
  • 10.Sandamirskaya Y. Rethinking computing hardware for robots. Sci. Robot. 2022;7:eabq3909. doi: 10.1126/scirobotics.abq3909. [DOI] [PubMed] [Google Scholar]
  • 11.Tavanaei A., Ghodrati M., Reza Kheradpisheh S., Masquelier T., Maida A. Deep learning in spiking neural networks. Neural Netw. 2019;111:47–63. doi: 10.1016/j.neunet.2018.12.002. [DOI] [PubMed] [Google Scholar]
  • 12.Schuman C.D., Kulkarni S.R., Parsa M., Mitchell J.P., Date P., Kay B. Opportunities for neuromorphic computing algorithms and applications. Nat. Comput. Sci. 2022;2:10–19. doi: 10.1038/s43588-021-00184-y. [DOI] [PubMed] [Google Scholar]
  • 13.Kendall J.D., Kumar S. The building blocks of a brain-inspired computer. Applied Physics Reviews. 2020;7:011305. doi: 10.1063/1.5129306. [DOI] [Google Scholar]
  • 14.Zaidel Y., Shalumov A., Volinski A., Supic L., Ezra Tsur E. Neuromorphic NEF-Based Inverse Kinematics and PID Control. Front. Neurorobotics. 2021;15:631159. doi: 10.3389/fnbot.2021.631159. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Volinski A., Zaidel Y., Shalumov A., DeWolf T., Supic L., Ezra-Tsur E. Data-driven artificial and spiking neural networks for inverse kinematics in neurorobotics. Patterns. 2022;3:100391. doi: 10.1016/j.patter.2021.100391. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Davies M., Wild A., Orchard G., Sandamirskaya Y., Guerra G.A.F., Joshi P., Plank P., Risbud S.R. Advancing Neuromorphic Computing With Loihi: A Survey of Results and Outlook. Proc. IEEE. 2021;109:911–934. doi: 10.1109/JPROC.2021.3067593. [DOI] [Google Scholar]
  • 17.Modha D.S. The Brain’s Architecture, Efficiency on a Chip. 2016. [(accessed on 12 October 2022)]. Available online: https://www.ibm.com/blogs/research/2016/12/the-brains-architecture-efficiency-on-a-chip/
  • 18.Modha D.S. Products–Akida Neural Processor SoC. 2022. [(accessed on 12 October 2022)]. Available online: https://brainchip.com/akida-neural-processor-soc/
  • 19.Sandamirskaya Y., Kaboli M., Conradt J., Celikel T. Neuromorphic computing hardware and neural architectures for robotics. Sci. Robot. 2022;7:eabl8419. doi: 10.1126/scirobotics.abl8419. [DOI] [PubMed] [Google Scholar]
  • 20.Li Y., Ang K.W. Hardware Implementation of Neuromorphic Computing Using Large-Scale Memristor Crossbar Arrays. Adv. Intell. Syst. 2021;3:2000137. doi: 10.1002/aisy.202000137. [DOI] [Google Scholar]
  • 21.Zhang X., Lu J., Wang Z., Wang R., Wei J., Shi T., Dou C., Wu Z., Zhu J., Shang D., et al. Hybrid memristor-CMOS neurons for in-situ learning in fully hardware memristive spiking neural networks. Sci. Bull. 2021;66:1624–1633. doi: 10.1016/j.scib.2021.04.014. [DOI] [PubMed] [Google Scholar]
  • 22.Payvand M., Moro F., Nomura K., Dalgaty T., Vianello E., Nishi Y., Indiveri G. Self-organization of an inhomogeneous memristive hardware for sequence learning. Nat. Commun. 2022;13:1–12. doi: 10.1038/s41467-022-33476-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Kimura M., Shibayama Y., Nakashima Y. Neuromorphic chip integrated with a large-scale integration circuit and amorphous-metal-oxide semiconductor thin-fil msynapse devices. Sci. Rep. 2022;12:5359. doi: 10.1038/s41598-022-09443-y. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Kim H., Mahmoodi M.R., Nili H., Strukov D.B. 4K-memristor analog-grade passive crossbar circuit. Nat. Commun. 2021;12 doi: 10.1038/s41467-021-25455-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Gerstner W., Kistler W.M., Naud R., Paninski L. Neuronal Dynamics. Cambridge University Press; Cambridge, UK: 2014. [DOI] [Google Scholar]
  • 26.Bing Z., Meschede C., Röhrbein F., Huang K., Knoll A.C. A Survey of Robotics Control Based on Learning-Inspired Spiking Neural Networks. Front. Neurorobotics. 2018;12:35. doi: 10.3389/fnbot.2018.00035. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Javanshir A., Nguyen T.T., Mahmud M.A.P., Kouzani A.Z. Advancements in Algorithms and Neuromorphic Hardware for Spiking Neural Networks. Neural Comput. 2022;34:1289–1328. doi: 10.1162/neco_a_01499. [DOI] [PubMed] [Google Scholar]
  • 28.Guo W., Fouda M.E., Eltawil A.M., Salama K.N. Neural Coding in Spiking Neural Networks: A Comparative Study for Robust Neuromorphic Systems. Front. Neurosci. 2021;15:638474. doi: 10.3389/fnins.2021.638474. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Juarez-Lora A., Ponce-Ponce V.H., Sossa H., Rubio-Espino E. R-STDP Spiking Neural Network Architecture for Motion Control on a Changing Friction Joint Robotic Arm. Front. Neurorobotics. 2022;16:904017. doi: 10.3389/fnbot.2022.904017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Harris C.R., Millman K.J., Van Der Walt S.J., Gommers R., Virtanen P., Cournapeau D., Wieser E., Taylor J., Berg S., Smith N.J., et al. Array programming with NumPy. Nature. 2020;585:357–362. doi: 10.1038/s41586-020-2649-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.Meurer A., Smith C.P., Paprocki M., Čertík O., Kirpichev S.B., Rocklin M., Kumar A., Ivanov S., Moore J.K., Singh S., et al. SymPy: Symbolic computing in Python. PeerJ Comput. Sci. 2017;3:e103. doi: 10.7717/peerj-cs.103. [DOI] [Google Scholar]
  • 32.Eshraghian J.K., Ward M., Neftci E., Wang X., Lenz G., Dwivedi G., Bennamoun M., Jeong D.S., Lu W.D. Training spiking neural networks using lessons from deep learning. arXiv. 20212109.12894 [Google Scholar]
  • 33.Saito T. Piecewise linear switched dynamical systems: A review. Nonlinear Theory Its Appl. IEICE. 2020;11:373–390. doi: 10.1587/nolta.11.373. [DOI] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Data Availability Statement

All of the scripts used in this article are available on the following Github page: https://github.com/LuisGarcia-S/SNN-Kalman-Filtering (accessed on 14 November 2022).


Articles from Sensors (Basel, Switzerland) are provided here courtesy of Multidisciplinary Digital Publishing Institute (MDPI)

RESOURCES