Next Article in Journal
Short-Term Fuzzy Load Forecasting Model Using Genetic–Fuzzy and Ant Colony–Fuzzy Knowledge Base Optimization
Previous Article in Journal
Artificial Neural Networks in Coordinated Control of Multiple Hovercrafts with Unmodeled Terms
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Orthogonal Simplex Chebyshev-Laguerre Cubature Kalman Filter Applied in Nonlinear Estimation Systems

Information and Navigation College, Air Force Engineering University, Xi’an 710077, China
*
Author to whom correspondence should be addressed.
Appl. Sci. 2018, 8(6), 863; https://doi.org/10.3390/app8060863
Submission received: 24 April 2018 / Revised: 16 May 2018 / Accepted: 17 May 2018 / Published: 24 May 2018

Abstract

:
To further improve the filtering accuracy in nonlinear estimation systems, a nonlinear filter, called the orthogonal simplex Chebyshev-Laguerre cubature Kalman filter (OSCL-CKF), is proposed. The filter is built within the cubature Kalman filter framework, which transforms the multidimensional, Gaussian weighted integral into a spherical-radial coordinate system. In the spherical integral, an orthogonal method is introduced to the third-degree spherical simplex rule, and then the nonlocal sampling effects can be reduced by tuning the high order interference terms. In the radial integral, the quadrature points and corresponding weights are determined according to the Chebyshev-Laguerre (CL) equation, which enables the nonlinear filter to improve the precision by the order of the CL polynomial. Numerical results show that the proposed filter outperforms the conventional algorithms.

Graphical Abstract

1. Introduction

Nonlinear estimation systems generally exist in civilian and military fields, such as target tracking systems, navigation systems, and communication systems. Nonlinear filtering algorithms have been widely used in these nonlinear estimation systems. For example, a multistatic radar based on nonlinear filter localizes a moving target within a small surveillance area [1]; a nonlinear-filter-based autonomous vehicle navigation system provides good positioning performance for vehicles [2]; the improved control systems based on nonlinear filter are adopted in wireless communication systems [3,4,5,6]. As the above examples show, nonlinear filtering algorithms play an important role in addressing nonlinear estimation problems.
In the Bayesian framework, the nonlinear filtering problem is essentially a computational problem of multidimensional integrals, which is typically intractable and hence the numerical approaches are considered [7]. In theory, the particle filter [8,9,10,11] based on the Monte-Carlo approximation for the multidimensional integrals can provide sufficient precision. However, the filter is usually impractical, owing to the enormous computational complexity from it suffers. The marginalized particle filters reduce the computational complexity to a certain degree, but it cannot deal with the problem whose process model and measurement model are both nonlinear. On the contrary, the filters under the Gaussian assumption of posterior probability density can be executed simply and quickly. The extended Kalman filter (EKF) [12,13], for instance, employs linearization via first-order Taylor series expansion, but it often results in unstable performance, and differentiability of the considered nonlinear functions is also required. In recent years, the deterministically sampled filters have drawn much attention, such as the central difference Kalman filter (CDKF) [14], the unscented Kalman filter (UKF) [15,16,17], and the cubature Kalman filter (CKF) [18]. Among these filters, the UKF uses a set of sigma-points and unscented transformation to capture posterior statistics of the state. The CKF performs with higher accuracy than the EKF and shows better numerical stability and lower computational demands than the UKF with a non-zero scaling parameter in high dimensions [18].
It should be noted that when the system model includes highly nonlinear functions, the unknown high order terms may drastically reduce the accuracy of the covariance estimate [19]. Additionally, the performance of the CKF may be unsatisfactory in high nonlinear conditions, and the way in which to make use of the measurements efficiently should also be taken into account. Jia [20] proposed the fifth and higher-degree CKF to further improve the accuracy, but the number of sample points increases rapidly with the increase of the algebraic degree or the state dimension. Compared with the high-degree CKF, the high-degree simplex cubature Kalman filter (SCKF) [21] uses fewer sample points and shows higher accuracy. Unfortunately, the number of sample points still increases quadratically with the increase of the state dimension.
The contribution of this paper is to derive a new class of nonlinear filter with arbitrary order of the Chebyshev-Laguerre (CL) polynomial. In order to regulate the effect of the high order terms, the stochastic orthogonal method [22] is introduced to the third-degree spherical simplex rule, which improves the accuracy of the CKF with only two more sample points. Moreover, the solution to the CL polynomial equation of arbitrary order is discussed [23]. The quadrature points and weights in the radial integral can be subsequently obtained according to the nature of the CL polynomial, and hence the accuracy can be controlled by the order of CL polynomial. The filter is called the orthogonal simplex Chebyshev-Laguerre cubature Kalman filter (OSCL-CKF). Compared with the standard CKF, the proposed filter is more flexible because the accuracy can be further improved with the increase of CL polynomial order. Also, computational cost increases linearly with CL polynomial order, which is superior to other high-degree versions of the CKF. The proposed filter can potentially be used in many applications such as air traffic control, remote sensing, ballistic missile guidance, and computer vision with good filtering accuracy.
The rest of this paper is organized as follows. Section 2 describes the system model and Bayesian nonlinear filter framework. The orthogonal simplex Chebyshev-Laguerre cubature rule is presented in Section 3. Section 4 yields the performance comparison of the proposed algorithm with the conventional algorithms. Conclusions are drawn in Section 5.

2. System Model and Bayesian Filter

2.1. System Model

The nonlinear discrete estimation system model can be expressed as follows:
{ x k = f ( x k 1 ) + v k 1 z k = h ( x k ) + e k ,
where x k n x is the state vector at time index k with n x dimensions, and z k n z is the measurement vector with nz dimensions. The values of n x and n z are dependent on specific applications. f ( ) and h ( ) are the nonlinear function, here k = 1 , 2 , . The process noise v k 1 and the measurement noise e k are generally assumed to be independent and identically distributed zero mean Gaussian noise with the covariance matrices Q k 1 and R k , respectively.

2.2. Bayesian Gaussian Recursive Filter

The Bayesian recursive solution to the problem above can be divided into a prediction step and a measurement update step. At the prediction step, the mean and associated covariance of the Gaussian predictive density can be obtained as follows:
x ^ k | k 1 = n x f ( x k 1 ) N ( x k 1 ; x ^ k 1 | k 1 , P k 1 | k 1 ) d x k 1 ,
P k | k 1 = n x f ( x k 1 ) f T ( x k 1 ) N ( x k 1 ; x ^ k 1 | k 1 , P k 1 | k 1 ) d x k 1 x ^ k | k 1 x ^ k | k 1 T + Q k 1 ,
At the measurement update step, D k 1 is denoted as the history of input measurement. Then, the predicted measurement density can be represented as follows:
p ( z k | D k 1 ) = N ( z k ; z ^ k | k 1 , P z z , k | k 1 ) ,
z ^ k | k 1 is the predicted measurement, which is predicted based on time index k − 1 and the measurement model. z ^ k | k 1 and its associated innovation covariance P z z , k | k 1 are given by the following:
z ^ k | k 1 = n x h ( x k ) N ( x k ; x ^ k | k 1 , P k | k 1 ) d x k ,
P z z , k | k 1 = n x h ( x k ) h T ( x k ) N ( x k ; x ^ k | k 1 , P k | k 1 ) d x k z ^ k | k 1 z ^ k | k 1 T + R k ,
and the cross-covariance is as follows:
P x z , k | k 1 = n x x k h T ( x k ) N ( x k ; x ^ k | k 1 , P k | k 1 ) d x k x ^ k | k 1 z ^ k | k 1 T .
Once the new measurement is received, the filter computes the posterior density, yielding the following:
p ( x k | D k ) = N ( x k ; x ^ k | k , P k | k ) ,
where
x ^ k | k = x ^ k | k 1 + K k ( z k z ^ k | k 1 ) ,
P k | k = P k | k 1 K k P z z , k | k 1 K k T ,
K k = P x z , k | k 1 P z z , k | k 1 1

3. Orthogonal Simplex Chebyshev-Laguerre Cubature Kalman Filter

The key of the Bayesian filter is how to compute Gaussian weighted integrals whose integrands are a product of a nonlinear function and a Gaussian density function that are present in (5)–(7). Considering the standard Gaussian distribution N ( x ; 0 , I ) , the integral can be expressed as follows:
I ( f ) = n x f ( x ) N ( x ; 0 , I ) d x = ( 2 π ) n x 2 n x f ( x ) e 1 2 x T x d x ,
where f ( x ) is an arbitrary nonlinear function.
Now, we transform the integral from the Cartesian coordinate to the spherical-radial coordinate. Assuming that x = r y with y T y = 1 and r = x T x , Equation (12) can be rewritten in the spherical-radial coordinate system as follows [18]:
I ( f ) = ( 2 π ) n x 2 0 U n x f ( r y ) r n x 1 e r 2 2 d σ ( y ) d r ,
where direction vector y and radius r are the corresponding parameters in the spherical-radial coordinate [18]. U n x = { y n x | y T y = 1 } is the spherical surface and d σ ( ) is the spherical surface measure. As a consequence, two kinds of integrals are given by the following:
S ( r ) = U n x f ( r y ) d σ ( y ) ,
G s = ( 2 π ) n x 2 0 S ( r ) r n x 1 e r 2 2 d r ,

3.1. Orthogonal Spherical Simplex Rule

According to Mysovskikh and Lu [24,25], the cubature rule for Equation (14) can be obtained from the transformation group of the regular simplex with vertices, that is:
α j = [ α j , 1 , α j , 2 , , α j , n x ] T ,
where j = 1 , 2 , , n x + 1 , and
α j , m = { n x + 1 n x ( n x m + 2 ) ( n x m + 1 ) m < j ( n x + 1 ) ( n x j + 1 ) n x ( n x j + 2 ) m = j 0 m > j ,
Accordingly, the third-degree spherical simplex rule is constructed as follows:
S 3 ( r ) = j = 1 n s w j s f ( ) = A n x 2 ( n x + 1 ) j = 1 n x + 1 ( f ( r α j ) + f ( r α j ) ) ,
where n s = 2 ( n x + 1 ) , A n x = 2 π n x / Γ ( n x / 2 ) , and Γ ( n x ) = 0 x n x 1 e x d x .
Compared with the cubature rule based on Arasaratnam et al. [18], two more sample points are needed in the spherical simplex rule, but it has been proven that the spherical simplex rule is more accurate [21]. According to Equation (1), the highly nonlinear nature of the nonlinear system model may lead to the nonlocal sampling effects, with the covariance being easily affected by unknown high order behavior (especially when n x > 3 ). Thus, we introduce the orthogonal method to tune the high order information of the spherical simplex transformation. In other words, Equation (18) can be updated as follows:
S 3 ( r ) = A n x 2 ( n x + 1 ) j = 1 n s f ( r γ j ) ,
where γ = [ γ 1 , γ 2 , , γ 2 n x + 2 ] = B × [ α   α ] and B = [ B 1 , B 2 , , B n x ] is an n x × n x orthogonal matrix, where B i = [ β i , 1 , β i , 2 , , β i , n x ] T . Therefore, γ is a n x × ( 2 n x + 2 ) matrix.
The method to select an orthogonal matrix can be seen in the works of [26,27]. In this paper, we construct B according to Xiu [28]:
β i , 2 p 1 = 2 n x cos ( 2 p 1 ) i π n x ,
β i , 2 p = 2 n x sin ( 2 p 1 ) i π n x ,
where p = 1 , 2 , ,   max { p Z | p n x / 2 } . If n x is odd, β i , n x = ( 1 ) i / n x .
From Equations (18)–(21), it can be seen that the orthogonal method does not introduce additional computational costs to the spherical simplex rule, because the new orthogonal sample points can be computed offline in advance.

3.2. High Order Chebyshev-Laguerre Quadrature Rule

Due to the quadratic term r 2 / 2 in the exponential function, it is difficult to deal with the radial integral (15) directly. Hence, we make an equivalent transformation that t = r 2 / 2 , and then Equation (15) can be rewritten as follows:
G s = 1 2 π n x 2 0 S ( 2 t ) t n x 2 1 e t d t v ,
The integral on the right-hand side is in the form of the generalized Gauss-Laguerre integral. Numerical integration is generally utilized because seeking an optimal or analytical solution to Equation (22) is typically intractable. Here, we evaluate it using quadrature points t k and associated weights w i c :
G s = k = 1 n c w i c S ( 2 t ) ,
which are determined by the Chebyshev-Laguerre polynomials [29]:
L n c ( a ) ( t ) = ( 1 ) n c t a e t d n c d t n c ( t a + n c e t ) ,
where a = n x / 2 1 and n c is the order of the Chebyshev-Laguerre polynomials.
The quadrature points t k are the roots of the Chebyshev-Laguerre polynomials, and associated weights can be obtained as follows [30]:
w k c = π n x 2 n c ! Γ ( a + n c + 1 ) 2 L ˙ n c ( a ) ( t k ) L n c + 1 ( a ) ( t k ) ,
where k = 1 , , n c . From the theory of Laguerre polynomials, the relation between L n c ( a ) ( t k ) and L n c + 1 ( a ) ( t k ) is described as follows:
L n c + 1 ( a ) ( t k ) = t k L ˙ n c ( a ) ( t k ) ,
and then we obtain the following:
w k c = π n x 2 n c ! Γ ( a + n c + 1 ) 2 t k [ L ˙ n c ( a ) ( t k ) ] 2 .
Obviously, the precision of the quadrature formula can be readily improved with the increase of the polynomials’ order, which is linear to the number of quadrature points.

3.3. Orthogonal Spherical Simplex Chebyshev-Laguerre Quadrature Rule

In Section 3.1, integral (13) is transformed into two kinds of integrals, which are dealt with in Section 3.1 and Section 3.2, respectively. Substituting Equations (18) and (23) into Equation (13), the orthogonal spherical simplex Chebyshev-Laguerre rule for N ( x ; 0 , I ) is as follows:
n x f ( x ) N ( x ; 0 , I ) d x i = 1 n s j = 1 n c w i s w j c f ( ) ,
That is,
I ( f ) i = 1 n s j = 1 n c w i s w j c f ( ) = i = 1 n s j = 1 n c A n x n s n c ! Γ ( a + n c + 1 ) π n x 2 t j [ L ˙ n c ( a ) ( t j ) ] 2 f ( 2 t j B × [ α   α ] i ) = i = 1 n s j = 1 n c 2 π n x / Γ ( n x / 2 ) 2 ( n x + 1 ) n c ! Γ ( a + n c + 1 ) π n x 2 t j [ L ˙ n c ( a ) ( t j ) ] 2 f ( 2 t j γ i )
Therefore,
I ( f ) = i = 1 2 ( n x + 1 ) j = 1 n c n c ! Γ ( n x / 2 + n c ) 2 t j ( n x + 1 ) Γ ( n x / 2 ) [ L ˙ n c ( n x / 2 1 ) ( t j ) ] 2 f ( 2 t j γ i )
The cubature formula is easy to extend to an arbitrary Gaussian distribution N ( x ; x ^ , P x ) . Computing Equations (5)–(7) using the formula, the new nonlinear filter, called the orthogonal simplex Chebyshev-Laguerre cubature Kalman filter, can be obtained.
The new filter uses 2 ( n x + 1 ) n c sample points to approximate the Gaussian-weighted integral. The number of sample points is linear to that of the state dimension n x and the polynomials’ order n c , respectively. It is more efficient than high-degree CKF and high-degree SCKF from the computational point of view. The accuracy of the filter depends on the order of the Chebyshev-Laguerre polynomials. In theory, the higher the order is, the more accurate the filter would be. Moreover, the high order moments of the OSCL transformation are tuned according to the designed orthogonal matrix, which can alleviate the nonlocal sampling effects efficiently.
When n c = 1 and γ = [ α   α ] , Equation (30) can be rewritten as follows:
I ( f ) = i = 1 2 ( n x + 1 ) 1 ! Γ ( n x / 2 + 1 ) 2 t 1 ( n x + 1 ) Γ ( n x / 2 ) [ L ˙ 1 ( n x / 2 1 ) ( t 1 ) ] 2 f ( 2 t 1 [ α   α ] i ) = i = 1 2 ( n x + 1 ) Γ ( 3 ) 4 ( n x + 1 ) Γ ( 2 ) [ L ˙ 1 ( 1 ) ( 2 ) ] 2 f ( 2 [ α   α ] i ) = 1 2 ( n x + 1 ) i = 1 2 ( n x + 1 ) f ( 2 [ α α ] i ) ,
which means that the third-degree SCKF is a specific form of the proposed filter, where the orthogonal matrix is an identity matrix and the order of the Chebyshev-Laguerre polynomials is nc = 1. The accuracy can be further improved by increasing nc. On the other hand, the advantages of the SCKF are also retained in the proposed filter, such as derivative-free and better numerical stability compared with the UKF.

4. Simulations

To describe the performance of the proposed algorithm, two nonlinear estimation examples as the nonlinear estimation problem and the bearings-only tracking problem, are considered.

4.1. The Highly Dimensional Nonlinear Estimation Problem

The system model of nonlinear estimation is defined as:
x k = x k 1 2 cos ( x k 1 ) + v k 1 ,
z k = 1 + x k T x n x + e k ,
where cos ( x k 1 ) = [ cos ( x 1 , k 1 ) , cos ( x 2 , k 1 ) , , cos ( x n x , k 1 ) ] T . Here we set the dimensions n x = 20 . v k 1 and ek are the independent Gaussian noise with zero means and covariance I n x and 1, respectively.
The true initial value is x 0 = 0.1 × 1 n x × 1 , and the initial estimate x ^ 0 used in the filters is generated randomly from N ( x ^ 0 ; x 0 , P 0 ) , where the initial covariance is P 0 = I n x . The mean squared error (MSE) for each Monte-Carlo run is defined as follows:
MSE i = 1 n k = 1 n [ 1 n x ( x k x^ k , i ) T ( x k x^ k , i ) ] ,
Accordingly, the average MSE can be written as follows:
MSE = 1 L i = 1 L MSE i ,
where the Monte-Carlo runs L = 100. The MSEs of the algorithms are shown in Figure 1.
As is shown in Figure 1, the MSEs of the OSCL-CKFs are smaller than those of the CKF and the SCKF, which means that OSCL points can provide more accurate performance in this highly dimensional problem. It can be also seen that the MSEs of the OSCL-CKF4 and OSCL-CKF3 are almost the same, which illustrates that the accuracy of the filter will hardly be improved if the order further increases.

4.2. Bearings-Only Tracking Problem

Bearings-only tracking is a typical nonlinear problem which estimates the position and the velocity of a target from noisy bearing measurements.
As is shown in Figure 2, we assume that the target is in uniform linear motion with acceleration disturbance. The state vector at time index k can be expressed by x k t = [ x k t , y k t , x ˙ k t , y ˙ k t ] T , where x k p = [ x k t , y k t ] T is the position and x ˙ k v = [ x ˙ k t , y ˙ k t ] T is the velocity vector. The true state of the observation platform is x k o = [ x k o , y k o , x ˙ k o , y ˙ k o ] T , and the state vector in the relative own-ship reference at time index k can be defined as follows:
x k x k t x k o = [ x k , y k , x ˙ k , y ˙ k ] T
The system model is written as follows:
{ x k = F x k 1 + v k u k 1 , k z k = h ( x k ) = arctan y k x k + e k ,
where u k 1 , k is the deterministic input and F is the state transition matrix, which can be given by:
u k 1 , k = [ x k o x k 1 o Δ x ˙ k 1 o y k o y k 1 o Δ y ˙ k 1 o x ˙ k o x ˙ k 1 o y ˙ k o y ˙ k 1 o ] ,   F = 1 0 Δ 0 0 1 0 Δ 0 0 1 0 0 0 0 1
where Δ = 1 min is the measurement interval. The standard deviation of measurement noise e k is σ e , and v k is the process noise vector with a covariance matrix of:
Q = Γ T Γ q
where q = 10 10 km2/s3 represents the intensity of the process noise, and Γ is the noise drive matrix:
Γ = [ Δ 2 / 2 0 0 Δ 2 / 2 Δ 0 0 Δ ]
A single observer is assumed to be maneuvering, where the start coordinate is (0,0). From 0 min to 12 min, the observer is in uniform linear motion, where the speed is 3 knots and the course is 2.44 rad (“rad”denotes radian). From 13 min to 17 min, the observer is in uniform turning motion, where the speed is 3 knots and the turn rate is 0.52 rad. From 18 min to 30 min, the observer is in uniform linear motion, where the speed is 3 knots and the course is 5.06 rad.
The root mean square error in position (RMSEpos) at time index k is defined as follows:
RMSE p o s , k = 1 L j = 1 L [ ( x^ k , j t x k , j t ) 2 + ( y^ k , j t y k , j t ) 2 ] ,
where L = 100. Similarly, the RMSE in velocity (RMSEvel) can be easily written according to the RMSEpos. The mean squared error in position (MSEpos) for each Monte-Carlo run is defined as follows:
MSE pos , i = 1 n k = 1 n [ ( x k t x ^ k | k , i t ) 2 + ( y k t y^ k | k , i t ) 2 ] .
In the Monte-Carlo test, the target begins at the same state every time for a fair comparison. The scale parameter κ of the UKF is set as 3 − nx, and all the algorithms are set at the same initial conditions. The initial range estimate follows r ¯ ~ N ( r , σ r 2 ) , where r is the true range. The initial bearing follows z 0 ¯ ~ N ( z 0 , σ e 2 ) , where z0 is the true bearing. Similarly, the initial velocity estimate s ¯ ~ N ( s , σ s 2 ) , where s is the true initial target velocity. The target course estimate follows c ¯ ~ N ( c , σ c 2 ) , where c is the true target course. The parameters in the simulation scenario are shown in Table 1. (“mrad” denotes milliradian in Table 1).
The initial estimate state and initial estimate covariance can be obtained according to Wu et al. [31]. Hence, the RMSEpos and RMSEvel are shown in Figure 3 and Figure 4, respectively.
The MSEpos for different noise intensities are shown in Figure 5.
As is shown in Figure 3, all algorithms tend to be convergent, with the measurement times increasing. During the Monte-Carlo test, the performance of CKF is better than that of UKF. One explanation is that the negative κ may lead to non-positive definiteness of the covariance matrices when nx > 3. Moreover, the OSCL-CKF-based algorithms perform better than the other algorithms. As the first order OSCL-CKF (OSCL-CKF1) provides better performance over the SCKF, it is proven that the orthogonal transformation can efficiently modify the uncertain higher order terms and relieve the nonlocal sampling effects. On the other hand, the high order OSCL-CKFs generally outperform the low order OSCL-CKF. At the end of the Monte-Carlo test, the RMSEpos of the OSCL-CKF4 is 3.2% better than that of the OSCL-CKF1, and 5.2% better than that of the SCKF. As is shown in Figure 4, the differences in the velocity estimate accuracy among these algorithms are not as obvious as in the position estimate. This is mainly due to the uniform linear motion of the target.
As is shown in Figure 5, the MSEspos of the filters become larger with the increasing of the noise intensity. In Case 1, the OSCL-CKF4 improves the CKF by 9.7%, and in Case 3, the OSCL-CKF4 improves the CKF by 13.3%, which means that the OSCL-CKFs show better performance to reduce the influence of the noise.

5. Conclusions

In order to improve the filtering accuracy of cubature Kalman filters in nonlinear estimation systems, this paper utilizes the orthogonal simplex Chebyshev-Laguerre polynomial to calculate the numerical integration of the cubature Kalman filter. The performance of the nonlinear filtering problem can be improved based on the orthogonal method, which is introduced to the spherical simplex rule without computational burden. Furthermore, unlike some high-degree sample points-based filtering algorithms, the filter improves the accuracy according to the order of the Chebyshev-Laguerre polynomials. This is an important observation because the computational cost increases linearly with the increase of state dimensions nx, which is more practical. In our simulation, the accuracy is improved slowly when the order exceeds 4. The choice of the order also depends on the accuracy request and the specific application. Furthermore, the OSCL-CKF has potential applications in other nonlinear systems of different fields. In future work, how to design orthogonal matrix suitably and how to choose the order of the CL polynomials in different application should be further studied.

Author Contributions

Z.L. and H.W. developed the algorithm and performed the experiments. Z.L., S.C., and H.W. analyzed the experimental results and wrote this paper. F.L. supervised the study and reviewed this paper.

Acknowledgments

This study was supported by the National Natural Science Foundation of China (Grants No. 61703420 and Grants No. 61673392).

Conflicts of Interest

The authors declare no conflict of interest.

Abbreviations

xvector of the state
xk|k−1x of the prediction
xk|kx of the update at time index k
zvector of the measurement
zk|k−1z of the prediction
zkthe measurement at time index k
vk−1vector of the process noise
ekvector of the measurement noise
Qk−1covariance of the process noise
Rkcovariance of the measurement noise
Pcovariance of the state
Pk|k−1P of the prediction
xkP of the update at time index k
Pzz,k|k−1innovation covariance
xxz,k|k−1cross-covariance
Dk−1history of input-measurement pairs up to k − 1
KkKalman gain
ydirection vector
rradius
αjj-th sample point of the regular simplex
γa set of the orthogonal transformation points
γii-th orthogonal transformation point
Borthogonal matrix
Biorthogonal sample point
w k c weight associated with k-th quadrature point
w j s weight associated with αj
nxdimension of state space
nzdimension of measurement space
ncorder of the Chebyshev-Laguerre polynomials

References

  1. Sobhani, B.; Paolini, E.; Giorgetti, A.; Mazzotti, M.; Chiani, M. Target tracking for uwb multistatic radar sensor networks. IEEE J. Sel. Top. Signal Process. 2017, 8, 125–136. [Google Scholar] [CrossRef]
  2. Toledo-Moreo, R.; Colodro-Conde, C.; Toledo-Moreo, J. A multiple-model particle filter fusion algorithm for GNSS/DR slide error detection and compensation. Appl. Sci. 2018, 8, 445. [Google Scholar] [CrossRef]
  3. Buzzi, S.; Poor, H.V. A multipass approach to joint data and channel estimation in long-code cdma systems. IEEE Trans. Wirel. Commun. 2004, 3, 612–626. [Google Scholar] [CrossRef]
  4. Meshkati, F.; Guo, D.; Poor, H.V.; Schwartz, S.C. A unified approach to power control in large energy-constrained cdms systems. IEEE Trans. Wirel. Commun. 2008, 7, 1208–1216. [Google Scholar] [CrossRef]
  5. Tsiropoulou, E.E.; Katsinis, G.K.; Papavassiliou, S. Utility-based power control via convex pricing for the uplink in CDMA wireless networks. In Proceedings of the 2010 European Wireless Conference, Lucca, Italy, 12–15 April 2010; pp. 200–206. [Google Scholar]
  6. Tsiropoulou, E.E.; Kapoukakis, A.; Papavassiliou, S. Energy-efficient subcarrier allocation in SC-FDMA wireless networks based on multilateral model of bargaining. In Proceedings of the IFIP Networking Conference, Brooklyn, NY, USA, 22–24 May 2013; pp. 1–9. [Google Scholar]
  7. Ito, K.; Xiong, K. Gaussian filters for nonlinear filtering problems. IEEE Trans. Autom. Control 2000, 45, 910–927. [Google Scholar] [CrossRef]
  8. Havangi, R. Robust evolutionary particle filter. ISA Trans. 2015, 57, 179–188. [Google Scholar] [CrossRef] [PubMed]
  9. Petetin, Y.; Morelande, M.; Desbouvries, F. Marginalized particle PHD filters for multiple object Bayesian filtering. IEEE Trans. Aerosp. Electron. Syst. 2014, 50, 1182–1196. [Google Scholar] [CrossRef]
  10. Martino, L.; Read, J.; Elvira, V.; Louzada, F. Cooperative parallel particle filters for online model selection and applications to urban mobility. Digit. Signal Process. 2017, 60, 172–185. [Google Scholar] [CrossRef]
  11. Dan, C.; Miguez, J. Nested particle filters for online parameter estimation in discrete-time state-space markov models. arXiv, 2013; arXiv:1308.1883. [Google Scholar]
  12. Emzir, M.F.; Woolley, M.J.; Petersen, I.R. A quantum extended kalman filter. J. Phys. A-Math. Theor. 2017, 50, 225301. [Google Scholar] [CrossRef]
  13. Lin, S.-G. Assisted adaptive extended kalman filter for low-cost single-frequency GPS/SBAS kinematic positioning. GPS Solut. 2015, 19, 215–223. [Google Scholar] [CrossRef]
  14. N∅rgaard, M.; Poulsen, N.K.; Ravn, O. New developments in state estimation for nonlinear systems. Automatica 2000, 36, 1627–1638. [Google Scholar] [CrossRef]
  15. Julier, S.J.; Uhlmann, J.K. Unscented filtering and nonlinear estimation. Proc. IEEE 2004, 93, 401–422. [Google Scholar] [CrossRef]
  16. Wan, E.A.; Van Der Merwe, R. The unscented kalman filter for nonlinear estimation. In Proceedings of the IEEE 2000 Adaptive Systems for Signal Processing, Communications, and Control Symposium (Cat. No.00EX373), Lake Louise, AB, Canada, 4 October 2000; pp. 153–158. [Google Scholar]
  17. Julier, S.J.; Uhlmann, J.K. New extension of the kalman filter to nonlinear systems. In Proceedings of the International Symposium on Aerospace/Defence Sensing, Simulation and Controls, Orlando, FL, USA, 20–25 April 1997; pp. 182–193. [Google Scholar]
  18. Arasaratnam, I.; Haykin, S. Cubature kalman filters. IEEE Trans. Autom. Control 2009, 54, 1254–1269. [Google Scholar] [CrossRef]
  19. Quine, B.M. A derivative-free implementation of the extended kalman filter. Automatica 2006, 42, 1927–1934. [Google Scholar] [CrossRef]
  20. Jia, B.; Xin, M.; Cheng, Y. High-degree cubature kalman filter. Automatica 2013, 49, 510–518. [Google Scholar] [CrossRef]
  21. Wang, S.; Feng, J.; Tse, C.K. Spherical simplex-radial cubature kalman filter. IEEE Signal Process Lett. 2014, 21, 43–46. [Google Scholar] [CrossRef]
  22. Duník, J.; Straka, O.; Šimandl, M. Stochastic integration filter. IEEE Trans. Autom. Control 2013, 58, 1561–1566. [Google Scholar] [CrossRef]
  23. Bhaumik, S. Cubature quadrature kalman filter. IET Signal Proc. 2013, 7, 533–541. [Google Scholar] [CrossRef]
  24. Mysovskikh, I. The approximation of multiple integrals by using interpolatory cubature formulae. Quant. Approx. 1980, 217–243. [Google Scholar] [CrossRef]
  25. Lu, J.; Darmofal, D.L. Higher-dimensional integration with gaussian weight for applications in probabilistic design. SIAM J. Sci. Comput. 2004, 26, 613–624. [Google Scholar] [CrossRef]
  26. Genz, A.; Monahan, J. Stochastic integration rules for infinite regions. SIAM J. Sci. Comput. 1998, 19, 426–439. [Google Scholar] [CrossRef]
  27. Dunik, J.; Straka, O.; Simandl, M. On sigma-point set rotation in derivative-free filters. In Proceedings of the 2014 17th International Conference on Information Fusion (FUSION), Salamanca, Spain, 7–10 July 2014; pp. 1–8. [Google Scholar]
  28. Xiu, D. Numerical integration formulas of degree two. Appl. Numer. Math. 2008, 58, 1515–1520. [Google Scholar] [CrossRef]
  29. Chihara, T.S. An Introduction to Orthogonal Polynomials; Courier Corporation: Chelmsford, UK, 2011. [Google Scholar]
  30. Krylov, V.I. Approximate Calculation of Integrals; Courier Corporation: Chelmsford, UK, 2006. [Google Scholar]
  31. Wu, H.; Chen, S.X.; Yang, B.F.; Chen, K. Robust derivative-free cubature kalman filter for bearings-only tracking. J. Guid. Control Dyn. 2016, 39, 1865–1870. [Google Scholar] [CrossRef]
Figure 1. The mean squared errors (MSEs) of various algorithms. CKF—cubature Kalman filter; SCKF—simplex CKF; OSCL-CKF—orthogonal simplex Chebyshev-Laguerre CKF.
Figure 1. The mean squared errors (MSEs) of various algorithms. CKF—cubature Kalman filter; SCKF—simplex CKF; OSCL-CKF—orthogonal simplex Chebyshev-Laguerre CKF.
Applsci 08 00863 g001
Figure 2. Model of bearings-only tracking.
Figure 2. Model of bearings-only tracking.
Applsci 08 00863 g002
Figure 3. The position root MSE (RMSE) of various algorithms. UKF—unscented Kalman filter.
Figure 3. The position root MSE (RMSE) of various algorithms. UKF—unscented Kalman filter.
Applsci 08 00863 g003
Figure 4. The velocity RMSE of various algorithms.
Figure 4. The velocity RMSE of various algorithms.
Applsci 08 00863 g004
Figure 5. The MSEs in position comparison of the algorithms. (Case 1: σe = 8.7 mrad; Case 2: σe = 17.5 mrad; Case 3: σe = 34.9 mrad).
Figure 5. The MSEs in position comparison of the algorithms. (Case 1: σe = 8.7 mrad; Case 2: σe = 17.5 mrad; Case 3: σe = 34.9 mrad).
Applsci 08 00863 g005
Table 1. The parameters of the tracking.
Table 1. The parameters of the tracking.
Parametersrscσrσeσc
Value5 km4 knots−2.44 rad2 km17.5 mrad π 12

Share and Cite

MDPI and ACS Style

Liu, Z.; Chen, S.; Wu, H.; Liang, F. Orthogonal Simplex Chebyshev-Laguerre Cubature Kalman Filter Applied in Nonlinear Estimation Systems. Appl. Sci. 2018, 8, 863. https://doi.org/10.3390/app8060863

AMA Style

Liu Z, Chen S, Wu H, Liang F. Orthogonal Simplex Chebyshev-Laguerre Cubature Kalman Filter Applied in Nonlinear Estimation Systems. Applied Sciences. 2018; 8(6):863. https://doi.org/10.3390/app8060863

Chicago/Turabian Style

Liu, Zhuowei, Shuxin Chen, Hao Wu, and Fang Liang. 2018. "Orthogonal Simplex Chebyshev-Laguerre Cubature Kalman Filter Applied in Nonlinear Estimation Systems" Applied Sciences 8, no. 6: 863. https://doi.org/10.3390/app8060863

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop