A Nonlinear Filter based on Fokker Planck Equation and MCMC Measurement Updates

Size: px
Start display at page:

Download "A Nonlinear Filter based on Fokker Planck Equation and MCMC Measurement Updates"

Transcription

1 A Nonlinear Filter based on Fokker Planck Equation and MCMC Measurement Updates Mrinal Kumar* and Suman Chakravorty** Abstract This paper presents a nonlinear filter based on the Fokker-Planck equation (FPE) for uncertainty propagation, coupled with a fast measurement update step. The measurement update is implemented as a function approximation performed over a Markov chain Monte Carlo (MCMC) sample of the unnormalized posterior obtained from the Bayes rule. MCMC sampling also results in fast computation of the normalization factor of the posterior, which is typically a computationally heavy step. A previously developed semianalytical meshless tool is employed to solve FPE for high dimensional systems in real time. Performance of the filter is studied for dynamical systems with 2 and 4 dimensional state spaces. I. INTRODUCTION Nonlinear filtering has been a widely researched subject for the past several decades. The Kalman filter [1] and later, the extended Kalman filter (EKF) have been the most widely used tools for this problem. The former is the optimal state estimator for systems governed by linear dynamics and linear measurement models. The latter extends the Kalman filter to nonlinear systems by considering the first order approximation of the actual nonlinear dynamics and measurement model. In other words, the Kalman filter and EKF deal with linear and linearized dynamical systems respectively. The primary drawback of EKF, namely linearization, is also its main appeal among practitioners because it greatly simplifies its implementation. However, several instances have been encountered over the years in which they fail to perform well or even diverge. Despite interest in nonlinear filtering methods since the 1980 s (e.g. see [2]), they have become practicable only in the past two decades with the sudden explosion in computing capability. This paper considers the problem of nonlinear filtering for continuous dynamical systems and discrete measurement updates. The key objective of filtering, also known as state estimation, is to determine the probability density function (pdf) of the system states conditioned on all available measurements. This leads us to the key research issue: a general probability density function is fully characterized only when all its moments, which are infinite in number, are taken into account. Therefore, any general nonlinear filter is equivalent to a set of propagation and update rules in the infinite dimensional space of moments. An alternate but equivalent description of the nonlinear filtering problem This work was not supported by any organization *M. Kumar is a Postdoctoral Research Assistant in the Department of Aerospace Engineering at the Texas A&M University, College Station, TX USA. mrinal@tamu.edu **S. Chakravorty is with the Faculty of Aerospace Engineering at the Texas A&M University, College Station, TX 77843, USA. schakrav@aero.tamu.edu can be given in functional space. Here, the Fokker-Planck equation (FPE) describes the propagation phase of the pdf and the Bayes rule describes the measurement update step. Unfortunately, analytical solutions of FPE, which is a partial differential equation, are not known to exist except for the case of linear dynamical systems (Ref. [3]). Additionally, numerical attempts have consistently been foiled by several difficult issues, most notable being the curse of dimensionality (Refs. [4] [6]). Furthermore, the update rule also suffers dimensionality issues which prevents its real-time implementation, as is required in the filtering application. As a result, the nonlinear filtering literature has branched into three broad directions (Ref. [7]). The first category of nonlinear filters can be classified as closure-filters. Here, the state uncertainty is characterized by moments of the pdf truncated up to a pre-determined order. The EKF is a special case which considers only the first two moments, leading to Gaussian closure. In the same spirit as EKF, propagation and update rules can be determined for higher order moments (higher order closures), thus capturing desired nonlinear effects (see Refs. [8], [9]). As with EKF, the higher order filters are subject to similar issues of poor performance/divergence depending on the degree of nonlinearity and/or intensity of noise in the underlying system. The second class of nonlinear filters, known as particlefilters treat the problem differently. They characterize the state uncertainty in terms of the statistics of a sample of points called particles. Each particle carries a weight and is individually propagated forward through the stochastic dynamics of the system (Refs. [10] [16]). The particle weights are updated as new measurements come in and the desired moments of the pdf are computed by studying the statistics of the weighted particles. Since the true pdf of the state is not known a-priori, the particles are sampled from a proposal density function, one that is known and relatively easy to sample from. Particle filters face two key research issues, first of which is determining how many points are sufficient to confidently describe the statistics of the uncertain state. The second difficulty faced by particle filters is called particle depletion - a scenario in which particles residing in regions of high probability mass migrate to the tail regions of the pdf. This causes thinning of the particle density in regions where the bulk of the conditional pdf resides. This requires re-sampling every few time steps so that particles are replenished in the regions of high probability density and removed from the tail regions. An important technique in this context is that of sampling/importantance resampling (SIR) (Refs. [10], [11], [17]). Recently, numerous particle filters

2 based on the Markov chain Monte Carlo sampling technique have been designed, e.g. Ref [18]. The third category of nonlinear filters, also the subject of this paper, is called projection filters. In general, this class of filters assumes the state conditional pdf to belong to a family of functions and determines the parameters associated with the said functions. Ref. [19] assumes the pdf to reside in the family of exponential pdfs. Xu et al. [20] represented the state conditional pdf in terms of Dirac delta functions and employed a direct quadrature method of moments to solve the associated FPE. Similarly, Gaussian sum filters (Refs. [21] [23]) assume the state conditional pdf to be composed of a mixture of Gaussians. Beard [24] proposed a projection filter in which the state pdf was expanded in terms of global shape functions. The FPE was solved in weak form via the Galerkin projection technique and the update was implemented as a weak form of the Bayes rule. Due to numerical issues associated with solving FPE, the application of this filter was limited to low dimensional state spaces. In addition, the implementation of Bayes rule in variational form is not suitable for the filtering application because it requires the computation of a large measurementstiffness matrix every time a new measurement is obtained. In Kumar et al. [25], a similar projection filter was proposed where the FPE was solved in real time using a meshless particle-partition of unity finite element technique. However, this filter also solved the Bayes rule in variational form, thereby restricting its application to cases with low-frequency updates. The current paper is an extension of the work in Ref. [25]. It utilizes the same technique as in Refs. [5], [6] and [25] for the propagation phase, namely, a meshless semianalytical method for solving FPE in near real-time. For the measurement update however, the current paper utilizes a Markov chain Monte Carlo sampling based technique to speed up the process, thus making the nonlinear filter more amenable to high-frequency update scenarios. The semianalytical FPE solver is a robust tool based on the meshless particle-partition of unity finite element method (ppufem) for dealing with nonlinear uncertainty propagation. ppufem naturally extends FPE discretization to high dimensional systems due to its meshless nature ( node based as opposed to element based). Equipped with h and p refinements, it is capable of generating highly accurate solutions of FPE using a small number of local shape functions. In Refs. [5] and [6], ppufem was combined with modal analysis to generate transient FPE response in real time for nonlinear dynamical systems, thus making it ideally suited for filtering applications. Markov chain Monte Carlo, or MCMC is a well established technique [26] for sampling non-standard distributions. The Metropolis-Hastings (MH) algorithm can be used to quickly generate a small sample from (a possibly unnormalized) pdf. Following the propagation step, the current paper utilizes the MH algorithm to generate a sample from the un-normalized posterior obtained from the Bayes rule. A function approximation algorithm (least-squares) is then implemented on this sample to approximate the posterior. This can be done online because the mass matrix associated with least-squares can be pre-computed. The outcome is that the MCMC based approach considerably speeds up the measurement update step. The remainder of this paper is organized as follows: Section II states the problem of nonlinear filtering with FPE and Bayes rule. Sections II-A - II-D describe each step of the proposed filter, including pdf approximation (Sec.II- A), filter initialization (Sec.II-D), propagation (Sec.II-B) and measurement update (Sec.II-C). Results are shown in Sec.III and conclusions drawn in Sec.IV. II. THE BAYES NONLINEAR FILTERING PROBLEM As mentioned earlier, we shall consider the case of continuous time dynamical systems and discrete measurement updates. The Bayes nonlinear filtering problem involves two steps implemented recursively - uncertainty propagation ( prediction) and measurement update ( filtering). Following filter initialization, the true description of state uncertainty propagation is given by the Fokker Planck equation. Measurements obtained are incorporated into state uncertainty via the Bayes rule. The filter starts again with propagation until the next batch of measurements are obtained. To set up the mathematical framework, consider a stochastic dynamical system governed by the following Itô stochastic differential equation (SDE): dx = f(t, x)dt + g(t, x)db(t), E[x(t 0 )] = x 0 (1) where, B represents a M-dimensional zero mean Brownian motion process with correlation function Qδ(t 1 t 2 ), and x 0 represents the mean initial state. Vector functions f(t, x) : [0, ) R N R N and g(t, x) : [0, ) R N R N M are measurable functions. The initial probability density of the state is known to be W(0, x) = W 0 (x), which captures the state uncertainty at time t = 0. Incoming measurements are captured by the following discrete nonlinear measurement model: y k = h(x k ) + v k (2) where, y R l, v is a l-dimensional Brownian motion process (measurement noise), h(x) : R n R l is measurable and k denotes the time instant of measurement. The growth of information with successive measurements is denoted by the filtration Y k = {y 0, y 1,..., y k }. Then, the nonlinear Bayes filtering problem is to determine the state probability density function conditioned on the filtration Y k, i.e., W(x k Y k ) utilizing the following recursive equations: W(x k Y k 1 ) = W(x k x k 1 )W(x k 1 Y k 1 )dx k 1 (3) W(x k Y k W(y k x k )W(x k Y k 1 ) ) = Ω W(y (4) k ξ)w(ξ Y k 1 )dξ Eq.3 represents the propagation part between two measurement updates. The left hand side of this equation is the prior state pdf, which can be obtained by integrating the associated Fokker-Planck equation between time labels

3 t k 1 and t k. The posterior state pdf is obtained from the Bayes rule in Eq.4. In this equation, W(y k x k ) represents the likelihood probability density function, given by: 1 W(y k x k ) = exp( 1 (2π det R) m 2 [y k h(x k )] T R 1 [y k h(x k )]), where, R k is the measurement error covariance matrix. As mentioned above, in order to obtain the prior pdf, i.e. W(x k Y k 1 ), it is required to solve the FPE associated with equation 1. FPE is a linear, parabolic partial differential equation given by: t W(t, x Y) = L FPW(t, x Y) (5) where, N N L FP = D (1) 2 i (, ) + D (2) ij (, ) (6) x i x i x j i,j=1 D (1) (t, x) = f(t, x) g(t, x) Qg(t, x) (7) x D (2) (t, x) = 1 2 g(t, x)qgt (t, x) (8) where, L FP is the Fokker-Planck operator, D (1) is known as the drift coefficient vector and D (2) is the diffusion coefficient matrix, both understood in the Stratonovich sense. There are numerous problems associated with solving FPE for general nonlinear high dimensional systems. Recently, Kumar et al. ( [5], [6]) have developed a robust meshless algorithm coupled with modal analysis to obtain near realtime transient response to FPE. This algorithm is used in the current paper for the propagation phase. We shall next consider the individual steps of the proposed nonlinear filter. A. State pdf Characterization Note that the Bayes nonlinear filtering problem is equivalent to an infinite dimensional system of equations involving all the moments of the unknown state pdf conditioned on available measurements. True characterization of the state pdf should therefore include all these moments. Unfortunately, a numerical method cannot do so directly because they are infinite in number. The Kalman filter/ekf truncates the pdf characterization at the first two moments, namely mean and covariance. By thus ignoring all higher moments, they implicity assume that the state pdf remains Gaussian at all times. The current filter does not characterize the pdf directly in terms of moments, but locally supported shape functions in the following manner: Ŵ(t, x Y) = P Q i a ij (t)ψ ij (x) (9) j=1 where, Ŵ(t, x Y) is an approximation of the true conditional state pdf, W(t, x Y). A similar annotation is used for all other approximated variables. The above characterization has been derived from a local, meshless approximation of W(t, x Y). The most important feature of a meshless approximation is that it is constructed in terms of nodes k distributed over the domain of solution. This is a clear paradigm shift from the traditional element-based, meshbased finite-element method (FEM). A mesh is nearly impossible to construct in dimensions greater than 3, thus severely restricting the utility of FEM for FPE. On the other hand, a meshless method such as the particle-partition of unity finite element method (ppufem) (Refs. [5], [6], [27], [28]) approximates the unknown purely in terms of nodes distributed over the domain of solution. Such a method is not concerned with how the nodes are connected to each other, thereby eliminating the mesh. Each node carries individually chosen local shape functions which best locally approximate the unknown. The local approximations of individual nodes are automatically blended together using weight functions called pasting functions. More detail about this technique can be obtained from Refs. [6], [27] and [28]. Due to space constraints, it is only important to consider Eq.9 in the present context. The outer summation (i = 1,... P ) enumerates the number of nodes in the approximation. The inner summation, (j = 1,... Q i ) counts the local shape functions assigned to the i th node. Therefore, Ψ ij (x) denotes the j th shape function assigned to the i th node in the approximation. The size of the approximation clearly is D = P Q i. As a result, the propagation and undate rules of the proposed nonlinear filter need to be determined for the associated parameters, a ij (t), totaling D in number. We will assume that the initial state conditional pdf is a posterior, i.e. the first step in the filter recursion is propagation. B. Filter Propagation For reasons which will soon be clear, filter initialization will be described last in this paper, following propagation and update steps. As noted before, the propagation step is given by Eq.3. This equation is equivalent to solving the associated FPE given in Eq.5. Substitution of Eq.9 in Eq.5 results in a residual. When the residual is minimized following the standard Galerkin projection technique, we obtain a D dimensional discretized representation of the FP operator: Mȧ(t) = Ka(t) + l. Here, M is the mass matrix, K is the stiffness matrix and l is the load vector. In Ref. [5], this discretization step was combined with modal analysis and spurious mode rejection to obtain near real-time transient FPE response. Modal analysis involves solving the generalized eigenvalue problem associated with the discretized system, i.e. Kφ = λmφ. The resulting set of eigenvectors {φ i } D is scrutinized for admissibility and physically irrelevant modes are blocked from participation in the approximation. Details of this process, which is fully automatic (does not require user input) can be obtained from Refs. [5], [6]. Spurious mode rejection leaves behind a reduced set (A) of admissible eigenfunctions that can be used to approximate the solution of the transient FPE as follows: Ŵ(t, x Y) = card(a) á i (t)φ i (x), φ i (x) A (10)

4 where, φ i (x) A are admissible eigenfunctions of the discretized FP operator and á i (t) are undetermined coefficients in modal space obtained from the transformation: á = V 1 a. Here, V is a matrix whose columns are eigenvectors of the system (K, M). Before we proceed, we note here that the parameters of the state pdf have now changed from a i (t) to á i (t), and their number reduced from D to card(a). The pdf is still characterized by shape functions, but now, by a special set of shape functions, namely the admissible eigenfunctions of the FP operator (Eq.10). This is also the reason why the filter initialization was left for the end because we actually deal with a transformed set of parameters, i.e. modal coefficients, á i (t), instead of the regular Fourier coefficients a i (t). A key point is that computation of admissible eigenfunctions is a pre-processing step that does not depend on initial state uncertainty. Therefore, once the eigenfunctions of the discretized FP operator are computed and stored away, the propagation step can be completed in real time. By virtue of working in the modal space, we obtain the following analytically solvable decoupled form: á(t) = Λá(t) + ĺ. In this relationship, Λ is a diagonal matrix containing the generalized eigenvalues of (K, M), and ĺ = V 1 M 1 l is the load vector in modal coordinates. The time history of these admissible modal amplitudes can now be written as: ( ) á i (t) = á i (t 0 ) + ĺi λ i exp(λ i t) ĺi λ i. (11) Accuracy of Approximation: Given the admissible set of eigenfunctions, it is possible to state the following result about the nature of computed transient FPE behavior: [4] Theorem 2.1: Let A = {φ i : Real(λ i ) < 0, ε i = L FP (φ i ) λ i φ i L2(Ω) < δ} be the set of stable admissible eigenfunctions. Define equation error in FPE as e(t) = tŵ(t, x Y) LFP(Ŵ(t, x) Y). If the initial equation-error is within a specified tolerance, i.e. e(t 0 ) < L2(Ω) ɛ, then the equation-error at all subsequent times is bounded by the initial equation-error, i.e. e(t) < ɛ. The proof of the above theorem is fairly straightforward and is excluded from the current paper (see Ref. [5]). The above theorem implies that equation error in FPE resulting from the modal basis actually reduces with time. In fact, a stronger result can be stated that the equation error is bounded above by an exponentially decaying envelope [5]. C. Filter Measurement Update The measurement update in a nonlinear Bayes filter is a computationally expensive step that requires implementation of the Bayes update rule. In most existing papers on projection-type nonlinear filters (e.g., see Beard [24]), this is achieved by solving the Bayes rule in weak form. This involves reducing Eq.4 to a discretized finite dimensional algebraic form via variational formulation: Ka = f, where K and f are the measurement stiffness matrix and load vector respectively. Unfortunately, neither K nor f can be computed off-line because they require input from the incoming new measurements. Because of the large size of K, this step cannot be completed fast enough for filtering applications. The current paper presents an accelerated method of implementing the measurement update step. Using the functional representation of the prior pdf from the propagation step (Eq.11) and the functional form of the likelihood function, the numerator of the RHS of Eq.4 is constructed. This is nothing but the un-normalized posterior state pdf. Next, a Markov chain Monte Carlo (MCMC) routine, such as the Metropolis-Hastings algorithm is run to generate a small sized sample from this un-normalized posterior. The motivation behind this step is to obtain a small-sized representation of the posterior density function. Let us denote this sample and the associated un-normalized probabilities by (ξ, W(ξ Y k )). Examples of such samples in 1 and 2 dimensions are shown in Fig.1. The sample size is typically very small, e.g. of the order of a few hundred points. Next, a least-squares function approximator is executed on this sample using the admissible eigenfunctions of the FP operator ({φ i } card(a) ) as basis functions. This results in the following normal equations: card(a) á + i (t k)φ i (x), φ j (x) = W(ξ Y k ), φ j (ξ) (12) where, á + i (t k) represent undetermined coefficients approximating the un-normalized posterior density function. The above system is equivalent to: Má = f, where the mass matrix M can be pre-computed. Only the load vector, f, in the RHS is required to be computed online as new measurements come in. This is much faster than the variational formulation of the Bayes update rule, which requires online computation of a measurement stiffness matrix. No such matrix is involved in the above formulation. We are now left with the task of computing the normalization factor, i.e. the denominator of Eq.4. Note that it is not possible to determine the normalization factor of Ŵ (x Y k) from its generated MCMC sample. Therefore, looking closer at the denominator of Eq.4, we treat it as the integral of the prior, weighted by the likelihood function. In the MCMC framework, this requires us to generate a sample of the likelihood function, which is a trivial task because it is Gaussian in nature. Thus the normalization constant can be computed as a weighted sum of the prior evaluated at points sampled from the likelihood function: W(ξ Y k 1 )W(y k ξ)dξ 1 N W(ζ i Y k 1 ); Ω N where, {ζ i } N W(y k x) (13) D. Filter Initialization From the propagation part, we know that the state conditional pdf is characterized in terms of the admissible eigenfunctions (φ A) of the FP operator. Therefore in filter initialization, we are required to find the modal coefficients at time t 0, i.e. á i (t 0 ). In the current filter, this is done by solving a function approximation problem using the pre-

5 + Actual pdf (un-normalized) MCMC Sample + MCMC Sample (a) MCMC samples for a bimodal pdf in 1D (b) MCMC samples for a bimodal pdf in 2D Fig. 1. MCMC sampling of probability density functions (Metropolis-Hastings algorithm) computed admissible eigenfunctions of the FP operator as basis functions. The function being approximated is the given initial state uncertainty distribution, W( x 0 ). As in the measurement update step, this can also be achieved via MCMC sampling using the same pre-computed mass matrix. We are thus led to the initial uncertainty estimate: Ŵ(x 0 Y 0 ) = card(a) á + i (t 0)φ (x). The superscript + signifies that the above pdf is a posterior, in accordance with the assumption made earlier that the filter is set into motion by propagation rather than update. In other words, if there is a measurement update involved at t = 0, it is assumed to be built into the function W( x 0 ). III. RESULTS Consider first a two-state nonlinear oscillator modeled by the Duffing equation with state-multiplied noise: ẍ + 2ηẋ x + ɛx 3 = xg 1 (t) + G 2 (t). The two independent components of noise, G 1 and G 1 have intensities D 11 and D 22. We consider the case of D 11 = 0.0 for easy comparison with the extended Kalman filter. Note that the current method is fully equipped to deal with state multiplied noise. Values of other parameters used are: η = 0.1, ɛ = 0.5 and D 22 = 0.4. An artificial measurement model measuring system energy is considered: h(x, ẋ) = x 2 +ηẋ 2 +ɛx 4. Measurement noise is assumed to be R = 2 and measurements are assumed to arrive every 9 seconds. The initial state distribution is given by the following Gaussian pdf: N({5, 5}, 0.5I 2 2 ). Filter-errors are plotted in Figs.2(a) and 2(b) along with 3-σ confidence bounds. Fig. 2(c) shows conditional densities obtained from the nonlinear filter at four time instants. It is instructive to consider Fig.2(c) first: since the measurement model does not provide unique information about the state (model is symmteric about the x and ẋ axis), the measurement update is unable to convert the bimodal prior into a unimodal function. Due to the nature of the measurement model, the posterior is bimodal, i.e., the update step only makes the two modes sharper (see Fig.2(c)) rather than eliminating one of the modes. On the other hand, the EKF estimate of state x tends to drift away from the truth, and despite tuning efforts, leads to inconsistent behavior. This is clearly apparent in Fig.2(a), wherein the filter error in x breaks the EKF 3 σ confidence boundary. This behavior is due to the ambiguity introduced by the measurement model in conjunction with long propagation time and high process noise. The key result of this paper is the time of computation for the measurement update step. The results presented in this section were obtained using modest computing resources: 1.86 GHz Pentium M processor with 1 GB RAM. For this machine, the time required for the measurement step for the current method was about 2 seconds. Note that with the time between measurements being 9 s, this filter is feasible in real time. However, the variational form of the Bayes rule for this system as described in Refs. [24], [25] requires about 400 s on the same computing platform. Therefore, the current approach for measurement update is clearly superior to variational implementation of Bayes rule and represents a significant step towards real-time feasibility of a FPE based nonlinear filter. System 2: Filtering in 4D: (Coupled Vibration Isolation Suspension) We next consider a coupled two-degree-offreedom (i.e. four-state) nonlinear vibration isolating suspension model studied by Ariaratnam [29]: x 1 = x 3, x 2 = x 4 x 3 = αx 3 1 M x 4 = βx 4 1 I V + ζ 1 x 1 V + ζ 2 (14) x 2 In this example, we consider a 2 dimensional measurement model in which the state-rates, x 1 and x 2, i.e. x 3 and x 4 are measured. The measurements are assumed to arrive every 4 seconds with an error covariance matrix of 5I 2 2. Error estimates in the various states are shown in Figs.3(a) and 3(b). The behavior of EKF for this system was observed to be unpredictable because different noise samples led to different steady state behaviors of x 2. This is a result of high process noise coupled with relatively long propagation times, causing the EKF errors to border on inconsistency (see error estimates of states x 2 and x 4 in Figs.3(a),3(b)). On the

6 EKF FPE/MCMC Based EKF FPE/MCMC Based (a) Comparative error estimates for x prior pdfs (b) Comparative error estimates for ẋ posterior pdfs t = 54 s t = 18 s t = 9 s t = 0 s (c) Full state pdf t = 0s to t = 54s Fig. 2. State estimates and conditional pdfs for the Duffing oscillator. EKF FPE Based EKF FPE Based (a) Comparative error estimates for x 1 and x 2. (b) Comparative error estimates for x 3 and x 4. Fig. 3. Error estimates for system 2. other hand, with only the information available about the states x 3 and x 4, the FPE based filter is unable to decide between the two modes of the system. For this system, the measurement update step was about 500 times faster using the MCMC sampling based technique than the variational form technique. IV. CONCLUSIONS In this paper, a nonlinear filter based on Fokker-Planck equation for propagation and MCMC based Bayes rule for measurement update was presented. FPE for the propagation phase was solved in real time using a robust semianalytical meshless technique developed in previous work. The measurement update was implemented as a function approximation problem on a small MCMC sample of the unnormalized posterior density obtained from the Bayes rule. Considerable speed-up in the update step (as compared with weak formulation of the Bayes rule) was reported. Examples were presented in 2 and 4 dimensional state space systems to demonstrate the effectiveness of this filter. Significant improvement in the time required for enforcing measurement updates are obtained. This is an important step towards the realization of a real time FPE based nonlinear filter. Work is currently under progress to implement this filter on more complex problems.

7 REFERENCES [1] R. E. Kalman, A New Approach to Linear Filtering and Prediction Problems, Trans. ASME J. of Basic Engr., pp 35-45, [2] F. E. Daum, Exact Finite-Dimensional Nonlinear Filters, Tr. Auto. Cont., Vol. AC-31, No. 7, pp , [3] A. T. Fuller, Analysis of nonlinear stochastic Systems by Means of the Fokker-Planck Equation, Int. J. Cont., vol. 9, no. 6, pp , [4] M. Kumar, S. Chakravorty, P. Singla, and J. L.Junkins, The Partition of Unity Finite Element Approach with hp-refinement for the Stationary Fokker-Planck Equation, J Sound and Vib., Vol. 327, No. 1-2, 2009, pp [5] M. Kumar and S. Chakravorty and J. L. Junkins, A Semianalytic Meshless Approach to the Transient Fokker-Planck Equation, Prob. Engr. Mech., article in print. [6] M. Kumar and S. Chakravorty, On the Curse of Dimesionality in Fokker-Planck Equation, Prob. Engr. Mech., under review [7] B. Azimi-Sadjadi and B. S. Krishnaprasad, Approximate Nonlinear Filtering and its Application in Navigation, Automatica, Vol. 41, 2005, pp [8] R. S. Park and D. Scheeres, Nonlinear Mapping of Gaussian State Uncertainties: Theory and Applications to Spacecraft Trajectory Design, J. Guid. Cont. Dyn., Vol. 29, No. 6, pp , [9] M. Majji, J. L. Junkins and J. D. Turner, J th Moment Extended Kalman Filtering for Estimation of Nonlinear Dynamic Systems, Proc. AIAA Guid. Nav. Cont. Conf., Aug 2008, Honolulu, HI. [10] M. S. Arulampalam, S. Maskell, N. Gordon and T. Clapp, A Tutorial on Particle Filters for Online Nonlinear/Non-Gaussian Bayesian Tracking, Tr. Sig. Proc., Vol. 50, No. 2, pp , [11] Z. Chen, Bayesian Filtering: From Kalman Filters to Particle Filters, and Beyond, Technical Report, Communications Research Laboratory, McMaster University, available form: filtering Chen.pdf [12] A. Budhiraja, L. Chen and C. Lee, A Survey of Numerical Methods for Nonlinear Filtering Problems, Physica D, Vol. 230, pp , [13] A. Doucet, J. F. G. defreitas and N. J. Gordon, An Introduction to Sequential Monte Carlo Methods, in Seq. MC Meth. in Practice, New York, Springer Verlag, [14] J. Carpenter, P. Clifford and P. Fearnhead, Improved Particle Filter for Nonlinear Problems, Proc. Inst. Elec. Engg. Radar; Sonar; Nav, [15] J. H. Kotecha and P. M. Djuric, Gaussian Particle Filtering, IEEE Tr. Sig. Proc, Vol. 51, No. 10, pp , [16] H. Wu and F. Sun, Fuzzy Particle Filtering for Uncertain Systems, IEEE Tr. Fuzzy Sys., Vol. 16, No. 5, pp , [17] N. Gordon, N. Salmond and A. F. M. Smith, A Novel Approach to Nonlinear and Non-Gaussian Bayesian State Estimation, Proc. Inst. Elec. Engg., Vol. 140, pp , [18] F. Pei, P. Cui and Y. Chen, Adaptive MCMC Particle Filter for Nonlinear and Non-Gaussian State Estimation, Proc. IEEE Int. Conf. Innov. Comput. Info., Jun , China. [19] D. Brigo, B. Hanzon and F. Le Gland, Approximate Nonlinear Filtering by Projection on Exponential Manifolds of Densities, Bernoulli, Vol. 5, No. 3, pp , [20] Y. Xu and P. Vedula, A Quadrature Based Method of Moments for Nonlinear Filtering, Automatica, Vol. 45, pp , [21] D. L. Alspach amd H. W. Sorensen, Nonlinear Bayesian estiamtion using Gaussian Sum Approximations, IEEE Tr. Auto. Cont., AC- 17, pp , [22] J. H. Kotecha and P. M. Djuric, Gaussian Sum Particle Filtering, IEEE Tr. Sig. Proc, Vol. 51, No. 10, pp , [23] G. Terejanu, P. Singla, T. Singh and P. D. Scott, Gaussian Sum Filter with Weights Adaption between obs., Sig. Proc., in review. [24] R. Beard, J. Kenney, J. Gunther, J. Lawton and W. Stirling, Nonlinear Projection Filter Based on Galerkin Approximation, J. Guid., Cont. Dyn., vol. 22, no. 2, March-April [25] M. Kumar and S. Chakravorty, A Nonlinear Filter Based on Fokker- Planck Equation, Proc. American Cont. Conf., Jun 30-Jul , Baltimore MD. [26] S. Chib and E. Greenberg, Understanding the Metropolis-Hastings Algorithm, American Statistician, Vol. 49, No. 4, pp , [27] M. Griebel and M. A. Schweitzer, A Particle-Partition of Unity Method for the Solution of Elliptic, Parabolic and Hyperbolic PDEs, SIAM J. Sci. Comput., Vol. 22, pp , [28] M. Griebel and M. A. Schweitzer, A Particle-Partition of Unity Method Part II: Efficient Cover Construction and Reliable Integration, Sonderforschungsbereich 256, Institut für Angewandte Mathematik, Universität Bonn [29] S. T. Ariaratnam, Random Vibration of Nonlinear Suspensions, J Mech. Engr. Sc., Vol 2., No. 3, 1960, pp

D (1) i + x i. i=1. j=1

D (1) i + x i. i=1. j=1 A SEMIANALYTIC MESHLESS APPROACH TO THE TRANSIENT FOKKER-PLANCK EQUATION Mrinal Kumar, Suman Chakravorty, and John L. Junkins Texas A&M University, College Station, TX 77843 mrinal@neo.tamu.edu, schakrav@aeromail.tamu.edu,

More information

A Novel Gaussian Sum Filter Method for Accurate Solution to Nonlinear Filtering Problem

A Novel Gaussian Sum Filter Method for Accurate Solution to Nonlinear Filtering Problem A Novel Gaussian Sum Filter Method for Accurate Solution to Nonlinear Filtering Problem Gabriel Terejanu a Puneet Singla b Tarunraj Singh b Peter D. Scott a Graduate Student Assistant Professor Professor

More information

Sensor Fusion: Particle Filter

Sensor Fusion: Particle Filter Sensor Fusion: Particle Filter By: Gordana Stojceska stojcesk@in.tum.de Outline Motivation Applications Fundamentals Tracking People Advantages and disadvantages Summary June 05 JASS '05, St.Petersburg,

More information

Uncertainty Propagation for Nonlinear Dynamical Systems using Gaussian Mixture Models

Uncertainty Propagation for Nonlinear Dynamical Systems using Gaussian Mixture Models Uncertainty Propagation for Nonlinear Dynamical Systems using Gaussian Mixture Models Gabriel Terejanu, Puneet Singla, Tarunraj Singh, Peter D. Scott A Gaussian mixture model approach is proposed for accurate

More information

The Partition of Unity Finite Element Approach to the Stationary Fokker-Planck Equation

The Partition of Unity Finite Element Approach to the Stationary Fokker-Planck Equation The Partition of Unity Finite Element Approach to the Stationary Fokker-Planck Equation Mrinal Kumar, Puneet Singla, Suman Chakravorty and John L. Junkins Texas A&M University, College Station, TX, 77840,

More information

Dynamic System Identification using HDMR-Bayesian Technique

Dynamic System Identification using HDMR-Bayesian Technique Dynamic System Identification using HDMR-Bayesian Technique *Shereena O A 1) and Dr. B N Rao 2) 1), 2) Department of Civil Engineering, IIT Madras, Chennai 600036, Tamil Nadu, India 1) ce14d020@smail.iitm.ac.in

More information

Title: A Homotopic Approach to Domain Determination and Solution Refinement for the Stationary Fokker- Planck Equation

Title: A Homotopic Approach to Domain Determination and Solution Refinement for the Stationary Fokker- Planck Equation Elsevier Editorial System(tm) for Probabilistic Engineering Mechanics Manuscript Draft Manuscript Number: Title: A Homotopic Approach to Domain Determination and Solution Refinement for the Stationary

More information

State Estimation using Moving Horizon Estimation and Particle Filtering

State Estimation using Moving Horizon Estimation and Particle Filtering State Estimation using Moving Horizon Estimation and Particle Filtering James B. Rawlings Department of Chemical and Biological Engineering UW Math Probability Seminar Spring 2009 Rawlings MHE & PF 1 /

More information

Human Pose Tracking I: Basics. David Fleet University of Toronto

Human Pose Tracking I: Basics. David Fleet University of Toronto Human Pose Tracking I: Basics David Fleet University of Toronto CIFAR Summer School, 2009 Looking at People Challenges: Complex pose / motion People have many degrees of freedom, comprising an articulated

More information

EVALUATING SYMMETRIC INFORMATION GAP BETWEEN DYNAMICAL SYSTEMS USING PARTICLE FILTER

EVALUATING SYMMETRIC INFORMATION GAP BETWEEN DYNAMICAL SYSTEMS USING PARTICLE FILTER EVALUATING SYMMETRIC INFORMATION GAP BETWEEN DYNAMICAL SYSTEMS USING PARTICLE FILTER Zhen Zhen 1, Jun Young Lee 2, and Abdus Saboor 3 1 Mingde College, Guizhou University, China zhenz2000@21cn.com 2 Department

More information

RESEARCH ARTICLE. Online quantization in nonlinear filtering

RESEARCH ARTICLE. Online quantization in nonlinear filtering Journal of Statistical Computation & Simulation Vol. 00, No. 00, Month 200x, 3 RESEARCH ARTICLE Online quantization in nonlinear filtering A. Feuer and G. C. Goodwin Received 00 Month 200x; in final form

More information

NONLINEAR BAYESIAN FILTERING FOR STATE AND PARAMETER ESTIMATION

NONLINEAR BAYESIAN FILTERING FOR STATE AND PARAMETER ESTIMATION NONLINEAR BAYESIAN FILTERING FOR STATE AND PARAMETER ESTIMATION Kyle T. Alfriend and Deok-Jin Lee Texas A&M University, College Station, TX, 77843-3141 This paper provides efficient filtering algorithms

More information

Bayesian Methods for Machine Learning

Bayesian Methods for Machine Learning Bayesian Methods for Machine Learning CS 584: Big Data Analytics Material adapted from Radford Neal s tutorial (http://ftp.cs.utoronto.ca/pub/radford/bayes-tut.pdf), Zoubin Ghahramni (http://hunch.net/~coms-4771/zoubin_ghahramani_bayesian_learning.pdf),

More information

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Background Data Assimilation Iterative process Forecast Analysis Background

More information

2D Image Processing (Extended) Kalman and particle filter

2D Image Processing (Extended) Kalman and particle filter 2D Image Processing (Extended) Kalman and particle filter Prof. Didier Stricker Dr. Gabriele Bleser Kaiserlautern University http://ags.cs.uni-kl.de/ DFKI Deutsches Forschungszentrum für Künstliche Intelligenz

More information

ABC methods for phase-type distributions with applications in insurance risk problems

ABC methods for phase-type distributions with applications in insurance risk problems ABC methods for phase-type with applications problems Concepcion Ausin, Department of Statistics, Universidad Carlos III de Madrid Joint work with: Pedro Galeano, Universidad Carlos III de Madrid Simon

More information

Bayesian Inverse problem, Data assimilation and Localization

Bayesian Inverse problem, Data assimilation and Localization Bayesian Inverse problem, Data assimilation and Localization Xin T Tong National University of Singapore ICIP, Singapore 2018 X.Tong Localization 1 / 37 Content What is Bayesian inverse problem? What is

More information

Stochastic Spectral Approaches to Bayesian Inference

Stochastic Spectral Approaches to Bayesian Inference Stochastic Spectral Approaches to Bayesian Inference Prof. Nathan L. Gibson Department of Mathematics Applied Mathematics and Computation Seminar March 4, 2011 Prof. Gibson (OSU) Spectral Approaches to

More information

Density Approximation Based on Dirac Mixtures with Regard to Nonlinear Estimation and Filtering

Density Approximation Based on Dirac Mixtures with Regard to Nonlinear Estimation and Filtering Density Approximation Based on Dirac Mixtures with Regard to Nonlinear Estimation and Filtering Oliver C. Schrempf, Dietrich Brunn, Uwe D. Hanebeck Intelligent Sensor-Actuator-Systems Laboratory Institute

More information

ECE276A: Sensing & Estimation in Robotics Lecture 10: Gaussian Mixture and Particle Filtering

ECE276A: Sensing & Estimation in Robotics Lecture 10: Gaussian Mixture and Particle Filtering ECE276A: Sensing & Estimation in Robotics Lecture 10: Gaussian Mixture and Particle Filtering Lecturer: Nikolay Atanasov: natanasov@ucsd.edu Teaching Assistants: Siwei Guo: s9guo@eng.ucsd.edu Anwesan Pal:

More information

A Note on Auxiliary Particle Filters

A Note on Auxiliary Particle Filters A Note on Auxiliary Particle Filters Adam M. Johansen a,, Arnaud Doucet b a Department of Mathematics, University of Bristol, UK b Departments of Statistics & Computer Science, University of British Columbia,

More information

Computer Vision Group Prof. Daniel Cremers. 11. Sampling Methods

Computer Vision Group Prof. Daniel Cremers. 11. Sampling Methods Prof. Daniel Cremers 11. Sampling Methods Sampling Methods Sampling Methods are widely used in Computer Science as an approximation of a deterministic algorithm to represent uncertainty without a parametric

More information

Particle Filters: Convergence Results and High Dimensions

Particle Filters: Convergence Results and High Dimensions Particle Filters: Convergence Results and High Dimensions Mark Coates mark.coates@mcgill.ca McGill University Department of Electrical and Computer Engineering Montreal, Quebec, Canada Bellairs 2012 Outline

More information

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond Department of Biomedical Engineering and Computational Science Aalto University January 26, 2012 Contents 1 Batch and Recursive Estimation

More information

Sequential Monte Carlo Methods for Bayesian Computation

Sequential Monte Carlo Methods for Bayesian Computation Sequential Monte Carlo Methods for Bayesian Computation A. Doucet Kyoto Sept. 2012 A. Doucet (MLSS Sept. 2012) Sept. 2012 1 / 136 Motivating Example 1: Generic Bayesian Model Let X be a vector parameter

More information

Computer Vision Group Prof. Daniel Cremers. 14. Sampling Methods

Computer Vision Group Prof. Daniel Cremers. 14. Sampling Methods Prof. Daniel Cremers 14. Sampling Methods Sampling Methods Sampling Methods are widely used in Computer Science as an approximation of a deterministic algorithm to represent uncertainty without a parametric

More information

Learning Static Parameters in Stochastic Processes

Learning Static Parameters in Stochastic Processes Learning Static Parameters in Stochastic Processes Bharath Ramsundar December 14, 2012 1 Introduction Consider a Markovian stochastic process X T evolving (perhaps nonlinearly) over time variable T. We

More information

AN EFFICIENT TWO-STAGE SAMPLING METHOD IN PARTICLE FILTER. Qi Cheng and Pascal Bondon. CNRS UMR 8506, Université Paris XI, France.

AN EFFICIENT TWO-STAGE SAMPLING METHOD IN PARTICLE FILTER. Qi Cheng and Pascal Bondon. CNRS UMR 8506, Université Paris XI, France. AN EFFICIENT TWO-STAGE SAMPLING METHOD IN PARTICLE FILTER Qi Cheng and Pascal Bondon CNRS UMR 8506, Université Paris XI, France. August 27, 2011 Abstract We present a modified bootstrap filter to draw

More information

The Unscented Particle Filter

The Unscented Particle Filter The Unscented Particle Filter Rudolph van der Merwe (OGI) Nando de Freitas (UC Bereley) Arnaud Doucet (Cambridge University) Eric Wan (OGI) Outline Optimal Estimation & Filtering Optimal Recursive Bayesian

More information

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond January 18, 2017 Contents 1 Batch and Recursive Estimation 2 Towards Bayesian Filtering 3 Kalman Filter and Bayesian Filtering and Smoothing

More information

Hastings-within-Gibbs Algorithm: Introduction and Application on Hierarchical Model

Hastings-within-Gibbs Algorithm: Introduction and Application on Hierarchical Model UNIVERSITY OF TEXAS AT SAN ANTONIO Hastings-within-Gibbs Algorithm: Introduction and Application on Hierarchical Model Liang Jing April 2010 1 1 ABSTRACT In this paper, common MCMC algorithms are introduced

More information

27 : Distributed Monte Carlo Markov Chain. 1 Recap of MCMC and Naive Parallel Gibbs Sampling

27 : Distributed Monte Carlo Markov Chain. 1 Recap of MCMC and Naive Parallel Gibbs Sampling 10-708: Probabilistic Graphical Models 10-708, Spring 2014 27 : Distributed Monte Carlo Markov Chain Lecturer: Eric P. Xing Scribes: Pengtao Xie, Khoa Luu In this scribe, we are going to review the Parallel

More information

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision The Particle Filter Non-parametric implementation of Bayes filter Represents the belief (posterior) random state samples. by a set of This representation is approximate. Can represent distributions that

More information

Seminar: Data Assimilation

Seminar: Data Assimilation Seminar: Data Assimilation Jonas Latz, Elisabeth Ullmann Chair of Numerical Mathematics (M2) Technical University of Munich Jonas Latz, Elisabeth Ullmann (TUM) Data Assimilation 1 / 28 Prerequisites Bachelor:

More information

Markov Chain Monte Carlo Methods for Stochastic

Markov Chain Monte Carlo Methods for Stochastic Markov Chain Monte Carlo Methods for Stochastic Optimization i John R. Birge The University of Chicago Booth School of Business Joint work with Nicholas Polson, Chicago Booth. JRBirge U Florida, Nov 2013

More information

Extension of the Sparse Grid Quadrature Filter

Extension of the Sparse Grid Quadrature Filter Extension of the Sparse Grid Quadrature Filter Yang Cheng Mississippi State University Mississippi State, MS 39762 Email: cheng@ae.msstate.edu Yang Tian Harbin Institute of Technology Harbin, Heilongjiang

More information

Lecture 6: Bayesian Inference in SDE Models

Lecture 6: Bayesian Inference in SDE Models Lecture 6: Bayesian Inference in SDE Models Bayesian Filtering and Smoothing Point of View Simo Särkkä Aalto University Simo Särkkä (Aalto) Lecture 6: Bayesian Inference in SDEs 1 / 45 Contents 1 SDEs

More information

Using the Kalman Filter to Estimate the State of a Maneuvering Aircraft

Using the Kalman Filter to Estimate the State of a Maneuvering Aircraft 1 Using the Kalman Filter to Estimate the State of a Maneuvering Aircraft K. Meier and A. Desai Abstract Using sensors that only measure the bearing angle and range of an aircraft, a Kalman filter is implemented

More information

Lecture 8: Bayesian Estimation of Parameters in State Space Models

Lecture 8: Bayesian Estimation of Parameters in State Space Models in State Space Models March 30, 2016 Contents 1 Bayesian estimation of parameters in state space models 2 Computational methods for parameter estimation 3 Practical parameter estimation in state space

More information

Self Adaptive Particle Filter

Self Adaptive Particle Filter Self Adaptive Particle Filter Alvaro Soto Pontificia Universidad Catolica de Chile Department of Computer Science Vicuna Mackenna 4860 (143), Santiago 22, Chile asoto@ing.puc.cl Abstract The particle filter

More information

Lecture 7: Optimal Smoothing

Lecture 7: Optimal Smoothing Department of Biomedical Engineering and Computational Science Aalto University March 17, 2011 Contents 1 What is Optimal Smoothing? 2 Bayesian Optimal Smoothing Equations 3 Rauch-Tung-Striebel Smoother

More information

Stochastic Structural Dynamics Prof. Dr. C. S. Manohar Department of Civil Engineering Indian Institute of Science, Bangalore

Stochastic Structural Dynamics Prof. Dr. C. S. Manohar Department of Civil Engineering Indian Institute of Science, Bangalore Stochastic Structural Dynamics Prof. Dr. C. S. Manohar Department of Civil Engineering Indian Institute of Science, Bangalore Lecture No. # 33 Probabilistic methods in earthquake engineering-2 So, we have

More information

Sequential Monte Carlo methods for filtering of unobservable components of multidimensional diffusion Markov processes

Sequential Monte Carlo methods for filtering of unobservable components of multidimensional diffusion Markov processes Sequential Monte Carlo methods for filtering of unobservable components of multidimensional diffusion Markov processes Ellida M. Khazen * 13395 Coppermine Rd. Apartment 410 Herndon VA 20171 USA Abstract

More information

FUNDAMENTAL FILTERING LIMITATIONS IN LINEAR NON-GAUSSIAN SYSTEMS

FUNDAMENTAL FILTERING LIMITATIONS IN LINEAR NON-GAUSSIAN SYSTEMS FUNDAMENTAL FILTERING LIMITATIONS IN LINEAR NON-GAUSSIAN SYSTEMS Gustaf Hendeby Fredrik Gustafsson Division of Automatic Control Department of Electrical Engineering, Linköpings universitet, SE-58 83 Linköping,

More information

2D Image Processing. Bayes filter implementation: Kalman filter

2D Image Processing. Bayes filter implementation: Kalman filter 2D Image Processing Bayes filter implementation: Kalman filter Prof. Didier Stricker Kaiserlautern University http://ags.cs.uni-kl.de/ DFKI Deutsches Forschungszentrum für Künstliche Intelligenz http://av.dfki.de

More information

Computational statistics

Computational statistics Computational statistics Markov Chain Monte Carlo methods Thierry Denœux March 2017 Thierry Denœux Computational statistics March 2017 1 / 71 Contents of this chapter When a target density f can be evaluated

More information

RAO-BLACKWELLISED PARTICLE FILTERS: EXAMPLES OF APPLICATIONS

RAO-BLACKWELLISED PARTICLE FILTERS: EXAMPLES OF APPLICATIONS RAO-BLACKWELLISED PARTICLE FILTERS: EXAMPLES OF APPLICATIONS Frédéric Mustière e-mail: mustiere@site.uottawa.ca Miodrag Bolić e-mail: mbolic@site.uottawa.ca Martin Bouchard e-mail: bouchard@site.uottawa.ca

More information

Introduction to Particle Filters for Data Assimilation

Introduction to Particle Filters for Data Assimilation Introduction to Particle Filters for Data Assimilation Mike Dowd Dept of Mathematics & Statistics (and Dept of Oceanography Dalhousie University, Halifax, Canada STATMOS Summer School in Data Assimila5on,

More information

Bayesian Nonparametric Regression for Diabetes Deaths

Bayesian Nonparametric Regression for Diabetes Deaths Bayesian Nonparametric Regression for Diabetes Deaths Brian M. Hartman PhD Student, 2010 Texas A&M University College Station, TX, USA David B. Dahl Assistant Professor Texas A&M University College Station,

More information

PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 13: SEQUENTIAL DATA

PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 13: SEQUENTIAL DATA PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 13: SEQUENTIAL DATA Contents in latter part Linear Dynamical Systems What is different from HMM? Kalman filter Its strength and limitation Particle Filter

More information

Markov Chain Monte Carlo Methods for Stochastic Optimization

Markov Chain Monte Carlo Methods for Stochastic Optimization Markov Chain Monte Carlo Methods for Stochastic Optimization John R. Birge The University of Chicago Booth School of Business Joint work with Nicholas Polson, Chicago Booth. JRBirge U of Toronto, MIE,

More information

A Statistical Input Pruning Method for Artificial Neural Networks Used in Environmental Modelling

A Statistical Input Pruning Method for Artificial Neural Networks Used in Environmental Modelling A Statistical Input Pruning Method for Artificial Neural Networks Used in Environmental Modelling G. B. Kingston, H. R. Maier and M. F. Lambert Centre for Applied Modelling in Water Engineering, School

More information

Nonlinear Measurement Update and Prediction: Prior Density Splitting Mixture Estimator

Nonlinear Measurement Update and Prediction: Prior Density Splitting Mixture Estimator Nonlinear Measurement Update and Prediction: Prior Density Splitting Mixture Estimator Andreas Rauh, Kai Briechle, and Uwe D Hanebec Member, IEEE Abstract In this paper, the Prior Density Splitting Mixture

More information

Particle Filtering Approaches for Dynamic Stochastic Optimization

Particle Filtering Approaches for Dynamic Stochastic Optimization Particle Filtering Approaches for Dynamic Stochastic Optimization John R. Birge The University of Chicago Booth School of Business Joint work with Nicholas Polson, Chicago Booth. JRBirge I-Sim Workshop,

More information

Answers and expectations

Answers and expectations Answers and expectations For a function f(x) and distribution P(x), the expectation of f with respect to P is The expectation is the average of f, when x is drawn from the probability distribution P E

More information

New Advances in Uncertainty Analysis and Estimation

New Advances in Uncertainty Analysis and Estimation New Advances in Uncertainty Analysis and Estimation Overview: Both sensor observation data and mathematical models are used to assist in the understanding of physical dynamic systems. However, observational

More information

Acceptance probability of IP-MCMC-PF: revisited

Acceptance probability of IP-MCMC-PF: revisited Acceptance probability of IP-MCMC-PF: revisited Fernando J. Iglesias García, Mélanie Bocquel, Pranab K. Mandal, and Hans Driessen. Sensors Development System Engineering, Thales Nederland B.V. Hengelo,

More information

A Monte Carlo Sequential Estimation for Point Process Optimum Filtering

A Monte Carlo Sequential Estimation for Point Process Optimum Filtering 2006 International Joint Conference on Neural Networks Sheraton Vancouver Wall Centre Hotel, Vancouver, BC, Canada July 16-21, 2006 A Monte Carlo Sequential Estimation for Point Process Optimum Filtering

More information

Imprecise Filtering for Spacecraft Navigation

Imprecise Filtering for Spacecraft Navigation Imprecise Filtering for Spacecraft Navigation Tathagata Basu Cristian Greco Thomas Krak Durham University Strathclyde University Ghent University Filtering for Spacecraft Navigation The General Problem

More information

Sensor Tasking and Control

Sensor Tasking and Control Sensor Tasking and Control Sensing Networking Leonidas Guibas Stanford University Computation CS428 Sensor systems are about sensing, after all... System State Continuous and Discrete Variables The quantities

More information

NONLINEAR STATISTICAL SIGNAL PROCESSING: A PARTI- CLE FILTERING APPROACH

NONLINEAR STATISTICAL SIGNAL PROCESSING: A PARTI- CLE FILTERING APPROACH NONLINEAR STATISTICAL SIGNAL PROCESSING: A PARTI- CLE FILTERING APPROACH J. V. Candy (tsoftware@aol.com) University of California, Lawrence Livermore National Lab. & Santa Barbara Livermore CA 94551 USA

More information

Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation

Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation IEEE TRANSACTIONS ON AUTOMATIC CONTROL Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation Gabriel Terejanu, Puneet Singla, Tarunraj Singh, Peter D. Scott Abstract A nonlinear filter is developed

More information

Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation

Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation IEEE TRANSACTIONS ON AUTOMATIC CONTROL Adaptive Gaussian Sum Filter for Nonlinear Bayesian Estimation Gabriel Terejanu, Puneet Singla, Tarunraj Singh, Peter D. Scott Abstract A nonlinear filter is developed

More information

Efficient Monitoring for Planetary Rovers

Efficient Monitoring for Planetary Rovers International Symposium on Artificial Intelligence and Robotics in Space (isairas), May, 2003 Efficient Monitoring for Planetary Rovers Vandi Verma vandi@ri.cmu.edu Geoff Gordon ggordon@cs.cmu.edu Carnegie

More information

DESIGN AND IMPLEMENTATION OF SENSORLESS SPEED CONTROL FOR INDUCTION MOTOR DRIVE USING AN OPTIMIZED EXTENDED KALMAN FILTER

DESIGN AND IMPLEMENTATION OF SENSORLESS SPEED CONTROL FOR INDUCTION MOTOR DRIVE USING AN OPTIMIZED EXTENDED KALMAN FILTER INTERNATIONAL JOURNAL OF ELECTRONICS AND COMMUNICATION ENGINEERING & TECHNOLOGY (IJECET) International Journal of Electronics and Communication Engineering & Technology (IJECET), ISSN 0976 ISSN 0976 6464(Print)

More information

Gaussian Filters for Nonlinear Filtering Problems

Gaussian Filters for Nonlinear Filtering Problems 910 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 45, NO. 5, MAY 2000 Gaussian Filters for Nonlinear Filtering Problems Kazufumi Ito Kaiqi Xiong Abstract In this paper we develop analyze real-time accurate

More information

Tuning of Extended Kalman Filter for nonlinear State Estimation

Tuning of Extended Kalman Filter for nonlinear State Estimation OSR Journal of Computer Engineering (OSR-JCE) e-ssn: 78-0661,p-SSN: 78-877, Volume 18, ssue 5, Ver. V (Sep. - Oct. 016), PP 14-19 www.iosrjournals.org Tuning of Extended Kalman Filter for nonlinear State

More information

AN ADAPTIVE GAUSSIAN SUM FILTER FOR THE SPACECRAFT ATTITUDE ESTIMATION PROBLEM

AN ADAPTIVE GAUSSIAN SUM FILTER FOR THE SPACECRAFT ATTITUDE ESTIMATION PROBLEM AAS 8-262 AN ADAPTIVE GAUSSIAN SUM FILTER FOR THE SPACECRAFT ATTITUDE ESTIMATION PROBLEM Gabriel Terejanu Jemin George and Puneet Singla The present paper is concerned with improving the attitude estimation

More information

Performance Evaluation of Generalized Polynomial Chaos

Performance Evaluation of Generalized Polynomial Chaos Performance Evaluation of Generalized Polynomial Chaos Dongbin Xiu, Didier Lucor, C.-H. Su, and George Em Karniadakis 1 Division of Applied Mathematics, Brown University, Providence, RI 02912, USA, gk@dam.brown.edu

More information

ECO 513 Fall 2009 C. Sims HIDDEN MARKOV CHAIN MODELS

ECO 513 Fall 2009 C. Sims HIDDEN MARKOV CHAIN MODELS ECO 513 Fall 2009 C. Sims HIDDEN MARKOV CHAIN MODELS 1. THE CLASS OF MODELS y t {y s, s < t} p(y t θ t, {y s, s < t}) θ t = θ(s t ) P[S t = i S t 1 = j] = h ij. 2. WHAT S HANDY ABOUT IT Evaluating the

More information

Kalman filtering and friends: Inference in time series models. Herke van Hoof slides mostly by Michael Rubinstein

Kalman filtering and friends: Inference in time series models. Herke van Hoof slides mostly by Michael Rubinstein Kalman filtering and friends: Inference in time series models Herke van Hoof slides mostly by Michael Rubinstein Problem overview Goal Estimate most probable state at time k using measurement up to time

More information

arxiv: v1 [stat.co] 23 Apr 2018

arxiv: v1 [stat.co] 23 Apr 2018 Bayesian Updating and Uncertainty Quantification using Sequential Tempered MCMC with the Rank-One Modified Metropolis Algorithm Thomas A. Catanach and James L. Beck arxiv:1804.08738v1 [stat.co] 23 Apr

More information

Automatic Differentiation Equipped Variable Elimination for Sensitivity Analysis on Probabilistic Inference Queries

Automatic Differentiation Equipped Variable Elimination for Sensitivity Analysis on Probabilistic Inference Queries Automatic Differentiation Equipped Variable Elimination for Sensitivity Analysis on Probabilistic Inference Queries Anonymous Author(s) Affiliation Address email Abstract 1 2 3 4 5 6 7 8 9 10 11 12 Probabilistic

More information

Reliability Theory of Dynamically Loaded Structures (cont.)

Reliability Theory of Dynamically Loaded Structures (cont.) Outline of Reliability Theory of Dynamically Loaded Structures (cont.) Probability Density Function of Local Maxima in a Stationary Gaussian Process. Distribution of Extreme Values. Monte Carlo Simulation

More information

Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems

Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems John Bardsley, University of Montana Collaborators: H. Haario, J. Kaipio, M. Laine, Y. Marzouk, A. Seppänen, A. Solonen, Z.

More information

A Comparison of Particle Filters for Personal Positioning

A Comparison of Particle Filters for Personal Positioning VI Hotine-Marussi Symposium of Theoretical and Computational Geodesy May 9-June 6. A Comparison of Particle Filters for Personal Positioning D. Petrovich and R. Piché Institute of Mathematics Tampere University

More information

A Comparative Study of Nonlinear Filtering Techniques

A Comparative Study of Nonlinear Filtering Techniques A Comparative Study of onlinear Filtering Techniques Adam K. Tilton, Shane Ghiotto and Prashant G. Mehta Abstract In a recent work it is shown that importance sampling can be avoided in the particle filter

More information

Kernel Sequential Monte Carlo

Kernel Sequential Monte Carlo Kernel Sequential Monte Carlo Ingmar Schuster (Paris Dauphine) Heiko Strathmann (University College London) Brooks Paige (Oxford) Dino Sejdinovic (Oxford) * equal contribution April 25, 2016 1 / 37 Section

More information

Bagging During Markov Chain Monte Carlo for Smoother Predictions

Bagging During Markov Chain Monte Carlo for Smoother Predictions Bagging During Markov Chain Monte Carlo for Smoother Predictions Herbert K. H. Lee University of California, Santa Cruz Abstract: Making good predictions from noisy data is a challenging problem. Methods

More information

2D Image Processing. Bayes filter implementation: Kalman filter

2D Image Processing. Bayes filter implementation: Kalman filter 2D Image Processing Bayes filter implementation: Kalman filter Prof. Didier Stricker Dr. Gabriele Bleser Kaiserlautern University http://ags.cs.uni-kl.de/ DFKI Deutsches Forschungszentrum für Künstliche

More information

9 Multi-Model State Estimation

9 Multi-Model State Estimation Technion Israel Institute of Technology, Department of Electrical Engineering Estimation and Identification in Dynamical Systems (048825) Lecture Notes, Fall 2009, Prof. N. Shimkin 9 Multi-Model State

More information

CERTAIN THOUGHTS ON UNCERTAINTY ANALYSIS FOR DYNAMICAL SYSTEMS

CERTAIN THOUGHTS ON UNCERTAINTY ANALYSIS FOR DYNAMICAL SYSTEMS CERTAIN THOUGHTS ON UNCERTAINTY ANALYSIS FOR DYNAMICAL SYSTEMS Puneet Singla Assistant Professor Department of Mechanical & Aerospace Engineering University at Buffalo, Buffalo, NY-1426 Probabilistic Analysis

More information

Particle Filters. Outline

Particle Filters. Outline Particle Filters M. Sami Fadali Professor of EE University of Nevada Outline Monte Carlo integration. Particle filter. Importance sampling. Degeneracy Resampling Example. 1 2 Monte Carlo Integration Numerical

More information

Exercises Tutorial at ICASSP 2016 Learning Nonlinear Dynamical Models Using Particle Filters

Exercises Tutorial at ICASSP 2016 Learning Nonlinear Dynamical Models Using Particle Filters Exercises Tutorial at ICASSP 216 Learning Nonlinear Dynamical Models Using Particle Filters Andreas Svensson, Johan Dahlin and Thomas B. Schön March 18, 216 Good luck! 1 [Bootstrap particle filter for

More information

Towards inference for skewed alpha stable Levy processes

Towards inference for skewed alpha stable Levy processes Towards inference for skewed alpha stable Levy processes Simon Godsill and Tatjana Lemke Signal Processing and Communications Lab. University of Cambridge www-sigproc.eng.cam.ac.uk/~sjg Overview Motivation

More information

Approximate Inference

Approximate Inference Approximate Inference Simulation has a name: sampling Sampling is a hot topic in machine learning, and it s really simple Basic idea: Draw N samples from a sampling distribution S Compute an approximate

More information

Local Positioning with Parallelepiped Moving Grid

Local Positioning with Parallelepiped Moving Grid Local Positioning with Parallelepiped Moving Grid, WPNC06 16.3.2006, niilo.sirola@tut.fi p. 1/?? TA M P E R E U N I V E R S I T Y O F T E C H N O L O G Y M a t h e m a t i c s Local Positioning with Parallelepiped

More information

L09. PARTICLE FILTERING. NA568 Mobile Robotics: Methods & Algorithms

L09. PARTICLE FILTERING. NA568 Mobile Robotics: Methods & Algorithms L09. PARTICLE FILTERING NA568 Mobile Robotics: Methods & Algorithms Particle Filters Different approach to state estimation Instead of parametric description of state (and uncertainty), use a set of state

More information

I. INTRODUCTION 338 IEEE TRANSACTIONS ON AEROSPACE AND ELECTRONIC SYSTEMS VOL. 33, NO. 1 JANUARY 1997

I. INTRODUCTION 338 IEEE TRANSACTIONS ON AEROSPACE AND ELECTRONIC SYSTEMS VOL. 33, NO. 1 JANUARY 1997 VI. CONCLUSION We have shown that dilution of precision terms for relative positioning, using double-difference processing of GPS satellite signals, are bounded by the corresponding dilution of precision

More information

Online monitoring of MPC disturbance models using closed-loop data

Online monitoring of MPC disturbance models using closed-loop data Online monitoring of MPC disturbance models using closed-loop data Brian J. Odelson and James B. Rawlings Department of Chemical Engineering University of Wisconsin-Madison Online Optimization Based Identification

More information

Maneuvering target tracking using an unbiased nearly constant heading model

Maneuvering target tracking using an unbiased nearly constant heading model Maneuvering target tracking using an unbiased nearly constant heading model P.A. Kountouriotis EEE Department Imperial College London SW7 2AZ, UK Email: pk201@imperial.ac.uk Simon Maskell QinetiQ St. Andrews

More information

Development of Stochastic Artificial Neural Networks for Hydrological Prediction

Development of Stochastic Artificial Neural Networks for Hydrological Prediction Development of Stochastic Artificial Neural Networks for Hydrological Prediction G. B. Kingston, M. F. Lambert and H. R. Maier Centre for Applied Modelling in Water Engineering, School of Civil and Environmental

More information

Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3

Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3 2010 American Control Conference Marriott Waterfront, Baltimore, MD, USA June 30-July 02, 2010 WeC17.1 Benjamin L. Pence 1, Hosam K. Fathy 2, and Jeffrey L. Stein 3 (1) Graduate Student, (2) Assistant

More information

Non-particle filters

Non-particle filters Non-particle filters Fred Daum & Misha Krichman Raytheon Company 225 Presidential Way Woburn, MA 01801 ABSTRACT We have developed a new nonlinear filter that is superior to particle filters in five ways:

More information

On Markov chain Monte Carlo methods for tall data

On Markov chain Monte Carlo methods for tall data On Markov chain Monte Carlo methods for tall data Remi Bardenet, Arnaud Doucet, Chris Holmes Paper review by: David Carlson October 29, 2016 Introduction Many data sets in machine learning and computational

More information

A Note on the Particle Filter with Posterior Gaussian Resampling

A Note on the Particle Filter with Posterior Gaussian Resampling Tellus (6), 8A, 46 46 Copyright C Blackwell Munksgaard, 6 Printed in Singapore. All rights reserved TELLUS A Note on the Particle Filter with Posterior Gaussian Resampling By X. XIONG 1,I.M.NAVON 1,2 and

More information

17 : Markov Chain Monte Carlo

17 : Markov Chain Monte Carlo 10-708: Probabilistic Graphical Models, Spring 2015 17 : Markov Chain Monte Carlo Lecturer: Eric P. Xing Scribes: Heran Lin, Bin Deng, Yun Huang 1 Review of Monte Carlo Methods 1.1 Overview Monte Carlo

More information

CSC487/2503: Foundations of Computer Vision. Visual Tracking. David Fleet

CSC487/2503: Foundations of Computer Vision. Visual Tracking. David Fleet CSC487/2503: Foundations of Computer Vision Visual Tracking David Fleet Introduction What is tracking? Major players: Dynamics (model of temporal variation of target parameters) Measurements (relation

More information

A new unscented Kalman filter with higher order moment-matching

A new unscented Kalman filter with higher order moment-matching A new unscented Kalman filter with higher order moment-matching KSENIA PONOMAREVA, PARESH DATE AND ZIDONG WANG Department of Mathematical Sciences, Brunel University, Uxbridge, UB8 3PH, UK. Abstract This

More information

A NEW NONLINEAR FILTER

A NEW NONLINEAR FILTER COMMUNICATIONS IN INFORMATION AND SYSTEMS c 006 International Press Vol 6, No 3, pp 03-0, 006 004 A NEW NONLINEAR FILTER ROBERT J ELLIOTT AND SIMON HAYKIN Abstract A discrete time filter is constructed

More information