Density morphing and mode propagation for Bayesian filtering

Information

  • Patent Application
  • 20050038638
  • Publication Number
    20050038638
  • Date Filed
    July 22, 2004
    20 years ago
  • Date Published
    February 17, 2005
    19 years ago
Abstract
A system and method for modeling a dynamic system using Bayesian filtering, includes a prediction module to predict a state model of the dynamic system, the prediction module generates a prediction density having at least one mode, the state model includes a conditional density function including at least one kernel. Approximating module approximates a measurement probability from a sample set through at least one kernel and an update module updates the conditional density function using the measurement probability and the prediction density. A mode finding and mixture reduction module reduces the number of kernels in the conditional density function.
Description
TECHNICAL FIELD

The present invention relates to statistical signal processing and more particularly to sequential Bayesian filtering using density morphing and mode propagation.


BACKGROUND

Some areas of computational research such as real-time machine vision, speech recognition, real-time object tracking, etc., provide a complex challenge to an application designer. For example, in an object-tracking application the complexity of the system increases due to the random nature of the captured image data. For example, using machine vision to track a live person in a given environment would require complex processing of captured image data concerning the person and the environment around such person. Hence, researchers have applied probabilistic and numerical techniques to deal with complex systems with stochastic nature in the field of system dynamics and measurements.


Dynamic system tracking applications typically use estimations for determining changes in the dynamic system states over time. Dynamic states are generally modeled using discrete time approach where measurements are made available at discrete time intervals. Typically, two models—a system model, which evaluates the evolution of the system states over time and a measurement model that links noisy measurements to states—are required.


It is possible to apply several state estimation techniques using the dynamic and measurements model. One such estimation technique uses a Bayesian approach. Typical statistical methods include Kalman-Bucy filtering and Particle filtering. Kalman-Bucy filtering provides minimum-mean-squared-error state estimations only for linear stochastic systems with Gaussian initial condition on the state and Gaussian noise, For nonlinear stochastic systems or stochastic systems involving non-Gaussian random variables, particle filtering provides a numerical solution to the state estimation over time. Particle filtering is described next.


Using importance sampling, particle filtering tracks the evolution of state variable with respect to time by probability density functions (PDF) with a set of weighted samples. Several variables may be of interest in a given application. For example, in an object tracking machine vision application, the variables of interest could be the object's position, the temperature, velocity, shape, etc. For each variable, samples in the state spaces are considered to be particles, where each of them has a weight that signifies its probability. Particle filtering is used to estimate the states of such variables by recursively applying predictions and updates to the particle set.


While conventional particle filtering has become a popular technique for dynamic tracking applications, it has several drawbacks. Real-world applications typically involve nonlinear stochastic systems with a high-dimensional state space. However, particle filtering technique becomes inefficient and impractical when the dimension of the state space is high, where an inhibitively large number of samples need to be tracked. Efficient sampling in high-dimensional space is very difficult. Sample degeneracy and sample impoverishment are common issues associated with particle filtering. Hence, there is a need for a technique that provides better filtering performance by avoiding problems associated with particle filtering.


SUMMARY

A system and method for analyzing dynamic systems with linear or nonlinear dynamic models by using Bayesian filtering. The system performs prediction over a state model of the dynamic system to generate a prediction density that has one or multiple modes. The system approximates a function of a measurement probability and prediction density. An update module updates the conditional density function using the measurement probability (i.e. likelihood function) and prediction density. A mode finding and mixture reduction process reduces the number of kernels to achieve mode propagation. The system maintains, over a time span, analytic representations in the form of mixtures of kernels for prior density functions, prediction density functions, measurement likelihood function and posterior density functions.


Density morphing can be performed to track the evolution of the density function of the state distribution over time. A prediction module can be configured to apply an unscented transformation on a prior probability density function of a prior state model of the dynamic system. The update module can then generate a continuous function to approximate measurement likelihood. A density morphing module tracks density evolution over the time and reconstructs the continuous function from sparse samples. The density morphing module propagates continuous density functions over time and maintains analytic representations in the form of mixtures of kernels for representing the density functions.


The number of mixtures generated during the update as a part of the recursive prediction-update iterations can be reduced by approximating densities near the modes by using Gaussian components with predetermined bandwidths.


Further, incremental sampling and interpolation can be used to approximate the measurement likelihood and the posterior PDF. Bandwidth of the kernels can be data-driven, i.e., determined by the local density of the sample distribution. Posterior probability density function can be generated by a product of the reconstructed continuous likelihood functions and predicted density. Throughout the recursive process of filtering, the intermediate density functions can be maintained in the form of mixtures of kernels.




BRIEF DESCRIPTION OF DRAWINGS

Preferred embodiments of the invention are described with reference to the accompanying drawings, of which:



FIG. 1 is a flow-chart for a mode propagation algorithm in an embodiment of the present invention;



FIG. 2A is a first stage in a first simulation in an embodiment of the present invention;



FIG. 2B is a second stage in a first simulation in an embodiment of the present invention;



FIG. 2C is a third stage in a first simulation in an embodiment of the present invention;



FIG. 2D is a fourth stage in a first simulation in an embodiment of the present invention;



FIG. 2E is a fifth stage in a first simulation in an embodiment of the present invention;



FIG. 3A is a first stage in a second simulation in an embodiment of the present invention;



FIG. 3B is a second stage in a second simulation in an embodiment of the present invention;



FIG. 3C is a third stage in a second simulation in an embodiment of the present invention;



FIG. 3D is a fourth stage in a second simulation in an embodiment of the present invention;



FIG. 3E is a fifth stage in a second simulation in an embodiment of the present invention;



FIG. 4 is an exemplary computer system used in an embodiment of the present invention.




DETAILED DESCRIPTION OF PREFERRED EMBODIMENTS

The preferred embodiments of the present invention will be described with reference to the appended drawings.


Bayesian filtering has been used for a number of applications including computer vision. In vision applications, the object or event of interest can be modeled by a dynamic system. For example, target tracking and belief propagation are applications where Bayesian filtering has been applied extensively. In the framework of Bayesian filtering, the state variable {χt; t=0, 1, 2, . . . } is characterized by its probability density function (PDF) estimated from the sequence of measurements {z1, z2, . . . zt}. The state evolution and measurement function are given by

χttt−1)+νt−1  (1)
zt=htt, nt)  (2)

where {νt; t=0, 1, . . . } is an Independent and Identically Distributed (“i.i.d”) process noise sequence and {nt; t=1, 2, . . . } is an i.i.d. measurement noise sequence. A convenient Bayesian solution to the dynamic system is given by a recursive Bayesian filter, where the conditional density of the state variable, given that the measurements are propagated through the stages of prediction and update. This process is typically performed in a recursive manner, where the measurements are processed sequentially and the posterior probability density function is constructed recursively as shown by the equations below:

Prediction: pt|z1:t−1)=∫ptt−1)pt−1|z1:t−1)t−1  (3)
Update: pt|z1:t)=κt·p(ztt)pt|z1:t−1)  (4)

where z1:t={z1, . . . , zt}, κt=[∫p(ztt)p(χt|z1:t−1)t]−1 is a constant independent of χt. In equation (3) above, p(xt|z1:t−1) is the prediction distribution, p(xt|xt−1) is the system dynamic model, also called motion model in computer vision applications, and p(xt−1|z1:t−1) is the prior distribution.


When the state equation (1) is linear and the posterior density of χt is Gaussian, the Kalman filter provides the optimal solution in terms of achieving minimum-mean-squared-error estimation. However, for many practical situations characterized by non-linear and/or non-Gaussian distributions, the solutions to optimal algorithm is not tractable due to the lack of a closed form expression for the integration result in prediction. For non-linear and/or non-Gaussian Bayesian filtering, various particle filtering methods have been developed, where the posterior density function is represented by a number of random samples (i.e. particles) {χti; i=1, 2 . . . } and their associated weights {wti; i=1, 2 . . . }.
p(x1z1:t)=iwtiδ(xt-xti)(5)

In the particle filtering technique, the conditional density is propagated through sampling, re-sampling and weight modification.



FIG. 1 is a flow-chart for a scheme called density morphing and mode propagation in an embodiment of the present invention. The main idea is to characterize the landscape of the underlying density function and track the density evolution over time. For this purpose, in at least one embodiment, the system approximates relevant probability density functions (PDFs) in the form of kernel mixtures derived by analyzing multiple modes of density functions, and maintains analytic representations throughout the recursive process of sequential Bayesian filtering. Without loss of generality, Gaussian kernels are used for presentation. The sequential filtering process is described next.


A mixture density function of the conditional density is described as:
p(x1z1:t)=iwtkK(xt-xtk;Htk)(6)

where K(χ, χtk; Htk) is a kernel function centered at χtk, with bandwidth Htk. The Bayesian filtering through density morphing and mode propagation is described next.


In the prediction step 12, the system applies an unscented transformation to transform the prior PDF described by a mixture density function
p(xtz1:t-1)=k=1Nt-1wt-1kK(xt-1,xt-1k;Ht-1k)

into the prediction PDF described by a mixtured density function
p(xtz1:t-1)=k=1Nt-1w_tiK(xt,x_ti;H_ti)(7)

According equation (3), the prediction PDF is written as follows
p(xtz1:t-1)=k=1Nt-1wt-1kp(xtxt-1)K(xt-1,xt-1k;Ht-1k)xt-1(8)


The computation of the prediction PDF in a nonlinear system is not straightforward due to lack of analytic solution for the integration in (8). To maintain a Gaussian mixture representation for the prediction PDF, we approximate each summation term ∫p(χt|xt−1)K(χt−1, χt−1k; Ht−1k)dχt−1 in (8) by a Gaussian kernel K(χt, {overscore (χ)}ti; {overscore (H)}ti) through unscented transformation as follows. Every kernel K(χt−1, χt−1k; Ht−1k) in the prior PDF is approximated by 2N+1 weighted samples, or sigma points
{Wi,xt-1,ik}xt-1,0k=xt-1k,W0=κ(N+κ)xt-1,ik=xt-1k+((N+κ)Ht-1k)i,Wi=1(N+κ)fori=1,,Nxt-1,ik=xt-1k+((N+κ)Ht-1k)i,Wi=1(N+κ)fori=N+1,,2N(9)


Where κ∈R, ({square root}{square root over ((N+κ)Ht−1k)})i is the i-th row or column of the matrix square root of (N+κ)Ht−1k, and Wi is the weight associated with point
xt-1,ik.

Denote y=ƒtt−1) as the resulting random variable of propagating χt−1 through a nonlinear transformation ƒt. The mean μy and covariance Hy of y are calculated from the transformed sigma points as follows
μy=i=02NWif(xt-1,ik);Hy=i=02NWi[ft(xt-1,ik)-μy][ft(xt-1,ik)-μy]T(10)


The mean and covariance of y obtained by the unscented transformation are precise to the second order of the Taylor series expansion of any nonlinear function ƒt. The choice of parameter κ affects the error introduced by higher order moments. Applying the unscented transformation to the Gaussian components of K(χt−1, χt−1k; Ht−1k) in (8) according to (3), the approximation of the prediction PDF (7) is derived as follows:
p(xtz1:t-1)=k=1N_tw_tkK(xt,x_tk;H_tk)N_t=Nt-1;w_tk=wt-1kx_tk=i=02NWif(xt-1,ik);H_tk=i=02NWi[f(xt-1,ik)-x_tk][f(xt-1,ik)-x_tk]T+Qt(11)

where Qt is the variance of process noise νt. It should be noted that here random sampling strategy can also be employed.


At step 14, the predicted density (7) is used to draw a set of samples {{tilde over (χ)}tj}. The likelihood of the measurement is p(zt|{tilde over (χ)}tj) calculated at these sample points.


At step 16, the likelihood function p(ztt) of the measurement is approximated as kernel mixtures. The approximation is obtained by interpolating the likelihood function from samples {{tilde over (χ)}tj}, assuming that the measurement likelihood is reasonably smooth.
p(zt|xt)=jw~tjK(xt,x~tj;H~tj)(12)


An outline of the approximation process can be stated as:


1. Analytic sampling; place samples in sparsely sampled area and area of significance (high measurement probability); discovery and refinement.


2. Interpolation; data-responsive variable bandwidth; and weight adjustment.


The density morphing and mode reduction algorithm progressively improves the approximation of the likelihood through incremental sampling. In contrast to various improved particle filters, a continuous approximation of the likelihood function is interpolated from all the samples available from each sampling step.


Sampling and distribution update is repeated over multiple steps. At each step, new samples are drawn from the approximate likelihood function recovered in the previous step. New samples are then added into the sample set which is used to obtain a new approximation of the distribution.


Given a set of samples, the likelihood or posterior distribution is approximated by a mixture function composed of weighted Gaussian kernels whose centers are set as sample locations and whose bandwidths are determined by the distance to their k-th nearest neighbors (kNN), which reflects the local density condition of the actual sample distribution.


The kernel bandwidths are data driven and lead from a smooth to fine interpolation of the underlying distribution function. In the initial step, with a small number of samples that are sparsely distributed in the state space, kernel bandwidths are set large and the interpolation algorithm gives a smooth approximation of the distribution.


As the sample size increases, samples are distributed densely, which leads to small kernel bandwidths, and the interpolation result reveals fine details of the landscape of the underlying distribution function. Since the analytic representation provides a global view of the landscape of the likelihood function, efficient sampling is possible, More samples should be placed in the region where the likelihood has significant values. The algorithm is summarized as follows with prediction distribution used as the initial sampling function.

    • 1. Choose the prediction PDF as the initial sampling function p1(χ)=p(χt|z1:t−1).
    • 2. For i=1, . . . , n:
      • Draw m samples {χi,1, . . . , χi,m} from the sampling function pi(χ), and calculate the measurement likelihood at these points ƒ(χi,j)=p(ztti,j) (j=1, . . . , m)
      • Interpolate the likelihood function from all available samples and their likelihood values {(χk,j, ƒ(χk,j)} (k=1, . . . , i; j=1, . . . , m)
        f~i(x)=k=1,k;j=1,,mwk,jK(x;xk,j,Hk,j)(13)Hk,j=λ·dk0(xk,j)(14)
        Hk,j=λ·dk0k,j)  (14)


        where λ is a constant, and dk0(χ) is the Euclidean distance between χ and its k-th nearest neighbor in the sample set. The weights are solved by the non-negative lease square (NNLS) algorithm.
        {wk,j}k=1,i;j=1,,m=argminx{xk,j}f~i(x)-k=1,i;j=1,,mwk,jK(x;xk,j,Hk,j)2(15)
    • Update the sampling function

      pi+1(χ)=κ·{tilde over (ƒ)}i(χ)  (16)

      where κ={tilde over (ƒ)}i(χ)/∫{tilde over (ƒ)}i(χ)dχ is a constant for normalization.
    • 3. The posterior PDF is approximated by the final interpolation result {tilde over (ƒ)}n(χ) and is written as a mixture function (12).


It is well known that closer the sampling function is to the distribution function under estimation, the better density estimate can be obtained from samples. It has been shown that, to recover a distribution function of interest, the best choice of the sampling function, which minimizes the variance of distribution estimate, is determined by the unknown distribution itself. Therefore, optimal sampling is not available in many situations.


Previous approaches choose to use the prediction PDF as the sampling function to estimate the measurement likelihood, which could lead to severe sample degeneracy when the likelihood is very “peak” as compared to the sampling function. In the density morphing and mode propagation approach, sampling and updating of the sampling function simultaneously is done simultaneously through incremental sampling. The advantage is to bring the sampling function close to the distribution under estimation, so that the resulting density estimate is less sensitive to the initial sampling function.


At step 18, an update on the posterior PDF is performed. With the prediction density (7) and the measurement likelihood (12), the conditional density function is updated as
p(xt|z1:t)=κt·p(zt|xt)p(xt|z1:t-1)=κt·iw_tiK(xt.x_ti;H_ti)·iw~tjK(xt,x~tj;H~tj)=κt·kwtkK(xt.xtk;Htk)(17)

where κt=└∫p(ztt)p(χt|z1:t−1)dχt┘ is a constant independent of χt. Due to the mixture representation of (7) and (12), the conditional density p(χt|z1:t) can be represented by a mixture density function with increased number of kernels.


If the prediction PDF p(χ1|z1:t−1) and the measurement likelihood p(ztt) are each represented by a Gaussian mixture with N1 and N2 components respectively, the resulting posterior PDF p(χt|z1:t) has N=N1N2 components. This number could explode in recursive filtering. Therefore, an algorithm or a technique is needed to reduce the mixture size. The need for approximating the sum or the product of Gaussian mixtures also arises in several other contexts, including nonparametric belief propagation and training mixture models.


A given application may bypass the approximating measurement likelihood, and use the incremental sampling and interpolation method to directly reconstruct a mixture representation for the product of the prediction PDF and the measurement likelihood. By normalizing the product, one obtains a kernel mixture representation of the posterior PDF.


At step 20, a mode finding and mixture reduction procedure is performed. To maintain a reasonable number of kernels in the posterior PDF, a mode finding and mixture reduction procedure through variable-bandwidth mean-shift is applied to reduce the number of mixtures in (17). The main idea is to locate the main modes of the posterior PDF and derive a more concise representation with fewer kernels using the modes to approximate the original density function. Mixture reduction is now described in detail. Given a Gaussian mixture resulting from the sum or the product of several Gaussian mixtures,
f(x)=i=1NaiK(x;xi,Hi)whereK(x;xi,Hi)=(2π)-d2Hi-12exp(-12(x-xi)THi-1(x-xi))(18)

one can treat ƒ(χ) as a density estimate from sample population {χi} with variable bandwidth {Hi}. A new algorithm called mode reduction produces an approximation of the original density, with a reduced number of Gaussian components. The algorithm is founded by the Variable Bandwidth MeanShift theory and performs a mode finding procedure on kernel density estimates.


From (18), one can compute the gradient as well as the Hessian at x
gradient:f(x)=i=1NaiK(x;xi,Hi)Hi-1(xi-x)Hessian:(T)f(x)=i=1NaiK(x;xi,Hi)Hi-1[(x-xi)(x-xi)T-Hi]Hi-1(19)


Starting from χ, the variable bandwidth MeanShift produces a convergent sequence:
yj+1=(i=0Nωi(yi)Hi-1)-1i=1Nωi(yj)Hi-1xiy0=x;j=1,2,,tillconvergencewhereωi(x)=aiK(x;xi,Hi)i=1NaiK(x;xi,Hi)(20)


At the convergence location
ym=(i=1Nwi(ym)Hi-1)i=1Nwi(ym)Hi-1xi,wehavef(x)x=ym=0.


To verify that this is indeed a mode, one needs to verify that the Hessian is negative definite (∇∇T)ƒ(x)|x=ym<0. By starting from each χi and running the Variable bandwidth MeanShift procedure, we can locate all the modes of ƒ(χ). In addition, we divide all the samples {χi} into disjoint sets {χj,i} such that samples in the same set {χj,1, χj,2, . . . } converge to the same mode mj. The idea of our algorithm is to approximate the density near the modes using Gaussian components with proper bandwidth. For a Gaussian component k(χ; μj, Σj), the gradient and the Hessian computed at the mean μj, also being the mode, are:
K(x;μj,j)|x=μj=0(T)K(x)|x=μj=-(2π){-d2Σj-12Σj-1(21)


To approximate the density near the mode, we equate the location, gradient and Hessian of the Gaussian component with the parameters computed at a mode mj.
μj=mjK(x;μj,j)x=μj=f(x)x=mj(T)K(x;μj,j)x=μj=(T)f(x)x=mj

Following (21), the Gaussian kernel is decided by:
μj=mjΣj=2π(-P)-1-1d+2(-P-1)whereP=(T)f(x)|x=mj(23)

given that the Hessian P is negative definite. For those samples χj whose convergence point is not a mode of f(x), we maintain the Gaussian component k (χ; χj, Hj) in the reduced mixture approximation. The resulting approximation is expressed as:
f~(x)=j=1McjK(x;mj,Σj)j=1Mcj=1,M<N(24)

(mj, Σj)=(mj, (∇∇T)ƒ(x)|x=mj) or (χji, Hji) depending on whether χji is associated with mode mj. The integrated square error of the approximation can be evaluated.

∥{tilde over (ƒ)}(x)−ƒ(x)∥2=cTQc+qTb+F  (25)

where c=[c1, . . . , cM]T is the weight vector, Q is a M×M matrix,
Q=[K(x;m1,Σ1),K(x;m1,Σ1)xK(x;m1,Σ1),K(x;mM,Σ1)K(x;mM,Σ1),K(x;m1,Σ1)K(x;mM,Σ1),K(x;mM,Σ1)](26)

and q is a M×1 vector, q=−2[<K(x; m1, ƒ(x)>, . . . , <K(x; mM, ƒ(x)ƒ(x)>]T. The notation <ƒ(x), g(x)>=∫ƒ(x)g(x)dx is used. The weights of the new components are obtained by solving the following convex quadratic programming problem:
c=argminc-c_TQb+qTc_subjecttoi=1Mci=1ci0fori=1,,M(27)

In general, the means {mj} and the bandwidths {Σj} of the new components are up to further optimization over the cost function (25).


After mode finding and mixture reduction, the conditional density is estimated by a reduced number of kernels.
p(xt|z1:t)=kwtkK(xt·xtk;Htk)(28)


Density morphing and Mode propagation have several potential advantages over the conventional particle filtering. Through the Variable-bandwidth Mean-shift based mode finding algorithm, the number of modes in the posterior is determined automatically and naturally. This information helps to decide the number of samples to be drawn. With the conventional particle filtering methods, it is difficult to determine how to efficiently sample the state space, especially when the dimensions are high.


The optimal bandwidth can also be determined by imposing certain smoothness of the measurement probability and the posterior. Thus, optimal sampling given the kernel density and estimation constraints are achieved. Optimal sampling is especially critical when the dimension of the state space is high, which is often encountered in real applications. In mode propagation, kernel estimation is used to replace particles, and with variable bandwidth it is able to reduce the effects of degeneracy and sample impoverishment.


Experimental results for the above are presented below. The nonlinear process model and the non-stationary observation model used in the experiments are:

xt+1=1+sin(wπt)+φxt+vt
zt=φxt2+nt

where vt is i.i.d., Gaussian noise with zero mean and variance nν2, vt˜N(0, nν2), w=4e−2 and φ=0.5 are scalar parameters. The observation noise nt is drawn from a Gaussian distribution N(0,12). In the initial step, a Gaussian mixture distribution describes the state variable.


To approximate the measurement distribution, a system based on at least one embodiment of the present invention samples the mean and a number of sigma points from each Gaussian in the predicted state distribution. Assuming that the predicted state distribution has a mixture of N Gaussians denoted as N(mi, σi2) i=1, . . . , n. m samples are drawn from the prediction distribution. Sample weights are proportional to the measurement probability. Then the measurement distribution is composed of m Gaussian mixture, and—nm Gaussian kernels are used to estimate the posterior distribution in the final step. The mode-fusion procedure based on the Variable-bandwidth Mean-shift algorithm is applied to simplify the state description with a reduced number of Gaussians.



FIGS. 2A-2E and 3A-3E are plots of simulations/experiments carried out using at least one embodiment of the present invention. The figures show that during the filtering process, multi-modal states are propagated over time. With proper scale selection, the approximation of the measurement probability function is very close to the ground truth, and the true state variables are being tracked.


In the experiments described next, nine points are sampled from each Gaussian, and we set k={square root}{square root over (2)}/3. The FIGS. 2A-2E and 3A-3E show the procedure of this algorithm for two cases: small prediction error with nν2=1 (FIG. 2A-2E) and large prediction error nν2=5 (FIGS. 3A-3E). The first row of each figure shows the conditional density from the last step. The second row shows the predicted distribution (solid line), true measurement (dashed line), sampled points (solid line and circles) and estimated measurement (dotted line). In the third row, dashed lines are Gaussian kernels generated from sampled points and the dotted line is the summation of those kernels. The last row shows the posterior distribution with true position specified with the asterisk/star symbol.


It is to be understood that the present invention may be implemented in various forms of hardware, software, firmware, special purpose processors, or a combination thereof. In at least one embodiment, the present invention may be implemented in software as an application program tangibly embodied on a program storage device. The application program may be uploaded to, and executed by, a machine capable of computing and having any suitable architecture.


Referring to FIG. 4, according to an embodiment of the present invention, a computer system 101 for implementing the present invention can comprise, inter alia, a central processing unit (CPU) 102, a memory 103 and an input/output (I/O) interface 104. The computer system 101 is generally coupled through the I/O interface 104 to a display 105 and various input devices 106 such as a mouse and keyboard. The support circuits can include circuits such as cache, power supplies, clock circuits, and a communications bus. The memory 103 can include random access memory (RAM), read only memory (ROM), disk drive, tape drive, etc., or a combination thereof. The present invention can be implemented as a routine 107 that is stored in memory 103 and executed by the CPU 102 to process the signal from the signal source 108. As such, the computer system 101 is a general purpose computer system that becomes a specific purpose computer system when executing the routine 107 of the present invention.


The computer platform 101 also includes an operating system and micro instruction code. The various processes and functions described herein may either be part of the micro instruction code or part of the application program (or a combination thereof) which is executed via the operating system. In addition, various other peripheral devices may be connected to the computer platform such as an additional data storage device and a printing device.


It is to be further understood that, because some of the constituent system components and method steps depicted in the accompanying figures may be implemented in software, the actual connections between the system components (or the process steps) may differ depending upon the manner in which the present invention is programmed. Given the teachings of the present invention provided herein, one of ordinary skill in the related art will be able to contemplate these and similar implementations or configurations of the present invention.


The Bayesian filtering method based on mode propagation can be generally applied to any purpose object tracking. For example, to 3D human tracking, vehicle tracking, and tracking problems from a large range of applications and domains. Software modules can be built for prediction, sampling, approximation and update as described above in detail. Additionally, input and output devices or other modules can be included depending upon a given application. Those skilled in the art will appreciate that these are only examples of applications where Bayesian filtering based on mode propagation can be applied.


While the present invention has been particularly shown and described with reference to exemplary embodiments thereof, it will be understood by those skilled in the art that various changes in form and details may be made therein without departing from the spirit and scope of the present invention as defined by the appended claims.

Claims
  • 1. A system for analyzing a dynamic system model using Bayesian filtering, the system comprising: a prediction module for predicting a state model of the dynamic system model from a prior density and the dynamic system model, the prediction module generating a prediction density having at least one mode, the representation of the prediction density including at least one kernel; an approximating module for approximating at least one measurement likelihood function from a sample set through at least one kernel; an update module for updating a conditional density function using the measurement likelihood function and the prediction density; and a mode finding and mixture reduction module for reducing the number of kernels in a probability density distribution function.
  • 2. The system of claim 1, further comprising: a sampling module for forming the sample set having samples by selecting at least one sample corresponding to each kernel by using the prior density.
  • 3. The system of claim 2 wherein the sampling module selecting samples in a random manner.
  • 4. The system of claim 2 wherein the samples are selected according to bandwidth information associated with a function of the prior density.
  • 5. The system of claim 1, wherein the prediction module generates prediction density from a prior set of modes corresponding to at least one prior state of the dynamic system model.
  • 6. The system of claim 1 wherein the prior density, prediction density, measurement likelihood function and posterior density are represented by analytic representations in the form of mixtures of kernels.
  • 7. The system of claim 1 wherein the kernel is a Gaussian function.
  • 8. The system of claim 1 wherein a mixture of kernels represents the conditional density function having a plurality of modes.
  • 9. A system for analyzing a dynamic system using Bayesian filtering, the system comprising: a prediction module for predicting a state model of the dynamic system; and an update module for updating the state model of the dynamic system by reducing the size of mixtures generated during a recursive operation of predicting and updating the state model during the Bayesian filtering.
  • 10. The system of claim 9 further comprising: a plurality of modes generated as an output of the update modules operations, wherein the size of mixtures is reduced by approximating densities near the modes by mode finding, and using Gaussian components with predetermined bandwidths and minimizing approximation error.
  • 11. A system for analyzing a dynamic system using a Bayesian filtering, the system comprising: a prediction module for applying an unscented transformation on a prior probability density function of a prior state model of the dynamic system, the prediction module generating a predicted density; an update module for recovering a continuous predicted density function to approximate a measurement likelihood function of a state model of the dynamic system; and a density morphing module for tracking density evolution over time, the density morphing module reconstructing the continuous predicted density function, measurement likelihood function and a posterior density function from at least one sparse sample.
  • 12. The system of claim 11 further comprising: a posterior probability density function (PDF) generator for generating the posterior PDF by creating a product of the reconstructed continuous functions of measurement likelihood and the predicted density.
  • 13. The system of claim 11 wherein the measurement likelihood function is approximated by using incremental sampling.
  • 14. The system of claim 11 wherein interpolation is used to obtain an analytic representation including of at least one kernel for approximating the measurement likelihood function.
  • 15. The system of claim 11 further comprising: an incremental sampling module for constructing a sequence of coarse to fine approximations of the measurement likelihood function.
  • 16. The system of claim 15 wherein the incremental sampling module uses a sequence of sampling functions to draw samples.
  • 17. The system of claim 16 wherein the sequence of sampling functions are derived from an approximated measurement likelihood function obtained by interpolation.
  • 18. The system of claim 11 the measurement likelihood is approximated by using a mixture function comprising: at least one Gaussian kernel having a bandwidth, the bandwidth being determined by a local density condition of a given sample distribution.
  • 19. The system of claim 11 wherein the prior probability density function, predicted density are represented by analytic representations in the form of mixtures of kernels.
  • 20. The system of claim 19 wherein the mixtures of kernels are Gaussian kernels.
  • 21. The system of claim 19 wherein said prediction module, update module and said density morphing module maintain the form of a plurality of intermediate density functions as mixtures of kernels throughout the Bayesian filtering process.
  • 22. A program storage device readable by machine, tangibly embodying a program of instructions executable by the machine to perform method steps for modeling a dynamic system using Bayesian filtering, the method steps comprising: predicting a state model of the dynamic system for generating a prediction density having at least one mode from a prior density, the representation of the prediction density including at least one kernel; approximating at least one measurement likelihood function from a sample set through at least one kernel; updating a conditional density function using the measurement probability and the prediction density; and finding modes to reduce the number of kernels in a probability density distribution function.
  • 23. The method of claim 22, the method further comprising: sampling to create the sample set having samples by selecting at least one sample corresponding to each kernel by using the prior density.
  • 24. The method of claim 23 wherein the sampling step selects samples in a random order.
  • 25. The method of claim 23 wherein the samples are selected according to bandwidth information associated with a function of prior density.
  • 26. The method of claim 22, wherein the step of predicting further comprising: generating prediction density from a prior set of modes corresponding to at least one prior state of the dynamic system.
  • 27. The method of claim 22 wherein the kernel is a Gaussian mixture.
  • 28. The method of claim 22 wherein a mixture of kernels represents the conditional density function having a plurality of modes.
  • 29. An object tracking system operating according to the method of claim 18, the system comprising: a prediction module for predicting a state model according to the predicting step; an approximating module for approximating using the approximating step; an update module for updating the conditional density function using the updating step; and a mode finding module for reducing the number of kernels using the finding step.
  • 30. The system of claim 29 further comprising: an image capture module for capturing an image having an object to be tracked; a processing module for processing the image to form the state model of the dynamic system. an image processing module recursively operating the prediction module, approximating module, the updating module, the mode finding module to track the object; and an output module generating an output of the object at least one characteristic of the object to at least one of another module and an output device.
  • 31. A method for modeling a dynamic system using Bayesian filtering, the method comprising: predicting a state model of the dynamic system; and updating the state model of the dynamic system to reduce the size of mixtures generated during a recursive operation of predicting and updating the state model during the Bayesian filtering.
  • 32. The method of claim 31 further comprising: generating a plurality of modes as an output of the updating step; reducing the size of mixtures by approximating densities near the modes by using Gaussian components with predetermined bandwidths.
  • 33. A method for modeling a dynamic system using a Bayesian filtering, the method comprising: applying an unscented transformation on a prior probability density function of a prior state model of the dynamic system generating a predicted density; recovering a continuous function to approximate a measurement likelihood of a state model of the dynamic system; tracking density evolution over time; and reconstructing the continuous function from at least one sparse sample.
  • 34. The method of claim 33 further comprising: generating a posterior PDF by creating a product of the reconstructed continuous function and the predicted density.
  • 35. The method of claim 33 wherein the measurement likelihood and the posterior PDF are approximated by using incremental sampling.
  • 36. The method of claim 33 wherein the measurement likelihood and the posterior PDF are approximated by using a mixture function comprising: at least one Gaussian kernels whose bandwidths is determined by the local density condition of a given sample distribution.
  • 37. The method of claim 33 wherein the prior probability density function and predicted density are represented by analytic representations in the form of mixtures of kernels.
  • 38. The system of claim 33 wherein the mixtures of kernels are Gaussian kernels.
  • 39. The system of claim 33 wherein said steps of applying, generating, recovering, tracking and reconstructing, maintain the form of a plurality of intermediate density functions as mixtures of kernels throughout the Bayesian filtering process.
  • 40. A method for modeling a dynamic system using a Bayesian filtering, the method comprising: generating a predicted density; recovering a continuous function to approximate measurement likelihood of a state model of the dynamic system; tracking density evolution over time; and reconstructing the continuous function from at least one sparse sample.
CROSS-REFERENCE TO RELATED APPLICATION

This application claims the benefit of U.S. Provisional Application, “Density Morphing And Mode Propagation For Bayseian Filtering”, Ser. No. 60/490,326, filed on Jul. 25, 2003, the contents of which are incorporated herein by reference.

Provisional Applications (1)
Number Date Country
60490326 Jul 2003 US