Next Article in Journal
Real-Time and High-Resolution 3D Face Measurement via a Smart Active Optical Sensor
Next Article in Special Issue
Random Finite Set Based Bayesian Filtering with OpenCL in a Heterogeneous Platform
Previous Article in Journal
Monitoring and Discovery for Self-Organized Network Management in Virtualized and Software Defined Networks
Previous Article in Special Issue
Object Tracking Using Local Multiple Features and a Posterior Probability Measure
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Strong Tracking Spherical Simplex-Radial Cubature Kalman Filter for Maneuvering Target Tracking

Ministerial Key Laboratory of JGMT, Nanjing University of Science and Technology, Nanjing 210094, China
*
Author to whom correspondence should be addressed.
Sensors 2017, 17(4), 741; https://doi.org/10.3390/s17040741
Submission received: 20 February 2017 / Revised: 26 March 2017 / Accepted: 28 March 2017 / Published: 31 March 2017

Abstract

:
Conventional spherical simplex-radial cubature Kalman filter (SSRCKF) for maneuvering target tracking may decline in accuracy and even diverge when a target makes abrupt state changes. To overcome this problem, a novel algorithm named strong tracking spherical simplex-radial cubature Kalman filter (STSSRCKF) is proposed in this paper. The proposed algorithm uses the spherical simplex-radial (SSR) rule to obtain a higher accuracy than cubature Kalman filter (CKF) algorithm. Meanwhile, by introducing strong tracking filter (STF) into SSRCKF and modifying the predicted states’ error covariance with a time-varying fading factor, the gain matrix is adjusted on line so that the robustness of the filter and the capability of dealing with uncertainty factors is improved. In this way, the proposed algorithm has the advantages of both STF’s strong robustness and SSRCKF’s high accuracy. Finally, a maneuvering target tracking problem with abrupt state changes is used to test the performance of the proposed filter. Simulation results show that the STSSRCKF algorithm can get better estimation accuracy and greater robustness for maneuvering target tracking.

1. Introduction

Maneuvering target tracking has drawn increasing attention because of its widespread application in areas such as radar tracking, aircrafts surveillance, and spacecraft orbit control [1,2]. For maneuvering target tracking, many algorithms are developed and grouped into two types. One type is to improve the accuracy of the motion model, such as multiple-model (MM) methods [3], optimization of multiple model neural filter [4], current statistical (CS) model [5,6], and so on. The other type is to detect the target maneuverability and then to cope with it effectively, such as strong tracking filter (STF) [7], tracking algorithm based on maneuvering detection [8], and so on. In these methods, the performance of the filter is an important factor affecting the performance of these methods. Therefore, improving the accuracy of the filter is also a useful method to improve the performance of maneuvering target tracking. Thus, a large number of nonlinear filters have been developed. Among these algorithms, the extended Kalman filter (EKF) [9] is one of the earliest and most widely used nonlinear filters. The EKF uses a linearization technique, based on the first-order Taylor series expansion, and approximates the nonlinear system. However, EKF has some limitations, such as complex Jacobian matrix calculations and poor accuracy in estimating the states of the strongly nonlinear system.
As better alternatives to the EKF, many nonlinear filters based on the idea of Bayesian theory have been proposed. One popular approach for the nonlinear non-Gaussian filtering problem is to use sequential Monte Carlo methods. The most famous method is known as particle filter (PF) [10,11,12,13]. The key idea of PF is to represent the posterior distribution by a set of random samples and to calculate estimates based on these samples and weights. Although the PF can provide good performance, the computational cost is very high and suffers from the curse of the dimensionality problem. These shortcomings restrict their applications in a real-time system. A different approach for nonlinear filtering is based on the point-based filtering technique that approximates intractable integrals encountered by a set of deterministically sampled points. Compared with the Monte Carlo numerical integration that relies on randomly sampled points, the deterministic point-based method has lower computational complexity with high accuracy. The type of filter includes the unscented Kalman filter (UKF) [14], Gauss-Hermite filter (GHF) [15], central difference filter (CDF) [16], etc. Among these methods, the well-known filter is UKF. The UKF uses unscented transform (UT) to capture the mean and covariance of a Gaussian density. It is shown that the UKF has better performance than the EKF. Besides its higher approximation accuracy, this UKF can avoid the cumbersome evaluation of Jacobian and Hessian matrices, making the algorithm easier to implement. Nevertheless, the unscented transform of the UKF is potentially unstable [17], which restricts its practical applications. Apart from the aforementioned filters, the cubature Kalman filter (CKF) has been proposed [17,18] by Arasaratnam and Haykin. Making use of the third-degree spherical-radial cubature rule, the CKF is reported to be more flexible in implementation form and more stable than UKF. In addition, Jia et al. [19] proposed the high-degree CKF where the number of sample points increases rapidly with the increase of the degree or state dimension. To further improve estimation accuracy with low complexity, a new nonlinear filter named spherical simplex-radial cubature filter (SSRCKF) is developed in [20]. The new class of CKF is based on the simplex spherical radial (SSR) rule, which improves the accuracy of CKF with only two more cubature points necessary.
Although the SSRCKF can achieve good accuracy in tracking non-maneuvering or weak maneuvering targets, it may lose the tracking ability to the abrupt state change when the system reaches the stable state. This is because the reaction of the gain matrix is delayed to the sudden change of the prediction error. To tackle the problem mentioned above, a new algorithm called strong tracking spherical simplex-radial cubature Kalman filter (STSSRCKF) is proposed in this paper. The STSSRCKF is developed based on the combination of strong tracking filter (STF) [7,21,22] and SSRCKF. The new algorithm using the strong tracking idea and the fading factor based on the residual to modify the prior covariance matrix quickly. Thus, the gain of the filter can be adjusted in real time to enhance tracking capacity for the maneuvering target. In addition, the algorithm can also keep a normal tracking accuracy for weak maneuvering targets. Compared with the STF, strong tracking unscented Kalman filter (STUKF) [23], strong tracking cubature Kalman filter (STCKF) [24] and SSRCKF, the proposed algorithm has a good accuracy and robust advantage over a wide range of maneuver. The performance of the proposed filter is demonstrated by the simulation.
The remainder of this paper is organized as follows. The overview of the background theory is presented in Section 2. The proposed algorithm is developed in Section 3. Simulation results and performance comparisons are presented in Section 4. Finally, conclusions are provided in Section 5.

2. A Review of UKF and CKF

The nonlinear discrete-time system is represented by
{ x k = f ( x k 1 ) + w k 1 z k = h ( x k ) + v k
where k N denotes discrete time, f ( ) represents the nonlinear function, h ( ) represents the measurement function. x k R n is the state vector of system, z k R m is the measurement, w k R n is the process noise vector, and v k R m is the measurement noise vector. The process w k and measurement noise v k are uncorrelated zero-mean Gaussian white sequences and have zero cross-correlation with each other, represented as w k ~ N ( 0 , Q k ) and v k ~ N ( 0 , R k ) , respectively.
Under the Gaussian assumption in the Bayesian filtering framework, the key problem of the nonlinear filtering problem is to calculate the multi-dimensional integrals. However, in most cases, the multi-dimensional integrals cannot be solved analytically. As a result, several approximation methods have been proposed, such as the unscented transformation (UT) and the cubature rule.
The UT with 2 n + 1 the sigma points χ i and corresponding weights is chosen as
{ χ 0 = x k | k χ i = x k | k + [ ( n + λ ) P k | k ] i   ( i = 1 , , n ) χ i = x k | k [ ( n + λ ) P k | k ] i   ( i = n + 1 , , 2 n ) ω m ( 0 ) = λ / ( n + λ )   ω c ( 0 ) = λ / ( n + λ ) + ( 1 α 2 + β ) ω m ( i ) = ω c ( i ) = 1 / 2 ( n + λ ) ( i = 1 , , 2 n )
where [ P k | k ] i is the i th column of the matrix square root of P k | k , n is the dimension of state. λ = α 2 ( n + κ ) n is the scaling parameter; α determines the spread of the sigma points around x k | k . The positive constants β and κ are used as parameters of the method.
The third-degree cubature rule with 2 n cubature points and weights is given by:
{ χ i = x k | k + [ ( n / 2 ) P k | k ] i   ( i = 1 , , n ) χ i = x k | k [ ( n / 2 ) P k | k ] i   ( i = n + 1 , , 2 n ) ω m ( i ) = ω c ( i ) = 1 / 2 n   ( i = 1 , , 2 n )
As indicated above, the main difference between the UT used in UKF and the third-degree cubature rule used in CKF is that the UT has one more point in the center with a tune parameter κ . If the parameter κ is set to zero, the sigma points set will evolve into the cubature points set and the UKF becomes identical to the CKF. For UKF, the scaling parameter κ is always set to n 3 . Based on this point, for high-dimensional problems ( n > 3 ) , it will lead to the negative weight of the center point. The presence of the negative weight may lead the covariance matrix to become non-positively defined. Thus, the cubature rule is more stable than the UT. In summary, the CKF is virtually a special case of UKF and the CKF has better numerical stability than UKF.

3. Strong Tracking Spherical Simplex-Radial Cubature Kalman Filter

The heart of the spherical simplex cubature Kalman filter is the spherical-radial cubature rule. The spherical-radial cubature rule does not approximate the nonlinear function, but it can approximate the integral of the form (nonlinear function × Gaussian) using weighted quadrature point sets. The integral with the standard Gaussian distribution N ( x ; 0 , I ) can be approximated by the quadrature
n f ( x ) N ( x ; 0 , I ) d x i = 1 m ω i f ( γ i )
where m is the total number of quadrature points in the state-space n , { γ i , ω i } i m is a set of quadrature points and corresponding weights. The general Gaussian integral n f ( x ) N ( x ; x ^ , P ) d x can be approximated by the following transformation
n f ( x ) N ( x ; x ^ , P ) d x = n f ( P x + x ^ ) N ( x ; 0 , I ) d x i = 1 m ω i f ( P γ i + x ^ )
The computational complexity of the numerical integration is proportional to the number of quadrature points, and the accuracy of the numerical integration rule is usually assessed by the polynomial approximation degrees.

3.1. Review of the Third-Degree Spherical Simplex-Radial Cubature Rule

The SSRCKF algorithm has the same structure as the general Gaussian approximation filters, such as the CKF, but uses the third-degree spherical simplex-radial cubature rule to calculate the Gaussian weight integral I ( f ) = R n f ( x ) N ( x ; 0 , I ) d x . By using the spherical simplex-radial cubature rule, the SSRCKF method can get more accurate estimation than CKF. In the third-degree spherical simplex-radial cubature rule, the following integral is considered [19]:
I ( f ) = R n f ( x ) exp ( x T x ) d x
where f ( ) is arbitrary nonlinear function, n is the integral domain. To calculate the above integral, let x = r s ( s T s = 1 , r = x T x ) . Equation (6) can be transformed into the spherical-radial coordinate system
I ( f ) = 0 U n f ( r s ) r n 1 exp ( r 2 ) d σ ( s ) d r
where s = [ s 1 , s 2 , , s n ] T , U n = { s n : s 1 2 + s 2 2 + + s n 2 = 1 } is the spherical surface, and σ ( ) is the area element on U n . Then, the Equation (7) can be decomposed into the spherical integral S ( r ) = U n f ( r s ) d σ ( s ) and the radial integral I ( f ) = 0 S ( r ) r n 1 exp ( r 2 ) d r .

3.1.1. Spherical Simplex Rule

As can be seen from the literature [25], the spherical integral U n f ( r s ) d σ ( s ) can be approximated by the transformation group of the regular n -simplex with vertices a j . P 0 The third-degree spherical simplex rule with 2 n + 2 quadrature points is given by
S ( r ) = A n 2 ( n + 1 ) j = 1 n + 1 ( f ( r a j ) + f ( r a j ) ) = j = 1 N s ω s , j f ( r y j )
where A n = 2 π n / Γ n ( 1 / 2 ) , N s = 2 n + 2 .

3.1.2. Radial Rule

The radial integral 0 S ( r ) r n 1 exp ( r 2 ) d r can be calculated by the following moment matching equation
0 S ( r ) r n 1 exp ( r 2 ) d r = i = 1 N r ω r , i S ( r i )
where S ( r ) = r l is a monomial in r , with l an even integer. Using the moment method with the minimum number of points, the third-degree radial rule ( N r = 1 ) can be derived. From Equation (9) we can obtain the moments’ equations as
{ ω r , 1 r 1 0 = 1 2 Γ ( n 2 ) ω r , 1 r 1 2 = 1 2 Γ ( n + 2 2 ) = n 4 Γ ( n 2 )
By solving Equation (10), the points and weights for the third-degree radial rule are given by
{ r 1 = n / 2 ω r , 1 = Γ ( n / 2 ) / 2

3.1.3. Spherical Simplex-Radial Rule

By using Equations (7), (8) and (11), the third-degree spherical simplex-cubature rule ( N r = 1 , N s = 2 n + 2 ) is given by
R n f ( x ) N ( x , 0 , I ) d x = 1 π n R n f ( 2 x ) exp ( x T x ) d x 1 π n i = 1 N r j = 1 N s ω r , i ω s , j f ( 2 r i s j ) = 1 2 ( n + 1 ) × ( j = 1 n + 1 f ( n a j ) + j = n + 2 2 n + 2 f ( n a j ) ) ) = k = 1 m ω k f ( ξ k )
where m = 2 n + 2 , ξ k = n [ a , a ] k and ω k = 1 / ( 2 n + 2 ) are the corresponding weights.
The steps of SSRCKF algorithm for the nonlinear system can be found in the literature [17].

3.2. Strong Tracking Filter

To improve the performance of EKF, a concept of STF was proposed by Zhou and Frank [7]. They proved that a filter can obtain the strong tracking estimation of the state can have the strong tracking performance only if the filter satisfies the orthogonal principle [7]. In strong tracking, the time-varying suboptimal fading factor is incorporated, which online adjusts the covariance of the predicted state. In this way, the algorithm has the ability to track abrupt state change and strong robustness against mode uncertainties. The algorithm has the following steps [21]:
x ^ k | k - 1 = f k ( x ^ k - 1 | k - 1 ) P k | k - 1 = λ k F k | k - 1 P k F k | k - 1 T + Q k K k = P k | k - 1 H k T ( H k P k | k - 1 H k T + R k ) - 1 x ^ k | k = x ^ k | k 1 + K k ( z k - h ( x ^ k | k 1 ) ) P k | k = [ I K k H k ] P k | k - 1
where F k | k - 1 and H k are the process matrix and measure matrix, respectively. The suboptimal time-varying fading factor λ k is given by
λ k = { c k , c k 1 1 , c k < 1 , c k = tr [ N k ] tr [ M k ]
N k = V k H k Q k 1 H k T β R k
M k = H k F k P k 1 | k 1 F k T H k T
V k = { v 0 v 0 T k = 0 ρ V k 1 + v k v k T 1 + ρ k 1
where t r [ ] is the trace operation, v k = z k z ^ k | k 1 denotes the measurement residual vector; β 1 is the softening factor, which can improve the smoothness of state estimation; 0 < ρ 1 is the forgetting factor. In generally, the parameters β and ρ are chosen as 4.5 and 0.95, respectively [26,27].

3.3. Equivalent Expression of the Fading Factor

As we know, STF need calculate the linearization of the nonlinear measurement matrix (Hessian matrix). However, SSRCKF is not necessary to compute the Hessian matrix. So we give the equivalent expression of STF, which need not calculate the Hessian matrix. Suppose P k | k 1 l is the state error covariance matrix before introducing fading factor, P z z , k | k 1 l is the measurement covariance matrix and P x z , k | k 1 l is cross-covariance matrix, Equations (15) and (16) have the following equivalent expressions:
N k = V k ( P x z , k | k 1 l ) T ( P k | k 1 l ) 1 Q k 1 ( P k | k 1 l ) 1 ( P x z , k | k 1 l ) β R k
M k = P z z , k | k - 1 l V k + N k + ( β 1 ) R k
The new fading factor can be obtained through Equations (14) and (17)–(19). It can be verified from Equations (18) and (19) that the calculation of suboptimal fading factor in the Equation expression does not need to compute any Jacobian matrix.

3.4. Steps of the STSSRCKF

Based on the previous sections, the strong tracking spherical-simplex cubature Kalman filtering (STSSRCKF) can adjust the prediction error covariance matrix by introducing a suboptimal factor. Hence, the robustness and real-time tracking ability are provided in the STSSRCKF algorithm. The initial state is assumed to be Gaussian distribution with x ^ 0 | 0 and P 0 | 0 . The computation steps of the third-degree strong tracking spherical simplex-radial cubature Kalman filter is summarized as follows:
Step 1. Give the state estimate x ^ k 1 | k 1 and the error covariance matrix P k 1 | k 1 ;
Step 2. State estimate prediction:
The cubature points are obtained as
χ j , k | k 1 l = x ^ k | k 1 + chol ( P k | k 1 ) T ξ j
where chol ( ) is the Cholesky factorization.
Propagate the cubature points, the predicted state x k | k 1 , and the predicted covariance P k | k 1 l without the fading factor are given as
χ j , k | k 1 * = f ( χ j , k 1 )
x ^ k | k 1 = j = 1 m ω j χ j , k | k 1 *
P k | k 1 l = j = 1 m ω j ( χ j , k | k 1 * x ^ k | k 1 ) ( χ j , k | k 1 * x ^ k | k 1 ) T + Q k 1
where Q k 1 is the covariance matrix of process noise.
Step 3. Calculation of the fading factor λ k :
Using the predicted state x ^ k | k 1 and the predicted covariance P k | k 1 l , the innovation covariance P z z , k | k 1 l and the cross covariance P x z , k | k 1 l can be calculated as
z j , k | k 1 l = h ( χ j , k | k 1 * )
z ^ k | k 1 l = j = 1 m ω j z j , k | k 1 l
P x z , k | k 1 l = j = 1 m ω j ( χ j , k | k 1 l x ^ k | k 1 ) ( z j , k | k 1 l z ^ k | k 1 l ) T
P z z , k | k 1 l = j = 1 m ω j ( z j , k | k 1 l z ^ k | k 1 l ) ( z j , k | k 1 l z ^ k | k 1 l ) T + R k
The fading factor λ k can be calculated by using Equations (14) and (17)–(19).
Step 4. Measurement updating modified by the fading factor:
The modified prediction covariance P k | k 1 can be updated by
P k | k 1 = λ k ( P k | k 1 l Q k 1 ) + Q k 1
By utilizing the predicted state estimate x ^ k | k 1 and the modified predicted covariance P k | k 1 with the fading factor λ k , the modified predicted measurement z ^ k | k 1 , the modified cross covariance and the modified innovation covariance P z z , k | k 1 can be calculated as follows
χ j , k | k 1 = chol ( P k | k 1 ) ξ i + x ^ k | k 1
z j , k | k 1 = h ( χ j , k | k 1 )
z ^ k | k 1 = j = 1 m ω j z j , k | k 1
P x z , k | k 1 = j = 1 m ω j ( χ j , k | k 1 x ^ k | k 1 ) ( z j , k | k 1 z ^ k | k 1 ) T
P z z , k | k 1 = j = 1 m ω j ( z j , k | k 1 z ^ k | k 1 ) ( z j , k | k 1 z ^ k | k 1 ) T + R k
Step 5. Estimation results:
The state estimate x ^ k and the covariance P k at time k are calculate as follows
K k = P x z , k | k 1 ( P z z , k | k 1 ) 1
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
The STSSRCKF combines the advantages of STF and SSRCKF. Then the STSSRCKF has strong robustness against model uncertainties and good real-time state tracking capability [28]. Moreover, the STSSRCKF algorithm eliminates the cumbersome evaluation of Jacobian/Hessian matrices, its numerical stability and estimated accuracy are significantly improved.

4. Simulation and Results

The effectiveness of the proposed algorithm will be illustrated through two examples of maneuvering target tracking. Taking the root mean square error (RMSE) and accumulative RMSE (ARMSE), the study compared the STSSRCKF algorithm with the EKF algorithm and the SSRCKF algorithm.

4.1. Tracking Model and Measurement Model

The constant acceleration (CA) model is a common tool for tracking target modeling. The state Equation of CA model in two-dimensional case is described as follow:
X k = d i a g [ Φ C A , Φ C A ] X k 1 + G C A V k 1 + w k 1
where X k 1 = [ x k 1 , x ˙ k 1 , x ¨ k 1 , y k 1 , y ˙ k 1 , y ¨ k 1 ] T is the target state at time k 1 , ( x k 1 , y k 1 ) , ( x ˙ k 1 , y ˙ k 1 ) and ( x ¨ k 1 , y ¨ k 1 ) represent the target position, velocity and acceleration in the x and y coordinate at time k 1 , respectively; d i a g [ Φ C A , Φ C A ] is the state transition matrix, G k 1 is the state input matrix, V k 1 is the process noise, w k 1 is zero-mean white Gaussian noise and its corresponding covariance matrix is Q c a . Φ C A , G k 1 are described as:
Φ C A = [ 1 T T 2 / 2 0 1 T 0 0 1 ]
G C A = [ T 2 / 2 T 1 ]
where T is the sampling interval.
In radar tracking system, the target motion is usually modelled in Cartesian coordinates, whereas the target’s position and azimuth are obtained in polar coordinate. The radar is located at the origin, and provides range and bearing measurements. The measurement model can be established as
z k = ( x k 2 + y k 2 atan 2 ( y k , x k ) ) + v k
where atan2(⋅) is the four-quadrant inverse tangent function, v k is the white Gaussian measurement noise with zero mean and covariance R k = d i a g ( [ σ r 2 , σ θ 2 ] ) . σ r and σ θ denote the standard deviation of range measurement noise and bearing angle measurement noise, respectively.

4.2. Simulation of the STSSRCKF

Example 1.
In this simulation, the sampling interval is T = 1   s and simulation time is 100 s . The Monte Carlo simulations are carried out 200 times. The RMSE of the target position at time k and the accumulative RMSE (ARMSE) of estimated position at all times are defined in Equations (41) and (42):
RMSE pos ( k ) = 1 M m = 1 M ( ( x k x ^ m , k ) 2 + ( y k y ^ m , k ) 2 )
ARMSE pos = 1 N k = 1 N ( RMSE pos 2 ( k ) )
where M is the number of Monte Carlo runs, ( x k , y k ) is the actual value of the target position at time k and ( x ^ m , k , y ^ m , k ) is the estimated position at time k in mth Monte-Carlo. The RMSE and the accumulative RMSE in the velocity and acceleration can be defined in the same way.
This example considers a two-dimensional simulation scenario including one motion mode of high maneuver. The initial location of the target is ( x , y ) = ( 100   m , 400   m ) , its initial velocity is ( v x , v y ) = ( 15   m / s , 20   m / s ) , and its initial acceleration is ( a x , a y ) = ( 0   m / s 2 , 0   m / s 2 ) . The target makes a uniform motion during the first 150 s. Then, it takes a high maneuver with the acceleration ( a x , a y ) = ( 15   m / s 2 , 25   m / s 2 ) up to the end of this simulation at t = 200   s . In this simulation, the initial value x ^ 0 | 0 and the initial covariance matrix P 0 | 0 are set to be [ 100   m , 15   m / s , 0   m / s 2 , 400   m , 20   m / s , 0   m / s 2 ] T and diag [ ( 50   m ) 2 , ( 20   m / s ) 2 , ( 1   m / s 2 ) 2 , ( 50   m ) 2 , ( 10   m / s ) 2 ( 1   m / s 2 ) 2 ] T , respectively. The standard deviation of range measurement noise σ r is 30 m and the standard deviation of bearing angle measurement noise σ θ is 10 mrad.
The example is executed to examine the performance among the SSRCFK, STF, STUKF, STCKF and STSSRCK methods. The RMSEs of the position, velocity and acceleration using the five filters are shown in Figure 1, Figure 2 and Figure 3. It can be shown that the STF, STUKF, STCKF and STSSRCK methods can converge quickly when the target engages in high maneuvering. The SSRCKF algorithm only has a good performance for uniform motion. However, the performance of SSRCKF decreases seriously when the target engages in high maneuvering. This is because that the prediction covariance cannot be adjusted timely when the target state suddenly changes. The STF algorithm has the fourth speed of convergence, which is due to the fact that the linear approximation in the STF may introduce errors in the state which may lead the state to diverge. As can be seen from Figure 1, Figure 2 and Figure 3, when the target is making uniform motion within the first 100 s, the five methods have a similar performance. When the maneuver starts at t = 101 s, it obviously shows that STF, STUKF, STCKF and STSSRCKF have the ability to convergence. The main reason is that the fading factor can adjust the prediction covariance and the corresponding filter gain in real time, which makes these algorithms converge in a short time. We can also see that the RMSE of the proposed algorithm is lower than that of STUKF and STCKF. It means that estimate precision of the proposed algorithm is higher than that of the two algorithms. It is demonstrated that the proposed algorithm can effectively track the abrupt motion state of the target.
To quantitatively describe the tracking performance, the ARMSEs of the five methods in estimating different target parameters are listed in Table 1. As shown, the STSSRCKF provided the best result in terms of estimation. The STCKF also performed well, followed by the STUKF and STF. The SSRCKF provided the worst estimate. We can also draw the conclusion that the STSSRCKF has the highest tracking accuracy of the position, velocity and acceleration.
The program is made on the Intel Core (TM) i5-4430 3.0GHZ CPU with 4.00G RAM. Table 2 shows the computational complexity and the computational time of SSRCFK, STF, STUKF, STCKF and STSSRCK for each run. Apart from STF, the computational complexity of different filters is mainly determined by the number of points they use. The computational complexity of STCKF as well as STUKF differs only by one points. The computational complexity of SSRCKF and STSSRCKF is O{(2n + 2)3}, where n denotes the dimension of state. In addition, we can see that the computational complexity of STF is the lowest. Because there is a clear formula in STF to calculate the Jacobian matrix, the computational complexity of STF is much smaller than other four algorithms. It is also shown that the computational time of the SSRCKF is 0.07 s for each run. However, the computational time of the STSSRCKF is 0.15 s, which is greater than that of the SSRCKF. This is because the STSSRCKF needs to calculate the suboptimal fading factor at each time step. At present, the time consumption is acceptable. The STSSRCKF needs more computational time than the SSRCKF, but considering the significant performance improvement gained from the STSSRCKF, this increased computational time is not substantial.
From this simulation, we can conclude that the STSSRCKF can perform the best in terms of the balance between computational complexity and estimation accuracy.
Example 2.
This example evaluates the proposed algorithm in tracking a target with weak maneuver and medium maneuver. Therefore, two simulations are simulated as follows. Assume that there is a target making uniform at first. The initial location of the target is ( x , y ) = ( 5000   m , 5000   m ) , its initial velocity is ( v x , v y ) = ( 150   m / s , 80   m / s ) , and its initial acceleration is ( a x , a y ) = ( 0   m / s 2 , 0   m / s 2 ) .
Case 1:
Simulation of medium maneuvering target tacking. The target moves with initial acceleration until t = 150   s . Then, it maneuvers with acceleration of ( a x ( 151 ) , a y ( 151 ) ) = ( 5   m / s 2 , 5   m / s 2 ) up to end of this simulation at t = 200   s .
Case 2:
Simulation of weak maneuvering target tracking. The initial position, velocity and acceleration of the target are the same as those in Case1. The target also moves with initial acceleration until t = 150   s . Then, it maneuvers with acceleration of ( a x ( 151 ) , a y ( 151 ) ) = ( 0.5   m / s 2 , 0.5   m / s 2 ) up to end of this simulation at t = 200   s .
Table 3 lists the accumulative RMSEs of the five methods in estimation the three target parameters. As can be seen from Table 3, the STSSRCKF algorithm also has a good tracking performance for a weak or medium maneuvering target.

5. Conclusions

To implement higher tracking accuracy for a maneuvering target, a new method has been proposed based on the STF and SSRCKF algorithms. Firstly, the time-varying suboptimal fading factor is introduced in order to adjust the prediction covariance and the corresponding filter gain in real time. Secondly, in the proposed method, the spherical simplex-cubature rule takes the place of calculating nonlinear function Jacobian matrix. In this way, STSSRCKF can converge rapidly in a short time. Thus, the proposed method has a high tracking accuracy for maneuvering target tracking. Simulation results show that the STSSRCKF can achieve higher accuracy and robustness than STF, STUKF, STCKF and SSRCKF, and indicate that it is suitable for maneuvering target tracking.

Author Contributions

All authors were involved in the study presented in this manuscript. Hua Liu provided insights into formulating the ideas and wrote the original manuscript of the paper. Wen Wu reviewed the manuscript and provided scientific advising to this study.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Yepes, J.L.; Hwang, I.; Rotea, M. New algorithms for aircraft intent inference and trajectory prediction. J. Guid. Control Dyn. 2007, 30, 370–382. [Google Scholar] [CrossRef]
  2. Liu, Z.X.; Zhang, Q.Q.; Li, L.Q.; Xie, W.X. Tracking multiple maneuvering targets using a sequential multiple target Bayes filter with jump Markov system models. Neurocomputing 2016, 216, 183–191. [Google Scholar] [CrossRef]
  3. Li, X.R.; Jilkov, V.P. Survey of maneuvering target tracking. Part V: Multiple-model methods. IEEE Trans. Aerosp. Electron. Syst. 2005, 41, 1255–1321. [Google Scholar]
  4. Kazimierski, W.; Stateczny, A. Optimization of multiple model neural tracking filter for marine targets. In Proceedings of the 13th International Radar Symposium (IRS), Warsaw, Poland, 23–25 May 2012; pp. 543–548. [Google Scholar]
  5. Zhou, H.R.; Kumar, K.S.P. A “Current” Statistical Model and Adaptive Algorithm for Estimating Maneuvering Targets. AIAA J. Guid. 1984, 7, 596–602. [Google Scholar]
  6. Bingbing Jiang, W.S. Range tracking method based on adaptive“current” statistical model with velocity prediction. Signal Process. 2017, 261–270. [Google Scholar] [CrossRef]
  7. Zhou, D.H.; Frank, P.M. Strong tracking filtering of nonlinear time varying stochastic systems with coloured noise application to parameter estimation and empirical robustness analysis. Int. J. Control 1996, 65, 295–307. [Google Scholar] [CrossRef]
  8. Li, X.R.; Jilkov, V.P. A Survey of Maneuvering Target Tracking—Part IV: Decision-Based Methods. In Proceedings of the SPIE Conference on Signal and Data Processing of Small Targets 2002, Orlando, FL, USA, 15 April 2002; pp. 4728–4760. [Google Scholar]
  9. Schmidt, S.F. The Kalman filter—Its recognition and development for aerospace applications. J. Guid. Control Dyn. 1981, 4, 4–7. [Google Scholar] [CrossRef]
  10. Djuric, P.M.; Kotecha, J.H.; Zhang, J.Q.; Huang, Y.F.; Ghirmai, T.; Bugallo, M.F.; Miguez, J. Particle filtering. IEEE Signal. Proc. Mag. 2003, 20, 19–38. [Google Scholar] [CrossRef]
  11. Doucet, A.; Johansen, A.M. A Tutorial on Particle Filtering and Smoothing: Fifteen Years Later. Available online: http://automatica.dei.unipd.it/tl_files/utenti/lucaschenato/Classes/PSC10_11/Tutorial_PF_doucet_johansen.pdf (accessed on 31 March 2017).
  12. 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]
  13. Kotecha, J.H.; Djuric, P.A. Gaussian particle filtering. IEEE Trans. Signal. Process. 2003, 51, 2592–2601. [Google Scholar] [CrossRef]
  14. Julier, S.J.; Uhlmann, J.K. Unscented filtering and nonlinear estimation. Proc. IEEE 2004, 92, 401–422. [Google Scholar] [CrossRef]
  15. Arasaratnam, I.; Haykin, S.; Elliott, R.J. Discrete-time nonlinear filtering algorithms using Gauss-Hermite quadrature. Proc. IEEE 2007, 95, 953–977. [Google Scholar] [CrossRef]
  16. Sadhu, S.; Srinivasan, M.; Bhaumik, S.; Ghoshal, I.K. Central difference formulation of risk-sensitive filter. IEEE Signal. Process. Lett. 2007, 14, 421–424. [Google Scholar] [CrossRef]
  17. Arasaratnam, I.; Haykin, S. Cubature Kalman filters. IEEE Trans. Autom. Control 2009, 54, 1254–1269. [Google Scholar] [CrossRef]
  18. Arasaratnam, I.; Haykin, S. Cubature Kalman smoothers. Automatica 2011, 47, 2245–2250. [Google Scholar] [CrossRef]
  19. Jia, B.; Xin, M.; Cheng, Y. High-degree cubature Kalman filter. Automatica 2013, 49, 510–518. [Google Scholar] [CrossRef]
  20. Wang, S.Y.; Feng, J.C.; Tse, C.K. Spherical Simplex-Radial Cubature Kalman Filter. IEEE Signal Process. Lett. 2014, 21, 43–46. [Google Scholar] [CrossRef]
  21. Wang, L.J.; Wu, L.F.; Guan, Y.; Wang, G.H. Online Sensor Fault Detection Based on an Improved Strong Tracking Filter. Sensors 2015, 15, 4578–4591. [Google Scholar] [CrossRef] [PubMed]
  22. Ge, Q.B.; Shao, T.; Wen, C.L.; Sun, R.Y. Analysis on Strong Tracking Filtering for Linear Dynamic Systems. Math. Probl. Eng. 2015, 2015. [Google Scholar] [CrossRef]
  23. Li, D.; Ouyang, J.; Li, H.Q.; Wan, J.F. State of charge estimation for LiMn2O4 power battery based on strong tracking sigma point Kalman filter. J. Power Sources 2015, 279, 439–449. [Google Scholar] [CrossRef]
  24. Gao, M.; Zhang, H.; Zhou, Y.L.; Zhang, B.Q. Ground maneuvering target tracking based on the strong tracking and the cubature Kalman filter algorithms. J. Electron. Imaging 2016, 25, 023006. [Google Scholar] [CrossRef]
  25. Jia, B.; Xin, M. Multiple sensor estimation using a new fifth-degree cubature information filter. Trans. Inst. Meas. Control. 2015, 37, 15–24. [Google Scholar] [CrossRef]
  26. Jwo, D.J.; Wang, S.H. Adaptive fuzzy strong tracking extended kalman filtering for GPS navigation. IEEE Sens. J. 2007, 7, 778–789. [Google Scholar] [CrossRef]
  27. Jwo, D.J.; Yang, C.F.; Chuang, C.H.; Lee, T.Y. Performance enhancement for ultra-tight GPS/INS integration using a fuzzy adaptive strong tracking unscented Kalman filter. Nonlinear Dyn. 2013, 73, 377–395. [Google Scholar] [CrossRef]
  28. Han, P.; Mu, R.; Cui, N. Effective fault diagnosis based on strong tracking UKF. Aircr. Eng. Aerosp. Technol. 2011, 83, 275–282. [Google Scholar] [CrossRef]
Figure 1. Root mean square error (RMSE) of the estimated position.
Figure 1. Root mean square error (RMSE) of the estimated position.
Sensors 17 00741 g001
Figure 2. RMSE of the estimated velocity.
Figure 2. RMSE of the estimated velocity.
Sensors 17 00741 g002
Figure 3. RMSE of the estimated acceleration.
Figure 3. RMSE of the estimated acceleration.
Sensors 17 00741 g003
Table 1. Tracking performance comparison.
Table 1. Tracking performance comparison.
FiltersPosition ARMSE/mVelocity ARMSE/(m/s)Acceleration ARMSE/(m/s2)
SSRCKF152.131.26.9
STF129.728.46.2
STUKF124.527.55.9
STCKF123.126.75.8
STSSRCKF119.325.15.6
Table 2. Computational complexity and computational time of different filters.
Table 2. Computational complexity and computational time of different filters.
FiltersComputational ComplexityComputational Time (s)
SSRCKFO{(2n + 2)3}0.07
STFO{(n)2}0.02
STUKFO{(2n + 1)3}0.14
STCKFO{(2n)3}0.14
STSSRCKFO{(2n + 2)3}0.15
Table 3. ARMSEs in simulation of medium and weak maneuvering target.
Table 3. ARMSEs in simulation of medium and weak maneuvering target.
SimulationFiltersPosition ARMSE/mVelocity ARMSE/(m/s)Acceleration ARMSE/(m/s2)
Case 1SSRCKF101.621.25
STF95.320.24.5
STUKF88.516.44.1
STCKF87.416.84.1
STSSRCKF81.115.93.7
Case 2SSRCKF50.58.21.8
STF65.110.82.4
STUKF57.38.82.2
STCKF56.38.32.2
STSSRCKF53.48.42.1

Share and Cite

MDPI and ACS Style

Liu, H.; Wu, W. Strong Tracking Spherical Simplex-Radial Cubature Kalman Filter for Maneuvering Target Tracking. Sensors 2017, 17, 741. https://doi.org/10.3390/s17040741

AMA Style

Liu H, Wu W. Strong Tracking Spherical Simplex-Radial Cubature Kalman Filter for Maneuvering Target Tracking. Sensors. 2017; 17(4):741. https://doi.org/10.3390/s17040741

Chicago/Turabian Style

Liu, Hua, and Wen Wu. 2017. "Strong Tracking Spherical Simplex-Radial Cubature Kalman Filter for Maneuvering Target Tracking" Sensors 17, no. 4: 741. https://doi.org/10.3390/s17040741

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