Next Article in Journal
Non-Contact Diagnostics of the Geometry of a Historic Wooden Building as an Element of Periodic Safety Assessment
Next Article in Special Issue
An Experimental Assessment of People’s Location Efficiency Using Low-Energy Communications-Based Movement Tracking
Previous Article in Journal
Influence of an External Electric Field and Dissipative Tunneling on Recombination Radiation in Quantum Dots
Previous Article in Special Issue
Real-Time Georeferencing of Fire Front Aerial Images Using Iterative Ray-Tracing and the Bearings-Range Extended Kalman Filter
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Mid-State Kalman Filter for Nonlinear Problems

Beijing Institute of Radio Measurement, Beijing 100854, China
*
Author to whom correspondence should be addressed.
Sensors 2022, 22(4), 1302; https://doi.org/10.3390/s22041302
Submission received: 5 January 2022 / Revised: 4 February 2022 / Accepted: 6 February 2022 / Published: 9 February 2022
(This article belongs to the Special Issue Multi-Radio and/or Multi-Sensor Integrated Navigation System)

Abstract

:
When tracking very long-range targets, wide-band radars capable of measuring targets with high precision at ranges have severe measurement nonlinearities. The existing nonlinear filtering technology, such as the extended Kalman filter and untracked Kalman filter, will have significant consistency problems and loss in tracking accuracy. A novel mid-state Kalman filter is proposed to avoid loss and preserve the filtering consistency. The observed state and its first-order state derivative are selected as the mid-state vector. The update process is transformed into the measurement space to ensure the Gaussian measurement distribution and the linearization of the measurement equation. In order to verify the filter performance in comparison, an iterative formulation of Cramér-Rao Low Bound for the nonlinear system is further derived and given in this paper. Simulation results show that the proposed method has excellent performance of high filtering accuracy and fast convergence by comparing the filter state estimation accuracy and consistency.

1. Introduction

Target tracking is a process that uses sensors to estimate the characteristics of a moving object of interest. It is widely used in unmanned aerial vehicles (UAV), military strikes, and other fields [1,2]. As the core problem of target tracking, state estimation theory realizes the real-time online estimation of a target’s motion state by integrating the prior information of the target and online measurement information provided by sensors. When the system satisfies the linear Gaussian condition, a Kalman filter (KF) can recursively obtain the consistent minimum variance and linear unbiased estimate of the state and is the optimal solution [3]. However, the system model is nonlinear in multi-sensor fusion, radar maneuvering target tracking, and satellite communication systems [4]. For the nonlinear system model, a nonlinear filtering method is needed to improve the estimation accuracy.
The extended Kalman filter (EKF) is the most widely used nonlinear filter in practical engineering because of its simple algorithm and small computation. The EKF uses a Taylor series expansion to approximate the nonlinear system model. When the nonlinearity is severe, the filtering accuracy will be reduced or even diverged due to a high-order truncation error [5]. Therefore, a second order and higher-order EKF are proposed successively, but their computational burden increases significantly [6]. The iterated extended Kalman filter (IEKF) is also obtained by dividing the one-step update of the EKF into multiple steps in pseudo-time and gradually updating the states according to the nonlinear gradient of measurement function [7]. The scholars applied numerical integration approximation methods to nonlinear filtering. The Gauss Hermite filter (GHF), unscented Kalman filter (UKF), and cubature Kalman filter (CKF) were proposed successively. The GHF is a polynomial integral approximation filtering algorithm for nonlinear system models [8] which uses Gauss-Hermite polynomials to approximate the probability density in Gaussian filtering. The UKF takes the UT criterion to select deterministic Sigma sampling points in the original state distribution point set, inputs the sampling points into the nonlinear system, and obtains the mean and covariance of the posterior probability density function through the transformation of the point set [9,10]. The UKF has less computation and better approximation performance than the EKF. The CKF is based on the spherical-radial criterion and uses a group of cubature points with equal weight to calculate the mean and covariance of state variables [11]. Wang Shuo conducts a comparative analysis on the UKF and CKF for low-dimensional and high-dimensional models under nonlinear conditions. The simulation results show that the CKF has the optimal numerical stability and filtering accuracy under high dimensional conditions [12,13]. A Particle Filter (PF) is not limited by the linearization error or gaussian noise assumption and approximates the probability density function corresponding to the nonlinear function. However, the considerable amount of calculation is unbearable for a real-time target tracking system [14].
Due to the complexity and uncertainty of very long-range target tracking, the Gaussian noise distribution in the measurement space will become a severe non-Gaussian distribution when it is converted into the state space in the update process. This phenomenon is often encountered in wide-band radar systems with high-range accuracy [15]. Due to the nonlinear distribution of the measurement area, existing nonlinear filters have specific problems in the accuracy of state estimation and the consistency of the filter and even divergence of the filter may occur in the EKF [16]. Because of this, a mid-state Kalman filter (MSKF) is proposed in this paper. A MSKF takes the observed state and its first-order state derivative as the mid-state vector and converts the predicted state covariance into the covariance of the mid-state vector according to the third-order spherical-radial criterion. Then the KF update process is converted to the measurement space and realizes the linearization of the measurement equation. Therefore, information loss in updating will be reduced to a minimum and the MSKF will have a higher accuracy in state estimation. The MSKF was applied to very long-range tracking problems and the simulation results prove the superiority and applicability of the algorithm.

2. Traditional Nonlinear Filter

In practical engineering applications, discrete nonlinear systems are generally characterized using additive noise and the system model is expressed as
{ x k = f ( x k 1 ) + w k 1 z k = h ( x k ) + v k
where process noise w k and observation noise v k are independent white zero-mean Gaussian noise.
The EKF obtains linear approximation of nonlinear system by using Taylor series expansion and then uses a KF to deal with the filtering problem of nonlinear system. The EKF approximates the nonlinear functions f ( x k 1 ) and h ( x k ) in the state space to the first-order Taylor polynomials near x ^ k and x ^ k | k 1 , respectively:
f ( x k ) f ( x ^ k 1 ) + F k 1 [ x k 1 x ^ k 1 ]
h ( x k ) h ( x ^ k | k 1 ) + H k [ x k x ^ k | k 1 ]
where F k 1 and H k are the Jacobi matrices as follows:
F k 1 = f ( x k 1 ) x | x = x ^ k 1
H k = h ( x k ) x | x = x ^ k | k 1
The UKF is different from the EKF in that it directly calculates the mean and covariance of the target distribution, avoiding the approximation of nonlinear functions. The UKF uses the mean and covariance of initial distribution to generate a series of determined sigma sampling points according to Formulas (6) and (7). These sigma sampling points are propagated through nonlinear functions to get the estimated mean and covariance [17].
{ χ 0 = x k χ i = x k + e i ( n x + κ ) P x χ i + n = x k e i ( n x + κ ) P x , i = 1 , 2 , , n x
The corresponding weight is
{ w 0 = κ n x + κ w i = w i + n = 1 2 ( n x + κ )
where κ is a fine-tuned scalar parameter, n x   is the dimension of the state vector x k , and e i is the i -th Cartesian fundamental vector. The size of κ is related to the size of the sample moments and controls the distance from the sigma point to the mean point.
Under the Gaussian assumption, the state estimation of the nonlinear KF can ultimately be equated to the calculation of multidimensional vector integral, which can be summarized in the form of a nonlinear function × Gaussian probability density function:
I ( g ) = R n g ( x ) N ( x ; x ¯ , P x ) d x
where g ( · ) is any nonlinear function. To solve the integral numerically, the CKF transforms it into spherical-radial form and then carries out numerical integration according to the spherical-radial criterion
0 f ( r ) r n 1 exp ( r 2 ) d r = i = 1 m w i f ( r i )
where r is the radial scalar obtained by spherical-radial transformation of the vector x in a cartesian coordinate system. The CKF filtering process is similar to that of the UKF. They all transform the sampled points with weight through the equations of the nonlinear system to calculate the first and second order moments required by filtering, but they have essential differences in obtaining sampling points. In a high-dimensional system, the weights of the UKF sigma points are prone to be negative which will cause the problem of unstable estimated values. The weights of the CKF sampling points are always positive, which solves the problem of instability. However, the filtering accuracy will be affected due to the increasing distance between the sampling point and the center point.

3. Mid-State Kalman Filter for Nonlinear Problems

The KF is proposed based on the least mean square error criterion. Under the assumption that the observation noise obeys the Gaussian distribution, the KF is a constant minimum variance and linear unbiased estimate that can recursively obtain the state. In this paper, a Mid-state Kalman Filter is proposed based on the KF method. A MSKF selects the observed state and its first-order state derivative as the mid-state vector and transforms the filter update process into the measurement space. The proposed method guarantees the Gaussian distribution of the measurement and correspondingly transforms the measurement equation into a linear form.

Mid-State Kalman Filter

Consider a nonlinear discrete system for target tracking as shown below:
{ x k = F k x k 1 + w k 1 z k = H k ( x k ) + v k
where, x k R n and z k R m are the system state vector and the measurement vector; F k ( · ) : R n R n and H k ( · ) : R n R m respectively represent the system state function and nonlinear measurement function; and the process noise w k and observation noise v k are independent zero-mean Gaussian noise with covariance Q k and R k .
In the typical two-dimensional radar target tracking, the target is assumed to be in uniform linear motion. Its state vector at time k is x k = [ x k , v x k , y k , v y k ] T , including the position [ x k , y k ] T and velocity vector [ v x k , v y k ] T . In the observation vector z k = [ r k , θ k ] T , r k and θ k are the distance measurement and angle measurement, respectively. The system state function and nonlinear measurement function in Equation (10) are respectively expressed as:
F = [ 1 T 0 0 0 1 0 0 0 0 1 T 0 0 0 1 ] , H k ( x k ) = [ x k 2 + y k 2 arctan ( y k 2 x k 2 ) ]
The MSKF selects x M k = [ z k , z ˙ k ] T = [ r k , r ˙ k , θ k , θ ˙ k ] T as mid-state vector and linearizes the measurement equation in the measurement space as:
z k = H z x M k + v k = [ I m 0 m × m ] × [ z k , z ˙ k ] T + v k
In this case, the nonlinear system in Equation (10) can be transformed into the following linear system:
{ x k = F k x k 1 + w k 1 z k = H z x M k + v k
This avoids the linearization process of the measurement function H k ( x k ) . Because the system satisfies the linear Gaussian condition of the KF, the mid-state can be updated by the KF. As the optimal linear filter, KF has less information loss and higher filtering accuracy.
In the mid-state, [ r ˙ k , θ ˙ k ] T is not only the first-order state derivative of [ r k , θ k ] T , but also has practical physical significance. r ˙ k and θ ˙ k , respectively, represent the radial velocity v r and angular velocity ω of the target movement in polar coordinates. Therefore, the linear velocity is v θ = ω r . As shown in Figure 1, the relative radar distance of the target is r , the angle is θ , and the velocity at time k is v . In the cartesian coordinate system, the velocity vector v can be decomposed into x axial velocity v x and y axial velocity v y . In the polar coordinate system, the velocity vector v can be decomposed into radial velocity v r and linear velocity v θ . It should be noted that the radial velocity v r only changes the magnitude of the velocity v without changing its direction, while the linear velocity v θ only changes the direction of the velocity v without changing its magnitude.
The mid-state is introduced into the Kalman filter to form the tracking filter algorithm MSKF, which is suitable for dealing with nonlinear problems. The algorithm steps are given as follows.
Initialization: Given the initial state estimate x ^ 0 and covariance matrix P 0 , set the time k = 1 .
Prediction: Assume that the input of filter in prediction step is the filtering result x ^ k and P k at time k , and obtain the state prediction result x ^ k + 1 | k and P k + 1 | k through the following formula:
x ^ k + 1 | k = F k x k
P k + 1 | k = F k P k F k T + Q k
State transformation: The predicted state vector x ^ k + 1 | k is converted to the mid-state x M k + 1 | k = [ z k + 1 | k , z ˙ k + 1 | k ] T , and the predicted covariance P k + 1 | k in the state space is converted to the covariance P M k + 1 | k in the measurement space according to the third-order spherical-radial criterion.
According to the geometric relation and velocity decomposition in Figure 1, the transformation relationship from state vector x ^ k + 1 | k = [ x k + 1 | k , v x k + 1 | k , y k + 1 | k , v y k + 1 | k ] T to mid-state vector x M k + 1 | k = [ r M k + 1 | k , r ˙ M k + 1 | k , θ M k + 1 | k , θ ˙ M k + 1 | k ] T is shown in the following formula:
{ r M k + 1 | k = x k + 1 | k 2 + y k + 1 | k 2 r ˙ M k + 1 | k = 1 r ( x k + 1 | k v x k + 1 | k + y k + 1 | k v y k + 1 | k ) θ M k + 1 | k = arctan ( y k + 1 | k x k + 1 | k ) θ ˙ M k + 1 | k = 1 r 2 ( x k + 1 | k v y k + 1 | k y k + 1 | k v x k + 1 | k )
The predicted covariance P k + 1 | k in the state space was converted to the covariance P M k + 1 | k in the measurement space according to the third-order spherical-radial criterion:
(1)
Obtain 2 n sampling points through x ^ k + 1 | k and P k + 1 | k :
{ w i = w i + n x = 1 2 n x ζ i = x ^ k + 1 | k + n x P k + 1 | k e i ζ i + n = x ^ k + 1 | k n x P k + 1 | k e i ,   i = 1 , 2 , , n x  
where e i represents the unit vector with the i -th element being 1.
(2)
The value of the sampling point after conversion is i = l ( ζ i ) ,   i = 1 , 2 , , 2 n x .
(3)
Then the covariance P M k + 1 | k in the intermediate states in the measurement space is:
c ¯ = i = 1 2 n w i i
P M k + 1 | k = i = 1 2 n w i ( i c ¯ ) ( i c ¯ ) T
The state transformation represents the target state transformation relationship under different coordinates. This module can be quickly replaced according to the actual situation without modifying the filter prediction and update module. This also improves the practical engineering applicability of the MSKF.
Update: The state estimation results x M k + 1 and P M k + 1 in the measurement space are obtained from the mid-states x M k + 1 | k and their covariance P M k + 1 | k .
S M k + 1 = H z P M k + 1 | k H z T + R k + 1
K M k + 1 = P M k + 1 | k H z S M k + 1 | k 1
x M k + 1 = x M k + 1 | k + K M k + 1 ( z k + 1 H z x M k + 1 | k )
P M k + 1 = ( I 2 m K M k + 1 H z ) P M k + 1 | k
where H z = [ I m 0 m × m ] is the observation matrix of the mid-state vector.
Extraction of state estimation: Obtain the state estimation x ^ k + 1 and P k + 1 at time k from the filtering results x M k + 1 and P M k + 1 in measurement space.
This process is the reverse process of state transformation. Therefore, the conversion relationship from the mid-state vector x M k + 1 = [ r M k + 1 , r ˙ M k + 1 , θ M k + 1 , θ ˙ M k + 1 ] T to the state vector x ^ k + 1 = [ x k + 1 , v x k + 1 , y k + 1 , v y k + 1 ] T is
{ x k + 1 = r M k + 1 cos θ M k + 1 v x k + 1 = v r M k + 1 cos θ M k + 1 v θ M k + 1 sin θ M k + 1 = r ˙ M k + 1 cos θ M k + 1 r M k + 1 θ ˙ M k + 1 sin θ M k + 1 y k + 1 = r M k + 1 sin θ M k + 1 v y k + 1 = v r M k + 1 sin θ M k + 1 + v θ M k + 1 cos θ M k + 1 = r ˙ M k + 1 sin θ M k + 1 + r M k + 1 θ ˙ M k + 1 cos θ M k + 1
At the same time, P k + 1 is obtained from P M k + 1 according to the third-order spherical-radial criterion.
The algorithm flow of the estimator is shown in Figure 2.

4. Nonlinear Filter Performance Evaluation

In order to better verify the performance of nonlinear filters, it is necessary to analyze and evaluate the filtering accuracy, credibility, stability, and other aspects of the filter which largely depend on reasonable evaluation metrics. In addition to the common evaluation metrics of state accuracy, such as root mean square error, this paper also deduces and gives the Cramér-Rao Low Bound iteration formula for nonlinear systems and analyzes the consistency of a filter by using a normalized error square.

4.1. Root Mean Square Error

Root Mean Square Error (RMSE) is widely used in performance comparison and evaluation of nonlinear filtering algorithms. It is based on the estimation error set obtained by the Monte Carlo simulation to evaluate the accuracy of the algorithm [18], defined as follows:
R M S E x = 1 N m l = 1 N m ( x ^ k | k l x k ) 2
where N m is the Monte Carlo simulation times, x ^ k | k l represents the estimation result of the target motion state at time k in the l -th Monte Carlo simulation, and x k is the actual state of the target. Although this metric has a definite physical meaning, it is easily dominated by considerable error values.

4.2. Cramér-Rao Low Bound for Nonlinear Systems

For nonlinear systems, the optimal Bayesian nonlinear filter is impossible [19], so there are many approximate suboptimal algorithms. They have a theoretical optimal performance lower bound called Cramér-Rao Low Bound (CRLB). It is not only a benchmark for performance analysis, but also can be used to design the parameters of a suboptimal algorithm. It has important theoretical and application value.
Literature [20,21] provides the CRLB iterative formula for discrete nonlinear systems, but it only provides the definition containing the expected operation without the final equations. Therefore, this paper deduces the CRLB for nonlinearity systems with Gaussian white noise.
For the nonlinear system in Equation (1), the unbiased estimate of the state x k is x ^ k and its covariance matrix is P k . The matrix should satisfy:
P k = E [ ( x ^ k x k ) ( x ^ k x k ) T ] J k 1
where J k = E [ 2 ln p ( x k , z k ) x k 2 ] known as the information matrix, J k 1 is the CRLB at time k . The iteration formula is
J k + 1 = D k 22 D k 21 ( J k + D k 11 ) 1 D k 12
Among them,
D k 11 = E [ 2 ln p ( x k + 1 | x k ) x k x k ] D k 12 = E [ 2 ln p ( x k + 1 | x k ) x k x k + 1 ] D k 21 = E [ 2 ln p ( x k + 1 | x k ) x k + 1 x k ] = [ D k 12 ] T D k 22 = E [ 2 ln p ( x k + 1 | x k ) x k + 1 x k + 1 ] + E [ 2 ln p ( z k + 1 | x k + 1 ) x k + 1 x k + 1 ]
If both the system noise v k and the measured noise w k are zero-mean Gaussian white noise and their covariance matrices are Q k and R k + 1 , respectively, then it can be obtained from the Formula (28):
ln p ( x k + 1 | x k ) x k = f k T ( x k ) x k Q k 1 [ x k + 1 f k ( x k ) ]
D k 11 = E { f k T ( x k ) x k Q k 1 [ x k + 1 f k ( x k ) ] [ x k + 1 f k ( x k ) ] T ( Q k 1 ) T [ f k T ( x k ) x k ] T } = E [ F ˜ k T Q k 1 F ˜ k ]
D k 12 = E [ F ˜ k T ] Q k 1 = [ D k 21 ] T
D k 22 = Q k 1 + E [ H ˜ k + 1 T R k + 1 1 H ˜ k + 1 ]
Defining F ˜ k = f k ( x k ) x k and H ˜ k + 1 = h k + 1 ( x k + 1 ) x k + 1 . The initial information matrix J 0 is the inverse of the initial state covariance matrix P 0 | 0 :
J 0 = P 0 | 0 1
Through the above derivation process, the CRLB provides the lower bound of the mean square error of unbiased estimation and gives the mean square error of an ideal nonlinear filter. In this paper, the RMSE curves of all filters are compared with the CRLB curves of the nonlinear model. The degree of approaching the CRLB curve reflects the accuracy and performance of the corresponding algorithm.

4.3. Normalized Estimation Error Squared

Normalized Estimation Error Squared (NEES) gives a more accurate quantitative evaluation of the consistency of the filtering algorithm. Literature [22] gives a relatively standard definition: for the confidence level α ( 0 α 1 ) , when the difference between the real error information and the error information calculated by the filter is not statistically significant, the filter can be considered to be consistent at the level α . The definition is as follows:
ε k = NEES = ( x k x ^ k | k ) T P k | k 1 ( x k x ^ k | k )
When P k | k is equal to the actual mean square error matrix, ε k follows the distribution χ 2 with degree of freedom n x , and n x is the state dimension. In this case, the consistency of state estimation is transformed into a χ 2 test problem. Most of the existing filter performance evaluation is based on the Monte Carlo simulation and the Arithmetic-mean Normalized Estimation Error Square (ANEES) using N m simulation results defined as follows:
ζ k = ANEES = 1 N m i = 1 N m ε k i n x = 1 N m n x i = 1 N m ε k i

5. Simulation

5.1. Problem Analysis

When the wide-band radar tracks a very long-range target, a typical problem caused by the measurement nonlinearity is the “Contact Lens” problem. It is directly related to the filter update process and is the leading cause of filter inconsistency and divergence.
The wide-band radar has high range accuracy and low angle accuracy when tracking very long-range targets. The uncertainty region of measurement will present a severe non-Gaussian distribution when the state in the Cartesian coordinate system is updated with nonlinear measurements from different coordinate systems. The uncertainty region presents a curved shape, similar to a banana shape in two dimensions and a contact lens shape in three dimensions. Therefore, this distribution is called the “Contact Lens” distribution and this kind of nonlinear problem is called the CL problem [23]. Figure 3 describes the reason for the uncertainty region of measurement from a geometric point of view. In the case of constant range accuracy, the range of cross-angle error R σ θ increases with the radar detection range. As it is far greater than the range error σ r , the uncertainty region of measurement gradually presents a curve. It should be noticed that in order to describe the distribution characteristics, the curve segment of constant thickness is used in Figure 3 to emphasize the overall curvature of the uncertainty region. However, the curvature of the actual space varies from place to place. The curvature is related to the probability of the measurement distribution at that point in the space. In Figure 4, the intensity of the color is proportional to the probability of the measurement distribution in the space.
Bar-shalom uses a parametric expression to describe the uncertainty region C L ( x ; r , σ r 2 , σ θ 2 ) , but he did not give the specific expression of the distribution. The bias significance metric is put forward to measure the degree of its distortion from a Gaussian distribution [24]:
β = r δ θ 2 2 δ r
where r is the distance from the target to the radar, δ θ 2 is the radar angle variance, and δ r 2 is the radar range variance. Figure 5 shows the measurement distribution characteristics corresponding to different values of β when the target is 500   km away from the radar. When β is small, the measurement distribution shows a typical Gaussian distribution and the traditional filter can track targets well. However, as the value increases, the nonlinear degree of measurement gradually increases. At this time, the nonlinear filters EKF and UKF will have consistency problems, resulting in the decrease of filtering accuracy and even the problem of filter divergence. This problem can be explained by theoretical analysis.
The EKF needs to linearize the measurement equation in Equation (10). Assume ( x , y ) is the position coordinate of the target relative to the Cartesian coordinate system with the radar as the origin. The vector ( x 0 , y 0 ) is an initial unbiased estimate of ( x , y ) with the covariance matrix P 0 . The range and angle observation model of the radar is r = ( x 2 + y 2 ) 1 / 2 + v r , θ = arctan ( y / x ) + v θ . Updating ( x 0 , y 0 ) with the measurement r and θ through the EKF, obtains a new estimate ( x e , y e ) with a covariance matrix P e . The EKF valuation equation is then expressed as
[ x e y e ] = [ x 0 y 0 ] + P e H 0 T R 1 [ r r 0 θ θ 0 ]
where
P e 1 = P 0 1 + H 0 T R 1 H 0
r 0 = ( x 0 2 + y 0 2 ) 1 / 2
θ 0 = arctan ( y 0 / x 0 )
H 0 = [ cos θ 0 sin θ 0 sin θ 0 / r 0 cos 0 0 / r 0 ]
R = [ σ r 2 0 0 σ θ 2 ]
Carrying out the matrix multiplication operation of Formula (37), we can get
[ x e y e ] = [ x 0 y 0 ] + P e [ cos θ 0 sin θ 0 ] [ ( r r 0 ) / σ r 2 ] + P e [ sin θ 0 cos θ 0 ] [ ( θ θ 0 ) / r 0 σ θ 2 ]
For high-resolution wide-band radar, P 0 1 R 1 , so P 0 1 can be ignored, then
P e H 0 1 R ( H 0 T ) 1
Thus,
[ x e y e ] [ x 0 y 0 ] + [ cos θ 0 sin θ 0 ] ( r r 0 ) + [ sin θ 0 cos θ 0 ] r 0 ( θ θ 0 )
From the above formula,
x e = r cos θ 0 r 0 ( θ θ 0 ) sin θ 0
y e = r sin θ 0 + r 0 ( θ θ 0 ) cos θ 0
Therefore, the following formula can be obtained:
r e = ( x e 2 + y e 2 ) 1 / 2
θ e = arctan ( y e / x e )
Assuming that ( r r 0 ) / r can be ignored, then the estimation error caused by the linearization of the measurement equation in EKF is
r e r r [ 1 + ( θ θ 0 ) 2 ] 1 / 2 r
θ e θ ( θ θ 0 ) + arctan ( θ θ 0 )
The above formula shows that when the target is far away from the radar, the estimation error may exceed the distance measurement error σ r , so the solution of the EKF will tend to diverge.
The UKF is a numerical method to calculate the statistical characteristics of random variables after nonlinear transformation. Its essence is to use multiple deterministic sampling points to approximate the Gaussian probability density function. However, in the CL problem, the probability distribution of measurement in the Cartesian coordinate system obviously cannot be approximated simply by Gaussian distribution, so the filtering accuracy of the UKF is poor. Figure 6 shows the error ellipse of the EKF and UKF estimation results which shows that the Gaussian distribution estimated by the two filters cannot cover the measurement distribution well, so the performance of the two filters is degraded or even divergent.
MSKF uses [ x k , x ˙ k , y k , y ˙ k ] T as the state vector as the prediction in Cartesian coordinates. The mid-state [ r , r ˙ , θ , θ ˙ ] is selected to make sure the update process is carried out in the measurement coordinates when updating. In the measurement space, the measurement distribution conforms to the Gaussian distribution assumption of the Kalman filter which ensures the consistency of the filter.

5.2. Simulations Results

The following two very long-range target tracking scenarios are designed for different radar performances:
(1)
r = 2700   km , δ r = 10   m , δ θ = 0.3 , β = 3.7 ;
(2)
r = 2700   km , δ r = 0.1   m , δ θ = 0.3 , β = 371
Figure 7 shows the measurement distribution of two simulation scenarios. Simulation scenario 1 uses narrowband radar to track very long-range targets. This is set according to the situation of missile target tracking by narrowband radar in engineering. The measurement distribution is Gaussian distribution. Simulation scenario 2 uses wide-band radar to track very long-range targets. In scenario 2, the typical CL problem occurs.
The experiment uses 100 Monte Carlo simulations, the initial target position is x 0 = 1050   km , y 0 = 2500   km , and the initial velocity is v x = 200   m / s , v y = 300   m / s . The traditional nonlinear filters EKF, UKF, and CKF are used for performance comparison simulation. The sampling time interval of the four filters is T = 0.1   s and the tracking time is 80   s . RMSE, CRLB theory, and consistency metric ANEES are used to test the filtering performance. The convergence speed of the filter is greatly related to the initial state, so the two-point starting method is adopted. The initial state and covariance are obtained by differentiating the two measurements at the first time and the second time.
Table 1 lists the range and velocity estimation RMSE of different filters in the tracking scenario (1) when the measurement uncertainty region is Gaussian distribution. In order to compare the computational complexity, the table also lists the Average State Estimation Time Consumption (ASETC) of different filters. It can be seen from Table 1 that the range measurement accuracy of the MSKF is similar to that of the UKF and CKF, which shows that the MSKF is also suitable for nonlinear target tracking in general. The angle measurement accuracy of the CKF and MSKF is higher than the EKF and UKF. The time cost of the MSKF is slightly higher than that of the other filters, but it increases the accuracy of radar angle measurement. In Table 2, the MSKF improves the angle measurement accuracy and achieves accurate tracking of a very long-range target compared with other filters. In summary, the MSKF can be used in various situations and, for special nonlinear scenarios, it can also effectively improve radar tracking accuracy.
Figure 8, Figure 9, Figure 10 and Figure 11 shows the simulation results of tracking very long-range targets with filters in scenario (2). At the time β = 371 , the uncertainty region of measurement is CL distribution. It can be seen from Figure 8 and Figure 9 that for very long-range targets, the measurement uncertainty region presents a severe non-Gaussian shape and the three filters except EKF can accurately track the target. In order to achieve the linear approximation of the system model, the EKF ignores the higher-order terms of Taylor’s expansion. Therefore, the EKF causes a significant error in the estimated state posterior distribution due to the truncation error. The UKF and CKF design a small number of deterministic sampling points and approximate the posterior probability of the state by calculating the statistical characteristics of these sampling points after passing through the nonlinear system so the target state is estimated accurately. For the tracking scenario (2), the angle estimation accuracy of the CKF is higher than that of the UKF. As shown in Table 2, the MSKF proposed in this paper has better filtering performance and higher target tracking accuracy than the CKF when the uncertainty region of measurement is CL distribution. Meanwhile, since the MSKF performs linear updates in the measurement space and is more affected by measures, the convergence speed of the MSKF is faster under the same two-point starting mode.
The state component estimation RMSE and theoretical performance lower bound CRLB is given in Figure 10. Due to the non-Gaussian measurement distribution, the initial RMSE of the four filters and CRLB are all large. As the iteration progresses, the UKF, CKF, and MSKF proposed in this paper gradually converge to steady-state, while the range accuracy of the EKF gradually diverges. The steady-state value indicates the approximation performance of the algorithm to nonlinear filtering. The convergence rate of RMSE represents the speed at which the algorithm finds the center of the non-Gaussian distribution. Figure 10a,b clearly show that the CKF and MSKF gradually converge to CRLB, and the MSKF has a faster convergence rate, a smaller steady-state value, and is closer to the theoretical boundary.
Figure 11 shows the ANEES distribution of the four filters. Since the consistency metric ANEES measures the difference between the real error and the estimated covariance matrix, the smaller the value, the better the consistency and the higher the robustness. It can be seen that the ANEES of EKF increases gradually, which means that the covariance matrix of the state vector increases gradually in the estimation process, eventually leading to the divergence. The ANEES of UKF gradually converges to a constant value, but its robustness is poor which leads to a significant estimation error. However, the ANEES of the CKF and MSKF gradually converge to achieve high-precision and stable target tracking. The MSKF has better state covariance estimation and higher robustness.

6. Conclusions

A typical nonlinear CL problem occurs when high-resolution wide-band radar tracks very long-range targets. To solve this problem, a novel mid-state Kalman filter is proposed in this paper. The MSKF uses the observed state and its first state derivative as the mid-state vector to transform the update process of the filter into the measurement space and rederives the update equation of the Kalman filter. The state transition module can be replaced according to the actual situation without modifying the filter prediction and update module. This improves the practical engineering applicability of the MSKF. When the CL problem occurs, the MSKF has the characteristics of high state estimation accuracy and fast filter convergence compared with other filters. This will significantly help the wide-band radar system to form the target trajectory quickly and accurately.

Author Contributions

Conceptualization, Z.L. and Y.C.; methodology, Z.L.; validation, Z.L.; formal analysis, Z.L. and Y.C.; investigation, Z.L.; resources, Y.L.; data curation, Z.L.; writing—original draft preparation, Z.L.; writing—review and editing, Y.C. and Y.L.; visualization, Y.C.; supervision, Y.L.; project administration, Y.L. All authors have read and agreed to the published version of the manuscript.

Funding

This research received no external funding.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

The data presented in this study are available on request from the corresponding author.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Liu, M.; Lan, J. Frontier Theory and Application of Target Tracking; Science Press: Beijing, China, 2015. [Google Scholar]
  2. Yan, G. Strapdown Inertial Navigation Algorithm and Integrated Navigation Principle; Northwestern Polytechnical University Press: Xi’an, China, 2019. [Google Scholar]
  3. Lv, D.; Wang, J.; Xiong, K. Strong tracking Kalman filter for non-Gaussian observation. Control Theory Appl. 2019, 36, 1997–2004. [Google Scholar]
  4. Lu, X.; Hu, B.; Li, K.; Dai, Y. Comparative Research on Nonlinear Target tracking Filtering Algorithms. Fire Control Command Control 2021, 46, 24–30. [Google Scholar]
  5. Valipour, M.; Ricardez-Sandoval, L.A. Abridged Gaussian sum extended Kalman filter for nonlinear state estimation under non-Gaussian process uncertainties. Comput. Chem. Eng. 2021, 155, 107534. [Google Scholar] [CrossRef]
  6. Wang, Q.; Sun, X.; Wen, C. Design Method for a Higher Order Extended Kalman Filter Based on Maximum Correlation Entropy and a Taylor Network System. Sensors 2021, 21, 5864. [Google Scholar] [CrossRef] [PubMed]
  7. Liu, M.; Gao, S.; Li, W.; Xie, B. Modified Iterative Extended Kalman Filter Based on State Augmentation. Appl. Electron. Tech. 2020, 46, 79–81, 88. [Google Scholar]
  8. Ito, K.; Xiong, K. Gaussians filters for nonlinear filtering problems. IEEE Trans. Autom. Control 2000, 45, 910–927. [Google Scholar] [CrossRef] [Green Version]
  9. Gao, B.; Hu, G.; Gao, S. Multi-sensor optimal data fusion based on the adaptive fading unscented Kalman filter. Sensors 2018, 18, 488. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  10. Arasaratnam, I.; Haykin, S. Cubature Kalman Filter. IEEE Trans. Autom. Control 2009, 54, 1254–1269. [Google Scholar] [CrossRef] [Green Version]
  11. Yang, F.; Luo, Y.; Zheng, L. Double-Layer Cubature Kalman Filter for Nonlinear Estimation. Sensors 2019, 19, 986. [Google Scholar] [CrossRef] [Green Version]
  12. Garcia, R.V.; Pardal, P.; Kuga, H.K. Nonlinear filtering for sequential spacecraft attitude estimation with real data: Cubature Kalman filter, unscented Kalman filter and extended Kalman filter. Adv. Space Res. 2018, 63, 1038–1050. [Google Scholar] [CrossRef]
  13. Zhang, A.; Bao, S.D.; Gao, F. A novel strong tracking cubature Kalman filter and its application in maneuvering target tracking. Chin. J. Aeronaut. 2019, 32, 2489–2502. [Google Scholar] [CrossRef]
  14. Fan, Z.E.; Weng, S.Q.; Jiang, J. Particle filter object tracking algorithm based on sparse representation and nonlinear resampling. J. Beijing Inst. Technol. 2018, 27, 51–57. [Google Scholar]
  15. Davis, B.; Blair, W.D. Adaptive Gaussian mixture modeling for tracking of long-range targets. In Proceedings of the IEEE Aerospace Conference, Big Sky, MT, USA, 5–12 March 2016; pp. 1–9. [Google Scholar]
  16. Davis, B.; Blair, W.D. Gaussian mixture approach to long-range radar tracking with high range resolution. In Proceedings of the IEEE Aerospace Conference, Big Sky, MT, USA, 7–14 March 2015; pp. 1–9. [Google Scholar]
  17. Ge, B.; Zhang, H.; Jiang, L.; Li, Z.; Butt, M.M. Adaptive Unscented Kalman Filter for Target Tracking with Unknown Time-Varying Noise Covariance. Sensors 2019, 19, 1371. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  18. Li, X.; Zhao, Z. Evaluation of Estimation Algorithms Part I: Incomprehensive Measures of Performance. IEEE Trans. Aerosp. Electron. Syst. 2006, 42, 1340–1358. [Google Scholar] [CrossRef]
  19. Jeong, P.; Sergiu, N. Efficient and Robust Classification Method Using Combined Feature Vector for Lane detection. IEEE Trans. Circuits Syst. Video Technol. 2005, 15, 528–537. [Google Scholar] [CrossRef]
  20. Zhang, J.; Zhan, R. Posterior Cramer-Rao Bounds Analysis for Passive Target Tracking. J. Syst. Eng. Electron. 2008, 19, 27–32. [Google Scholar] [CrossRef]
  21. Wang, Z.; Shen, X. Posterior Cramer-Rao Bounds for Discrete-Time Nonlinear Filtering with Finitely Correlated Noises. In Proceedings of the Chinese Control Conference, Hangzhou, China, 28–30 July 2015; pp. 4541–4546. [Google Scholar]
  22. Li, X.; Zhao, Z.; Li, X.-B. Evaluation of Estimation Algorithms: Credibility Tests. IEEE Trans. Syst. Man Cybern.-Part A Syst. Hum. 2012, 42, 147–163. [Google Scholar] [CrossRef]
  23. Tian, X.; Bar-Shalom, Y.; Chen, G.; Blasch, E.; Pham, K. A Novel filtering approach for the general contact lens problem with range rate measurements. In Proceedings of the International Conference on Information Fusion, Edinburgh, UK, 26–29 July 2010; pp. 1–8. [Google Scholar]
  24. Lerro, D.; Bar-Shalom, Y. Tracking with debiased consistent converted measurements versus EKF. IEEE Trans. Aerosp. Electron. Syst. 1993, 29, 1015–1022. [Google Scholar] [CrossRef]
Figure 1. Velocity decomposition.
Figure 1. Velocity decomposition.
Sensors 22 01302 g001
Figure 2. The algorithm flow of the MSKF.
Figure 2. The algorithm flow of the MSKF.
Sensors 22 01302 g002
Figure 3. The CL Problem of Nonlinear Measurement.
Figure 3. The CL Problem of Nonlinear Measurement.
Sensors 22 01302 g003
Figure 4. The non-Gaussian CL error distribution.
Figure 4. The non-Gaussian CL error distribution.
Sensors 22 01302 g004
Figure 5. Measurements Distribution: (a) β = 0.02 ,   C L ( x ; 200   km , ( 10   m ) 2 , ( 0.001   rad ) 2 ) and (b) β = 2 ,   C L ( x ; 200   km , ( 0.1   m ) 2 , ( 0.001   rad ) 2 ) .
Figure 5. Measurements Distribution: (a) β = 0.02 ,   C L ( x ; 200   km , ( 10   m ) 2 , ( 0.001   rad ) 2 ) and (b) β = 2 ,   C L ( x ; 200   km , ( 0.1   m ) 2 , ( 0.001   rad ) 2 ) .
Sensors 22 01302 g005
Figure 6. Measurement Distribution and the filter estimation error ellipse.
Figure 6. Measurement Distribution and the filter estimation error ellipse.
Sensors 22 01302 g006
Figure 7. Measurements Distribution: (a) β = 3.7 ,   C L ( x ; 2700   km , ( 10   m ) 2 , ( 0.3 ) 2 ) and (b) β = 371 ,   C L ( x ; 2700   km , ( 0.1   m ) 2 , ( 0.3 ) 2 ) .
Figure 7. Measurements Distribution: (a) β = 3.7 ,   C L ( x ; 2700   km , ( 10   m ) 2 , ( 0.3 ) 2 ) and (b) β = 371 ,   C L ( x ; 2700   km , ( 0.1   m ) 2 , ( 0.3 ) 2 ) .
Sensors 22 01302 g007
Figure 8. Range estimation accuracy of CL distribution.
Figure 8. Range estimation accuracy of CL distribution.
Sensors 22 01302 g008
Figure 9. Angle estimation accuracy of CL distribution.
Figure 9. Angle estimation accuracy of CL distribution.
Sensors 22 01302 g009
Figure 10. Comparison of state component RMSE and CRLB of CL distribution: (a) RMSE in X position; (b) RMSE in Y position; (c) RMSE in X speed; and (d) RMSE in Y speed.
Figure 10. Comparison of state component RMSE and CRLB of CL distribution: (a) RMSE in X position; (b) RMSE in Y position; (c) RMSE in X speed; and (d) RMSE in Y speed.
Sensors 22 01302 g010
Figure 11. Comparison of ANEES of CL distribution.
Figure 11. Comparison of ANEES of CL distribution.
Sensors 22 01302 g011
Table 1. Different filtering accuracy and time consumption in scenario (1).
Table 1. Different filtering accuracy and time consumption in scenario (1).
FilterRange RMSE/mAngle RMSE/°ASETC/s
EKF2.4870.22240.0295
UKF2.5060.09860.0450
CKF2.5020.02660.0426
MSKF2.5980.02080.0691
Table 2. Different filtering accuracy and time consumption in scenario (2).
Table 2. Different filtering accuracy and time consumption in scenario (2).
FilterRange RMSE/mAngle RMSE/°ASETC/s
EKF1.670017.77000.03155
UKF0.09561.27300.04779
CKF0.11390.19770.04578
MSKF0.09260.07810.07162
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Liu, Z.; Chen, Y.; Lu, Y. Mid-State Kalman Filter for Nonlinear Problems. Sensors 2022, 22, 1302. https://doi.org/10.3390/s22041302

AMA Style

Liu Z, Chen Y, Lu Y. Mid-State Kalman Filter for Nonlinear Problems. Sensors. 2022; 22(4):1302. https://doi.org/10.3390/s22041302

Chicago/Turabian Style

Liu, Zhengwei, Ying Chen, and Yaobing Lu. 2022. "Mid-State Kalman Filter for Nonlinear Problems" Sensors 22, no. 4: 1302. https://doi.org/10.3390/s22041302

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