The Higher Order Unscented Filter

You might also like

Download as pdf or txt
Download as pdf or txt
You are on page 1of 6

The Higher Order Unscented Filter

Dirk Tenne Tarunraj Singh


Graduate Student Associate Professor
Department of Mechanical & Aerospace Engineering,
State University of New York at Buffalo
http://code.eng.buffalo.edu

Abstract ical Jacobian of the EKF with numerically evaluated


divided differences (DDF). The Gaussian filter applied
This article proposes a technique for the selection of by It0 et al. 161 numerically integrates the predictor
the g-set for a probability distribution approximation step and Yields, depending on the integration scheme,
filter, the unscented filter. The a-set is selected i.e. central difference filter (CDF), results similar to the
so as to capture the higher order input The DDF. However, Ito states that the Gauss-Hermite rule
Taylor series expansion is used to illustrate that the outperforms the CDF. Emulating a Monte Carlo sim-
3rd order and higher statistics of the nonlinear trans- ulation, Julier and Uhlman [2] perform the prediction
formation can be reproduced while the unscented filter of the with a set Of chosen
points.
captures the statistics up to the 3rd order only. Two
benchmark problems are used to corroborate the pro- On the other hand, research has focused on the up-
posed solution. date equation (essentially Bayes’ rule), which is opti-
mal when one has perfect knowledge of the pdf. The
particle filter (PF) represents the required pdf’s by a fi-
1 Introduction nite sum based on samples (or particles) drawn from an
assumed distribution [3, 7, 8, 91. Difficulties arise with
the selection of the proposal distribution, which can be
Recently, there has been an increasing interest in the
simplified by combining the unscented filter (or EKF)
development of techniques for nonlinear estimation,
with the particle filter as shown by van der Merwe
which can approximate the statistics of the process as
et al. [SI. The U K F generates approximations of the
accurately as possible [I,2, 31.
prior distribution with adjustable accuracy. Challa
The process of state estimation combines a priori and Bar-Shalom [lo]numerically propagate the prior
knowledge about the state and its transition due to a pdf through the Fokker-P1anck-Kolmo~orov equation,
set of inputs, with a sequence of measurements. G ~ ~ -where the negligible tails of the distribution are identi-
erally, the state estimate is recursively obtained in two fied by Chebyshev’s inequality. Although this approach
stages: (i) the prediction and (ii) the update. The well solves the optimal estimator, its computational efforts
known optimal state estimator utilizes the analytical are large ‘Ompared to any Of the approaches, which
probability density function (pdf) to predict the states the Monte simulations.
using the total probability theorem and subsequently
The probability distribution approximation filter
uses the measurement to update with Bayes’ rule [4].
(PDAF) termed unscented Filter by Uhlman and
Since this optimal estimator requires storing the pdf
Julier [a] has been developed in the context of state
and integrating it, often resulting in impractical algo-
estimation of dynamic systems, for example fast mov-
rithms, techniques have been developed to approximate
ing robots. Initial application to parameter estimation
the Optima’ estimator‘ A Of such
of this technique has been proposed by van der Merwe
as the extended Kalman (EKF)’ divided differ- and Wan 181. The unscented filter carefully selects a
ence filter (DDF), unscented Kalman filter (UKF) etc.,
set of stencils called the g-set, which exhibits the same
focus on approximating the prediction probability char-
statistical properties (mean, moments) to a certain de-
acteristics and use the standard linear minimum mean
gree as the true distribution of the state. The U-set is
square error estimator. The EKF uses first order Tay-
propagated through the state equations and the statis-
lor series, which can be improved by higher order ap-
tics of the predicted state are the result of a weighted
proximations [5]at the cost of computational efficiency.
sum, which agrees up to the second order of the Tay-
Norgaard et al. [l]exploited polynomial interpolations
lor series of the true mean and covariance. Julier’s [ll]
of the nonlinear transformations replacing the analyt-
skewed approach also captures the third order subop-
timal. The proposed technique modifies the selection
Proceedings of the American Control Conference
0-7803-7896-2/03/$17.0002003 IEEE 2441 Denver, Colorado June 4-6, 2003
of the o-set to arrive at a design space capable of ap- and the estimate of the mean and variance of Y is ob-
proximating higher order input moments and thus ap- tained by the same weighting scheme:
proaching the true mean and covariance. 2n

2n
2 The Unscented Filter
i=O
Consider a nonlinear transformation of the random
variable X with mean 2 and variance P, where the weights remain the same as for matching the
input moments, equations 7 and 8.

where we would like to approximate the statistics of the 3 The Higher Order Unscented Filter
transformed random variable Y , for example the mean
and variance. Note, that this paper improves on the It is a well known fact that the Unscented Filter de-
approximation of the statistics of the aformentioned scribed by equations 12, 13 exhibits an accuracy in es-
transformation, which can be seen as the prediction timating the statistical characteristics up to the second
algorithm of the state estimation. moment. This has been achieved by selecting a a-set
resembling the input statistics. By utilizing the Taylor
+
The unscented filter selects a o-set consisting of 2n 1
series expansion it can be shown that the transformed
points, which are perturbations from the mean by a
statistics match the covariance up to the third order,
scaled deviation. The deviations oi are defined as the
i.e. errors are introduced at the fourth and higher or-
columns of the matrix square root of P, [2].
ders [2].

o= (2) Since the higher order terms of the Taylor series con-
sist of a combination of higher order moments, it is es-
The 0-set is defined as: sential to correctly estimate these moments to achieve
an increase in the performance of the estimator. Ap-
pendix A shows the derivation of the Taylor series ex-
pansion. The following section introduces an algorithm
matching higher order moments of the input.The per-
such that the a-set exhibits the same probabilistic char- formance increase is illustrated on a simple example.
acteristics as the random variable X and K. is a free
variable of the unscented filter. The weighting scheme The higher order unscented filter (HOUF) remains the
same structure as the original unscented filter. The
HOUF consists of an augmented o-set with separate
weights. The new o-set can be constructed as follows:
CO = x (14)
<i = CO + oi (15)
for oi = &GI,3 ~ 2 , . .. ,*om ,
where m = n f q is the augmented dimension and q is
the number of additional U points. The statistical prop-
erties of the a-set are defined by the weighted sums:
2m
has been selected to match the first four central mo-
ments of X, i.e. f = Cwi<i (16)
i=O
- 2m
Px=Pc
2=(
p.”,= p: = 0 p: = pt
(9)
(10)
p; = CW&
i=O
-f)j (17)

which is true for all Gaussian random variables if K. is where and p i represent the mean and the jth central
+
selected to satisfy the constraint, n K = 3. moment.

The o points are transformed by the nonlinear relation- 3.1 2-0 HOUF
ship The statistics of the o-set are selected to match the
vi = g [ < i , t ] for i = 1 . .. 2 n (11) statistics of the input X.This procedure is exemplified
Proceedings of the American Control Conference
2442 Denver, Colorado June 4-6, 2003
for the HOUF with two cr's, (TI and 172. Expanding where X is a zero mean Gaussian random variable with
equations 16 and 17 up to the eighth central moment, variance P,. It is a well known fact that the trans-
yields the following relationships: formed random variable Y is non-Gaussian and its odd-
order moments are non-zero. A Monte Carlo (MC)
1 = WO + 2Wl+ 2w2 simulation with 25 million samples has been performed
P, = 2(" + IE,(WlU1" + w 2 a 3 and the resulting moments are shown in Table 1 along
CL: = 0 with the estimates of the Higher Order Unscented Fil-
CL2 = 2(m + IE)2(w,cril + 21124)
ter and the standard Unscented Filter (UF). The pa-
rameters for the HOUF are derived from equation 21
CL: = 0 and listed in Table 2. We arrive at two solutions, which
PI6 = 2(m + +
I E ) ~ ( w ~ (w
T2~4 ) in turn are identical since the indices are swapped, i.e.
7 (TI becomes n2 and vice versa, etc. Observing Table 2,
PI = 0
Pz
8
= 2(m + I E ) ~ ( w ~ o+: w 2 4 ) ,
where pk is the ith central moment of X. With the
C1 g2 WO w1 w2 K.
knowledge of the input moments we are able to solve
1.6495 0.7827 0.5333 0.0113 0.2221 1
for the cr points oi,the weights wi and IE. The general
0.7827 1.6495 0.5333 0.2221 0.0113 1
solution becomes rather difficult to present and one has
to decide on a case by case basis about possible simpli-
fications. The following transformation of the weights the even order moments of the transformed random
and the requirement of the standard unscented filter variable 2 remain the same as the input X , whereas
m + IE = 3 lead t o an amenable solution in the partic- the odd order moments change significantly. The UF
ular case of Gaussian moments. matches the MC's even order moments up to the fourth
order, while the odd order moments differ. The HOUF
w; = 2(m + IE)Wl w; = 2(m + K)W2 (19) closely approximates the even and odd order moments
of the MC simulation up to the eights order moment.
The equations 18 can be rewritten as:
For greater clarity, we expand the above example to a
problem with known analytical solution. Let the ran-
dom variable Y describe the distance of a particle above
a barrier (121. The particle at the initial position zois
traveling with a velocity of W O , then the distance from
the barrier is given as:

y = 1x0 + wotl . (23)


yielding a set of 5 equations for the 5 unknown param- Now, let the initial position zo be a Gaussian dis-
eters. tributed random variable with unit variance P, and
zero mean such that
In contrast to the unscented filter, which assumes the
same weights wi for all [i for i > 0, solving equations 20 y = 9 ( X , t ) = 1x1 1 (24)
requires two independent weights wl and w2. Employ-
ing an analytical solver, a solution can be obtained in where X = N(vot,l) is a Gaussian random variable
the following form: with a time varying mean. The distance of the particle
exemplifies a function with varying level of nonlinear-
=
ity since for a larger distance of the particle from the
U:: (21a) barrier the transformation becomes almost linear, i.e.
10 Y = X and only the tails of the Gaussian distributed
cr; = -P, - a; (21b) X are effected by the nonlinear transformation. The
3
analytical solutions of the mean and variance can be
1 2 1 4 - 55Pz
w1 = -
60 3 4 - 5 P X
(21c) derived with standard procedures of probability the-
ory, which are:
-1 3PX(0?- P,)
w2 = (214
3 ( 3 4 - Pz)(.,2 - a?) jj = E { Y } = voterf(-
WO = 1- 2 ( W l + w2) We)
Py= E { (Y- jj)2} = P, + (vat)' - j j 2 . (26)
For example, consider the nonlinear transformation:
The goal is to estimate the mean jj and the variance
z=1x1 7 (22) Pv as accurately as possible as a function of the n-set
Proceedings of the American Control Conference
2443 Denver, Colorado June 4-6, 2003
P3,= 1 Moments
a1 a2 a3 a4 (35 a6 a7 08

MC 0.7980 1.0005 1.5971 3.0035 6.3926 15.0283 38.2514 104.8600


UF 0.5774 1.0000 1.7321 3.0000 5.1962 9.0000 15.5885 27.0000
HOUF 0.6667 1.0007 1.6335 3.0056 6.3351 15.0467 38.8505 105.3871

tion, which is the result of matching the higher order


moments.

3.2 3-U H O U F
The performance of the HOUF depends on the num-
ber of auxiliary a’s, where a larger a-set should better
approximate the true solution. The expansion to 3 CT’S
enables the HOUF to match up to the twelfth order
moment. Solving an expanded set of equations simi-
lar to equations 20, yields the parameters, which are
shown in Appendix B. Figure 3 compares the true so-
lution with the HOUF for 2 and 3 a’s for the particle
above a barrier example. It can be seen that 3-a HOUF
I
2 1 0
“0‘
1 2 3 approaches the true solution.

Figure 1: Optimal solution minimizing the mean and vari-


ance error 4 Conclusion

and the weights wi. The optimal solution is obtained The unscented filter by Uhlman and Julier [2] matches
by constructing a cost function consisting of the square up to the fifth order moment of the input variable (as-
error of the mean and variance estimate. suming a Gaussian distribution), whereas the trans-
formed covariance introduces errors at the fourth and
) (g - f j ) 2
J(ai,~i= + (P, - PV)’ (27) higher orders of a Taylor series expansion. The higher
order unscented filter is capable of matching any desir-
The cost function J ( a i ,wi) can be minimized for the able input moment by selecting a modified a-set. This
unscented filter (equations 12, 13) with respect to the results in a higher order approximation of the trans-
design variables 01 and w1, where W O = --&and formed covariance. This has been shown on an example
+
n K = 3 has been assumed. The numerically de- with variable degree of nonlinearity, i.e. the distance
termined optimal al and w1 are shown in Figure l for of a particle above a barrier.
a time varying mean vot within the interval [-3 31.
The “jumps”, for example at vot = 1.3, result from the The improved approximation of the transformed mean
selected nonlinear function, the absolute value, which and covariance can be utilized in dynamic estimations
is part of the weighted sequence in equations 12 and such as Kalman filtering. With the assumption of
13. Furthermore, the suggested a-set and weights by Gaussian distribution of the state throughout its prop-
Uhlman and Julier [2] are illustrated by the dashed agation the HOUF can approximate the mean and co-
lines. The optimal solution approaches Uhlman’s a-set variance with adjustable accuracy. On the contrary,
as the input mean increases and the influence of the a larger a-set increases the computational load, which
nonlinearity vanishes. leads to a trade-off depending on the nonlinear trans-
formation. As we have seen from the aforementioned
Figure 2 shows the analytical mean and deviation, i.e. example, after one transformation the Gaussian as-
the square root of the variance, for a time varying mean sumption does not hold and odd order central mo-
of the input X . The optimal solution (Figure 1) closely ments are generated. Based on the characteristics of
matches the analytical solution. Both unscented filters the nonlinear function it might be desirable to track
reasonably approximate the mean of the particles dis- higher order moments, which can be approximated by
tance, whereas the HOUF better describes its devia- the HOUF after slight modification of the matching
Proceedings of the American Control Conference
2444 Denver, Colorado June 4-6, 2003
1

c
m
09

f 08
5
$07

06
-3 -2 1 0 I 2 3
'0'

Figure 3: Comparison of 2- and 3-U HOUF

Hugh F. Durrant-Whyte. New approach for filtering


nonlinear systems. In ACC, volume 3, pages 1628-
I
0 5'
-3 -2 1 0 1 2 3 1632, 1995.
vo'

(a) Mean distance above the barrier [3] N.J. Gordon, D.J. Salmond, and A.F.M. Smith.
Novel approach to nonlinearlnon-gaussian bayesian
state estimation. IEE Proc. on Radar & Signal Pro-
cessing, 140(2):107-113, Apr. 1993.

[4] Yaakov Bar-Shalom and Thomas E. Fortmann.


Tracking Data and Association. Academic Press, Inc.,
1988.

[5] Mohinder S. Grewal and Angus P. Andrews.


Kalman Faltering-Theory and Practice. Prentice Hall
Information and System Sciences Series, 1993.

[6] Kazufumi Ito and Kaiqi Xiong. Gaussian filters


for nonlinear filtering problems. IEEE Trans. on Au-
J
041
-3 -2 1 0 I 2 3 tomatic Control, 45(5):910-927, May 2000.
"0'

(b) Variance of the distance above the barrier [7] A. Doucet, N. de F'reitas, and N. Gordon. Se-
quential Monte Carlo Methods in Practice. New York:
Figure 2: Deviation of the distance of a particle above a Springer-Verlag, Jan. 2001.
barrier
[8] Rudolph van der Merwe, Arnaud Doucet, Nando
equations. de Freitas, and Eric Wan. The unscented particle filter.
Technical Report CUED/F-INFENG/TR 380, Cam-
The HOUF derived in this paper currently applies to bridge University Engineering Department, Aug. 2000.
one dimensional systems, but its algorithm is amenable
to address multi-dimensional extensions. [9] Sanjeev Arulampalam,.Simon Maskell, Neil Gor-
don, and Tim Clapp. A tutorial on particle filters for
online nonlinearlnon-gaussian bayesian tracking. IEEE
Trans. on Signal Processing, 50(2):174-188, Feb. 2002.
Acknowledgments
[lo] S.Challa and Y . Bar-Shalom. Nonlinear filter de-
This research has been supported by the Center sign using Fokker-Planck-Kolmogorov probability den-
for Multisource Information h s i o n (CMIF) and the sity evolutions. IEEE Trans. on Aerospace and Electr.
Calspan/UB Research Center (CUBRC). Systems, 36(1):309-315, Jan. 2000.

[ll] Simon J. Julier. A skewed approach to filtering.


In Signal and Data Processing of Small Targets, volume
References
3373, pages 271-282. SPIE, 1998.
[I] Magnus Norgaard, Niels K. Poulsen, and Ole
Ravn. New developments in state estimation for nonlin- [12] James R. van Zandt. A more robust unscented
ear systems. Automatics, 36(11):1627-1638, Nov. 2000. transform. Technical report, MITRE Corporation,
[2] Simon J. Julier, Jeffrey K. Uhlmann, and http://www.mitre.org, July 2001.
Proceedings of the American Control Conference
2445 Denver, Colorado June 4-6, 2003
A The Taylor Series Expansion

Describing the nonlinear transformation of equation 1


via a Taylor series about the mean X ,we have:

+ ... (28)
The mean and variance of the transformed random
variable can be determined by taking expectations of
the Taylor series

E{Yl
1 d2g 1 d3g
g(X) + -2!dx2
-P, + -3!dx
7 E { A X 3 } + ...
(29)
E { (Y - V,”}

[(g)2--
(
i

,

.
] 2 ! dx2 Px+

d3
3! dx2 dx3 (30)

It is evident that the Taylor approximation of the mean


and variance depends on the higher order moments of
the input X.

B 3-(THOUF optimal Parameters

Employing an analytical solver to the expanded set of


equations 20, a solution for the optimal (T set can be ob-
tained by sequentially solving the following three equa-
tions.

39”. +
- 6 3 P , ~ ; 105P:~:- 35P: = 0 (31)
3 ( ~ ~ + ( 3 ~ ~ - 2 1 P , ) ( ~ ~ - 2 1 P ~ ( ~=~0+(32)
3~~+35P~
cl; + +
U; 03” - 7Px = 0 (33)
The closed form solution of the weights is:

w1 =
(126P: +1 8 ~ : 72a$PX- 5 4 ~ , ” P 2 ) -
- ( ~567P:
: + + +
9SP:u,Z 6 6 6 P : ~ i 2 7 ~ -
: 270(~,6P,
54(T3$(oT - a;)(a; - a;)((T;- a?)
(34)
5P2 - 3 P Z 4 - 3Pxu,”+ 3 u : 4
w2 = (35)
18a,”(aT- (T,”)((T,”- u;)

Proceedings of the American Control Conference


2446 Denver, Colorado June 4-6, 2003

You might also like