Extended Kalman Filter Derivation Example application: frequency tracking

Size: px
Start display at page:

Download "Extended Kalman Filter Derivation Example application: frequency tracking"

Transcription

1 Extended Kalman Filter Derivation Example application: frequency tracking Nonlinear State Space Model Consider the nonlinear state-space model of a random process x n+ = f n (x n )+g n (x n )u n y n = h n (x n )+v n where u u m n v n, v m Q n δ n,m x x x x = R n δ n,m Π Assumes no interaction between the process and measurement noise, u n, v m = J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 2 Nonlinear Functions f n (x n ), g n (x n ) and h n (x n ) are multivariate, time-varying functions. f n, (x n ) f n,2 (x n ) f n (x n )=.. f n,k (x n ) g n, (x n ) g n,m (x n ) g n,2 (x n ) g n,2m (x n ) g n (x n )=..... g n,lm (x n ) g n,lm (x n ) h n, (x n ) h n,2 (x n ) h n (x n )=.. h n,m (x n ) Taylor Series Approximations Now consider a first-order Taylor expansion of f n (x) and h n (x) about ˆx n. f n (x n ) f n (ˆx n )+F n (x n ˆx n ) h n (x n ) h n (ˆx n )+H n (x n ˆx n ) g n (x n ) g n (ˆx n ) where the matrices F n and H n are the Jacobians of f n (x) and h n (x) evaluated at ˆx n = x f n (x) = f n(x) x F n l l G n = g n (ˆx n ) m m H n p p = x h n (x) = h n(x) x x=ˆxn x=ˆxn J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 3 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 4

2 Taylor Series Approximations: Linearization Point Taylor series expansion could be about different estimates of x n for each of the three nonlinear functions ˆx n n is usually used for f n ( ) and g n ( ) ˆx n n is usually used for h n ( ) The best possible estimate should be used in all cases to minimize the error in the Taylor series approximations Note that, even if the estimates ˆx n and ŷ n are unbiased, the estimates ˆx n+ n and ŷ n n will be biased Jacobians In expanded form, the Jacobians are given as follows f n, (x) f n, (x) x() x(2) x f n (x) = f f n,2 (x) f n,2 (x) n(x) x = x() x(2) x h n (x) = h n(x) x = f n,l (x) x() h n, (x) x() h n,2 (x) x(). h n,p (x) x() f n,l (x) x(2) h n, (x) x(2) h n,2 (x) x(2). h n,p (x) x(2) f n, (x) f n,2 (x) f n,l (x) h n, (x) h n,2 (x).... h n,p (x) J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 5 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 6 Affine State Space Approximation x n+ f n (ˆx n )+F n (x n ˆx n )+G n u n = F n x n + f n (ˆx n ) F n ˆx n +G n u n }{{} Requires estimation y n h n (ˆx n )+H n (x n ˆx n )+v n = H n x n +(h n (ˆx n ) H n ˆx n ) +v n }{{} Requires estimation The performance of the extended Kalman filter depends most critically on the accuracy of the Taylor series approximations Most accurate when the state residual (x n ˆx n ) is minimized The EKF simply uses the best estimates that are available at the time that the residuals must be calculated Accounting for the Nonzero Mean x n+ f n (ˆx n )+F n (x n ˆx n )+G n u n y n h n (ˆx n )+H n (x n ˆx n )+v n The Taylor series approximation results in an affine model There are two key differences between this model and the linear model x n and y n have nonzero means The coefficients are now random variables not constants The typical approach to converting this to our linear model is to subtract the means from both sides J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 7 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 8

3 Redefining the Normal Equations The optimal estimate of the state is now defined as the optimal affine transformation of y n ˆx n+ n K o y n + k = K o (y n E[y n ]) + E[x n+ ] In terms of the normal equations we have ˆx n+ n = x n+, col{, y,,y n } col{, y,,y n } 2 col{, y,,y n } = x n+, col{, e,,e n } col{, e,,e n } 2 col{, e,,e n } = µ n+ + nx k= x n+, e k R e,ke k where the first innovation is now defined as e y ŷ = y E[y ] and all the innovations have zero mean by definition Centering the Output Equation E[y n ]=E[h n (ˆx n )] + H n (E[x n ] E[ˆx n ]) + E[v n ] =E[h n (ˆx n )] + H n (E[x n ] E[ˆx n ]) Now if we assume that ˆx n is nearly deterministic (in other words, perfect) then and this simplifies to E[ˆx n ] ˆx n E[h n (ˆx n )] h n (ˆx n ) E[y n ] h n (ˆx n )+H n (E[x n ] ˆx n ) Then the centered output is given by y c,n y n E[y n ] [h n (ˆx n )+H n (x n ˆx n )+v n ] [h n (ˆx n )+H n (E[x n ] ˆx n )] = H n (x n E[x n ]) + v n +(h n (ˆx n ) h n (ˆx n )) + H n (ˆx n ˆx n ) = H n x c,n + v n J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 9 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 The expected value of x n+ is State Mean E[x n+ ]=F n E[x n ]+E[f n (ˆx n )] F n E[ˆx n ]+G n E[u n ] μ n+ = F n μ n +E[f n (ˆx n )] F n E[ˆx n ] = F n (μ n E[ˆx n ]) + E[f n (ˆx n )] Thus we obtain a recursive update equation for the state mean. Again, if we assume that ˆx n is nearly deterministic E[ˆx n ] ˆx n E[f n (ˆx n )] f n (ˆx n ) The mean recursion then simplifies to μ n+ = F n (μ n ˆx n )+f n (ˆx n ) Centering the State μ n+ = F n (μ n ˆx n )+f n (ˆx n ) x c,n+ x n+ μ n+ =(F n x n + f n (ˆx n ) F n ˆx n + G n u n ) (F n μ n + f n (ˆx n ) F n ˆx n ) = F n (x n μ n )+(f n (ˆx n ) f n (ˆx n )) F n (ˆx n ˆx n )+G n u n = F n x c,n + G n u n Thus our complete linearized state space model becomes x c,n+ = F n x c,n + G n u n y c,n = H n x c,n + v n J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 2

4 Linearization Points x n+ f n (ˆx n )+F n (x n ˆx n )+G n u n y n h n (ˆx n )+H n (x n ˆx n )+v n Best estimate of x n for the state prediction is ˆx n ˆx n n Cannot be used for the output estimate because the innovation e n = y n ŷ n is required to calculate ˆx n n Thus, ˆx n ˆx n n is used for the output linearization point These estimates result in several simplifications Estimating the State x c,n+ = F n x c,n + G n u n y c,n = H n x c,n + v n The KF recursions will give us the optimal estimated state for the linearized model, ˆx c,n n and ˆx c,n n Conversion to the state estimates requires estimation of the state mean ˆx n n = ˆx c,n n + μ n ˆx n n = ˆx c,n n + μ n Would be convenient if we could estimate the state directly J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 3 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 4 Predicted State Recursions ( ) μ n+ = F n μn ˆx n n + fn (ˆx n n ) ˆx n+ n = ˆx c,n+ n + μ n+ = [ ] [ ( ) F n ˆx c,n n + Fn μn ˆx n n + fn (ˆx n n ) ] = F n (ˆx c,n n + μ n ) F n ˆx n n + f n (ˆx n n ) = F n ˆx n n F n ˆx n n + f n (ˆx n n ) = f n (ˆx n n ) Filtered State Recursions ˆx n n = ˆx c,n n + μ n = (ˆx c,n n + K f,n e n ) + μn = (ˆx c,n n + μ n ) + Kf,n e n = ˆx n n + K f,n e n Thus the measurement updates can also be obtained directly in terms of the estimated state without having to estimate the state mean! Thus the time update can be obtained directly in terms of the estimated state without having to estimate the mean! ˆx n+ n = f n (ˆx n n ) J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 5 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 6

5 The affine model for the output is Estimating the Output y n h n (ˆx n n )+H n (x n ˆx n n )+v n Then the best affine estimate of y n given L{, y,,y n } is given by ŷ n n = ĥn(ˆx n n )+H n (ˆx n n ˆx n n ) = ĥn(ˆx n n ) h n (ˆx n n ) Innovations It would be convenient if we could express the innovations directly in terms of the observations, rather than the centered observations. This would also eliminate the need to estimate E[y n ]. e n y c,n ŷ c,n n =(y n +E[y n ]) ( ŷ n n +E[y n ] ) = y n ŷ n n y n h n (ˆx n n ) As before, these approximations assume ˆx n n is nearly deterministic ĥ n (ˆx n n ) h n (ˆx n n ) J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 7 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 8 Linearization Summary The Kalman filter is optimal for the standard state space model Minimizes the mean square error of all possible linear estimators The EKF is only approximately optimal (nearly meaningless) Three approximations First- and zero-order Taylor series approximations Assumes ˆx n n is unbiased in the output approximation Assumes ˆx n n and ˆx n n are nearly deterministic It s not clear to me how critical each of these assumptions are Extended Kalman Filter (unsimplified) ˆx = x P =Π e n = y n h n (ˆx n n ) R e,n = R n + H n P n n Hn K f,n = P n n HnR e,n ˆx n n = ˆx n n + K f,n e n ˆx n+ n = f n (ˆx n n ) P n n = P n n K f,n R e,n Kf,n P n+ n = F n P n n F n + G n Q n G n J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 9 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 2

6 Simplifiying the EKF: Filtered Gain There are a number of ways in which these 9 equations can be simplified K f,n = P n n Hn(H n P n n Hn + R n ) R e,n Kf,n ( ) = R e,n R e,nh n P n n = H n P n n P n n = P n n K f,n R e,n K f,n = P n n K f,n H n P n n =(I K f,n H n )P n n Extended Kalman Filter (simplified) The Schmidt extended Kalman filter (EKF) can now be initialized with ˆx = x P =Π and the recursive algorithm can be expressed as K f,n = P n n Hn(H n P n n Hn + R n ) ( ˆx n n = ˆx n n + K f,n yn h n (ˆx n n ) ) ˆx n+ n = f n (ˆx n n ) P n n =(I K f,n H n )P n n P n+ n = F n P n n F n + G n Q n G n J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 2 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver Extended Kalman Filter (complete) A more complete algorithm is as follows ˆx = x P =Π H n = x h n (x) x=ˆxn n K f,n = P n n Hn(H n P n n Hn + R n ) ( ˆx n n = ˆx n n + K f,n yn h n (ˆx n n ) ) F n = x f n (x) x=ˆxn n G n = g n (ˆx n n ) where denotes the Jacobian operator x x () ˆx n+ n = f n (ˆx n n )P n n =(I K f,n H n )P n n P n+ n = F n P n n F n + G n Q n G n J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 24

7 EKF Discussion Can only be expected to perform well for nonlinear functions that can be accurately approximated locally about ˆx n as linear functions Excludes functions with discontinuities and discontinuous slopes Only smooth functions should be used There is a positive feedback mechanism in the Taylor series approximations If the estimate ˆx n is good, then the approximation will generally be accurate and the next estimate will be good (possibly better) If the estimate is poor, then the next estimate will be poor (possibly worse) If the EKF starts to lose track, the approximation error in the Taylor series approximation may exacerbate this problem in subsequent estimates Example : Frequency Tracking Develop a state space model to track the frequency of a quasi-periodic sinusoid measured from a noisy sensor. Consider the following continuous-time state space model y(t) =a sin ( ) 2πT s fn+ θ(n) + v(n) θ(t) =ω(t) ω(t) =u(t) f(t) = f + 2π ω(t) J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver Example : Continuous- to Discrete-time Conversion Use the coarse CT-DT conversion, we obtain a DT state space model y(n) =a sin ( ) 2πT s fn+ θ(n) + v(n) θ(n +)=θ(n)+t s ω(n) ω(n +)=ω(n)+u(n) f(n) = f + 2π u(n) Note that the state update equation is linear. [ ] [ ][ ] θ(n +) Ts θ(n) = + u(n) ω(n +) ω(n) x n+ = F x n + u n where u(n), u(k) = [ ] T s δ kn So we have and Example : Output Linearization y(n) =a sin ( 2πT s fn+ θ(n) ) + v(n) h n (x n ) a sin ( ) 2πT s fn+ θ(n) = a sin ( 2πT s fn+ xn () ) H n x h n (x) = [ a cos ( 2πT s fn+ xn () ) ] J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 28

8 Example : Chirp Frequency Tracking Example : Chirp Frequency Tracking q=5.e-7 q=5.e J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 3 Example : Chirp Frequency Tracking Example : Chirp Frequency Tracking q=5.e-5 q= J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 3 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 32

9 Example : Chirp Frequency Tracking Example : Chirp Frequency Tracking q=.5 q= J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver clear; close all; Example : MATLAB Code title(sprintf( $q$=5.3g,q(c)*var(y))); print(sprintf( KFChirpQd,round(log(q(c)))), -depsc ); User-Specified Parameters fs = ; Sample rate (Hz) N = 3; Number of observations from the process Np = 5; Number of samples to throw away to account for transient k = :N/4; t = (k-.5)/fs; yc = chirp(t,.5,t(end),.45); y = [yc fliplr(yc) yc fliplr(yc)] ; Kalman Filter Estimates q = [e-6 e-5 e-4 e-3 e-2 e-]; for c=:length(q), fi = KalmanFrequencyTracker(y,fs,[],[q(c)*var(y) var(y).]); NonparametricSpectrogram(y,fs,2); colormap(colorspiral); hold on; k = :length(y); t = (k-.5)/(6*fs); h = plot(t,fi, k,t,fi, w ); set(h(), LineWidth,.5); set(h(2), LineWidth,.5); hold off; FigureSet(, LTX ); AxisSet(8); J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 36

10 Example : MATLAB Code function [fi,fv,yh] = KalmanFrequencyTracker(y,fsa,fmna,nva,aa,pfa); KalmanFilterFrequencyTracker: Tracks instantaneous frequency [fi,yh] = KalmanFrequencyTracker(y,fs,fmn,nv,a,pf); y Input signal. fs Sample rate (Hz). Default = Hz. fmn A priori mean frequency nv Noise variances of [fi y x]. Default = [..]. a Amplitude of the frequency component. Default = see manuscript. pf Plot flag: =none (default), =screen, 2=current figure. fi Instantaneous frequency (fi) estimates. yh Smoothed estimate of the input signal. Uses the following model a harmonic estimate of the signal with time-varying amplitude and instantaneous frequency. Example: Generate the parametric spectrogram of an intracranial pressure signal using a Blackman-Harris window that is 45 s in duration. load Tremor.mat; N = length(x); fss = 75; New sample rate (Hz) Ns = ceil(n*fss/fs); Number of samples sti = floor((fss/fs)*(si-))+; Indices of spikes ks = :Ns; Sample index ts = (ks-.5)/fss; Time index xs = zeros(ns,); Allocate memory for spike train xs(sti) = ; Create spike train KalmanFrequencyTracker(xs,fss); S. Kim, J. McNames, "Tracking tremor frequency in spike trains using the extended Kalman filter," Proceedings of the 27th Annual International Conference of the Engineering in Medicine and Biology Society, September 25. Version. JM See also Lowpass, ParametricSpectrogram, and KernelFilter. Error Checking if nargin<2, help KalmanFrequencyTracker; return; Process Function Arguments fs = ; if exist( fsa, var ) & ~isempty(fsa), fs = fsa; fmean = 2; if exist( fmna, var ) & ~isempty(fmna), fmean = fmna; a =.*std(y); Amplitude of the frequency component if exist( aa, var ) & ~isempty(aa), a = aa; nv = [.*var(y) var(y).]; Noise Variances if exist( nva, var ) & ~isempty(nva), nv = nva; J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver pf = ; if nargout==, pf = ; if exist( pfa ) & ~isempty(pfa), pf = pfa; Default - no plotting Plot if no output arguments Fs = cell(ny,); Res = cell(ny,); es = cell(ny,); xhps = cell(ny,); Pps = cell(ny+,); Kalman Filter Parameter Definitions nx = 2; Dimension of the state vector Preprocessing my = mean(y); Save the mean value of y y = y(:) - mean(y); Make sure y is a column vector ny = length(y); No. samples Ts = /fs; Sampling interval (sec) wmean = fmean/(2*pi); Mean frequency Q = Ts*diag([;nv()]); Process noise covariance matrix for discrete-time process model R = nv(2); Measurement noise covariance matrix for discrete-time process model P = nv(3)*eye(nx,nx); Initial predicted error covariance matrix Memory Allocation fi = zeros(ny,); fv = zeros(ny,); yh = zeros(ny,); Hs = cell(ny,); Variable Initialization xhp = zeros(nx,); Initial value of predicted state at time i= Pp = P; Predicted state error covariance Pps{} = Pp; xhps{} = xhp; Kalman Filter Recursions for n=:ny, H = [a*cos(wmean*n*ts+xhp()),]; Re = R + H*Pp*H ; Innovation covariance matrix Kf = Pp*H *inv(re); Filtered estimate Kalman gain yhp = a*sin(wmean*n*ts+xhp()); Predicted estimate of the output e = y(n) - yhp; Innovation xhm = xhp + Kf*e; Measurement update estimate of the state F = [ Ts; ]; Linearized state transition matrix xhp = [xhm()+ts*xhm(2);xhm(2)]; Predicted state estimates Pm = Pp - Kf*Re*Kf ; Measurement state error covariance Pp = F*Pm*F + Q; Predicted state error covariance Store Variables for Smoothing J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 4

11 Hs{n} = H; Fs{n} = F; Res{n} = Re; es{n} = e; xhps{n+} = xhp; Pps{n+} = Pp; Process Return Arguments if nargout==, clear( fi, yh ); Store Variables of Interest fi(n) = (xhm(2)+wmean)/(2*pi); Instantaneous frequency estimate fv(n) = Pm(2,2)/((2*pi).^2); Estimated error variance of estimate Post-processing yh = yh + my; Plotting if pf>=, fmean = wmean/(2*pi); ds = floor(fs/(4*fmean)); Tx = ny/fs; NonparametricSpectrogram(decimate(y,ds),fs/ds,/fmean,[],[],[],pf); hold on; k = :ny; t = (k-.5)/fs; h = plot(t,fi, k,t,fi, w ); set(h(), LineWidth,2.5); set(h(2), LineWidth,.5); hold off; J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 4 J. McNames Portland State University ECE 539/639 Extended Kalman Filter Ver..2 42

x n C l 1 u n C m 1 y n C p 1 v n C p 1

x n C l 1 u n C m 1 y n C p 1 v n C p 1 Kalman Filter Derivation Examples Time and Measurement Updates x u n v n, State Space Model Review x n+ = F n x n + G n u n x u k v k y n = H n x n + v n Π = Q n δ nk S n δ nk Snδ nk R n δ nk F n C l l

More information

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids Overview of Continuous-Time Fourier Transform Topics Definition Compare & contrast with Laplace transform Conditions for existence Relationship to LTI systems Examples Ideal lowpass filters Relationship

More information

Overview of Discrete-Time Fourier Transform Topics Handy Equations Handy Limits Orthogonality Defined orthogonal

Overview of Discrete-Time Fourier Transform Topics Handy Equations Handy Limits Orthogonality Defined orthogonal Overview of Discrete-Time Fourier Transform Topics Handy equations and its Definition Low- and high- discrete-time frequencies Convergence issues DTFT of complex and real sinusoids Relationship to LTI

More information

Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates

Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1 1 Introduction

More information

J. McNames Portland State University ECE 223 DT Fourier Series Ver

J. McNames Portland State University ECE 223 DT Fourier Series Ver Overview of DT Fourier Series Topics Orthogonality of DT exponential harmonics DT Fourier Series as a Design Task Picking the frequencies Picking the range Finding the coefficients Example J. McNames Portland

More information

x(n) = a k x(n k)+w(n) k=1

x(n) = a k x(n k)+w(n) k=1 Autoregressive Models Overview Direct structures Types of estimators Parametric spectral estimation Parametric time-frequency analysis Order selection criteria Lattice structures? Maximum entropy Excitation

More information

5 Kalman filters. 5.1 Scalar Kalman filter. Unit delay Signal model. System model

5 Kalman filters. 5.1 Scalar Kalman filter. Unit delay Signal model. System model 5 Kalman filters 5.1 Scalar Kalman filter 5.1.1 Signal model System model {Y (n)} is an unobservable sequence which is described by the following state or system equation: Y (n) = h(n)y (n 1) + Z(n), n

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fourier Series & Transform Summary x[n] = X[k] = 1 N k= n= X[k]e jkω

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding J. McNames Portland State University ECE 223 FFT Ver. 1.03 1 Fourier Series

More information

Bayes Filter Reminder. Kalman Filter Localization. Properties of Gaussians. Gaussians. Prediction. Correction. σ 2. Univariate. 1 2πσ e.

Bayes Filter Reminder. Kalman Filter Localization. Properties of Gaussians. Gaussians. Prediction. Correction. σ 2. Univariate. 1 2πσ e. Kalman Filter Localization Bayes Filter Reminder Prediction Correction Gaussians p(x) ~ N(µ,σ 2 ) : Properties of Gaussians Univariate p(x) = 1 1 2πσ e 2 (x µ) 2 σ 2 µ Univariate -σ σ Multivariate µ Multivariate

More information

Kalman Filter. Predict: Update: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q

Kalman Filter. Predict: Update: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q Kalman Filter Kalman Filter Predict: x k k 1 = F k x k 1 k 1 + B k u k P k k 1 = F k P k 1 k 1 F T k + Q Update: K = P k k 1 Hk T (H k P k k 1 Hk T + R) 1 x k k = x k k 1 + K(z k H k x k k 1 ) P k k =(I

More information

Change in Notation. e (i) (n) Note that this is inconsistent with the notation used earlier, c k+1x(n k) e (i) (n) x(n i) ˆx(n i) M

Change in Notation. e (i) (n) Note that this is inconsistent with the notation used earlier, c k+1x(n k) e (i) (n) x(n i) ˆx(n i) M Overview of Linear Prediction Terms and definitions Nonstationary case Stationary case Forward linear prediction Backward linear prediction Stationary processes Exchange matrices Examples Properties Introduction

More information

Overview of Sampling Topics

Overview of Sampling Topics Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

Nonlinear State Estimation! Extended Kalman Filters!

Nonlinear State Estimation! Extended Kalman Filters! Nonlinear State Estimation! Extended Kalman Filters! Robert Stengel! Optimal Control and Estimation, MAE 546! Princeton University, 2017!! Deformation of the probability distribution!! Neighboring-optimal

More information

J. McNames Portland State University ECE 223 Sampling Ver

J. McNames Portland State University ECE 223 Sampling Ver Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

ECE531 Lecture 11: Dynamic Parameter Estimation: Kalman-Bucy Filter

ECE531 Lecture 11: Dynamic Parameter Estimation: Kalman-Bucy Filter ECE531 Lecture 11: Dynamic Parameter Estimation: Kalman-Bucy Filter D. Richard Brown III Worcester Polytechnic Institute 09-Apr-2009 Worcester Polytechnic Institute D. Richard Brown III 09-Apr-2009 1 /

More information

From Fourier Series to Analysis of Non-stationary Signals - X

From Fourier Series to Analysis of Non-stationary Signals - X From Fourier Series to Analysis of Non-stationary Signals - X prof. Miroslav Vlcek December 14, 21 Contents Stationary and non-stationary 1 Stationary and non-stationary 2 3 Contents Stationary and non-stationary

More information

1 Kalman Filter Introduction

1 Kalman Filter Introduction 1 Kalman Filter Introduction You should first read Chapter 1 of Stochastic models, estimation, and control: Volume 1 by Peter S. Maybec (available here). 1.1 Explanation of Equations (1-3) and (1-4) Equation

More information

6.4 Kalman Filter Equations

6.4 Kalman Filter Equations 6.4 Kalman Filter Equations 6.4.1 Recap: Auxiliary variables Recall the definition of the auxiliary random variables x p k) and x m k): Init: x m 0) := x0) S1: x p k) := Ak 1)x m k 1) +uk 1) +vk 1) S2:

More information

L06. LINEAR KALMAN FILTERS. NA568 Mobile Robotics: Methods & Algorithms

L06. LINEAR KALMAN FILTERS. NA568 Mobile Robotics: Methods & Algorithms L06. LINEAR KALMAN FILTERS NA568 Mobile Robotics: Methods & Algorithms 2 PS2 is out! Landmark-based Localization: EKF, UKF, PF Today s Lecture Minimum Mean Square Error (MMSE) Linear Kalman Filter Gaussian

More information

Least Squares and Kalman Filtering Questions: me,

Least Squares and Kalman Filtering Questions:  me, Least Squares and Kalman Filtering Questions: Email me, namrata@ece.gatech.edu Least Squares and Kalman Filtering 1 Recall: Weighted Least Squares y = Hx + e Minimize Solution: J(x) = (y Hx) T W (y Hx)

More information

Introduction to Unscented Kalman Filter

Introduction to Unscented Kalman Filter Introduction to Unscented Kalman Filter 1 Introdution In many scientific fields, we use certain models to describe the dynamics of system, such as mobile robot, vision tracking and so on. The word dynamics

More information

Time Series Analysis

Time Series Analysis Time Series Analysis hm@imm.dtu.dk Informatics and Mathematical Modelling Technical University of Denmark DK-2800 Kgs. Lyngby 1 Outline of the lecture State space models, 1st part: Model: Sec. 10.1 The

More information

CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems. CDS 110b

CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems. CDS 110b CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems CDS 110b R. M. Murray Kalman Filters 14 January 2007 Reading: This set of lectures provides a brief introduction to Kalman filtering, following

More information

Nonlinear and/or Non-normal Filtering. Jesús Fernández-Villaverde University of Pennsylvania

Nonlinear and/or Non-normal Filtering. Jesús Fernández-Villaverde University of Pennsylvania Nonlinear and/or Non-normal Filtering Jesús Fernández-Villaverde University of Pennsylvania 1 Motivation Nonlinear and/or non-gaussian filtering, smoothing, and forecasting (NLGF) problems are pervasive

More information

Lecture Notes 4 Vector Detection and Estimation. Vector Detection Reconstruction Problem Detection for Vector AGN Channel

Lecture Notes 4 Vector Detection and Estimation. Vector Detection Reconstruction Problem Detection for Vector AGN Channel Lecture Notes 4 Vector Detection and Estimation Vector Detection Reconstruction Problem Detection for Vector AGN Channel Vector Linear Estimation Linear Innovation Sequence Kalman Filter EE 278B: Random

More information

Mini-Course 07 Kalman Particle Filters. Henrique Massard da Fonseca Cesar Cunha Pacheco Wellington Bettencurte Julio Dutra

Mini-Course 07 Kalman Particle Filters. Henrique Massard da Fonseca Cesar Cunha Pacheco Wellington Bettencurte Julio Dutra Mini-Course 07 Kalman Particle Filters Henrique Massard da Fonseca Cesar Cunha Pacheco Wellington Bettencurte Julio Dutra Agenda State Estimation Problems & Kalman Filter Henrique Massard Steady State

More information

Optimization-Based Control

Optimization-Based Control Optimization-Based Control Richard M. Murray Control and Dynamical Systems California Institute of Technology DRAFT v1.7a, 19 February 2008 c California Institute of Technology All rights reserved. This

More information

Lesson 1. Optimal signalbehandling LTH. September Statistical Digital Signal Processing and Modeling, Hayes, M:

Lesson 1. Optimal signalbehandling LTH. September Statistical Digital Signal Processing and Modeling, Hayes, M: Lesson 1 Optimal Signal Processing Optimal signalbehandling LTH September 2013 Statistical Digital Signal Processing and Modeling, Hayes, M: John Wiley & Sons, 1996. ISBN 0471594318 Nedelko Grbic Mtrl

More information

TSRT14: Sensor Fusion Lecture 8

TSRT14: Sensor Fusion Lecture 8 TSRT14: Sensor Fusion Lecture 8 Particle filter theory Marginalized particle filter Gustaf Hendeby gustaf.hendeby@liu.se TSRT14 Lecture 8 Gustaf Hendeby Spring 2018 1 / 25 Le 8: particle filter theory,

More information

ECONOMETRIC METHODS II: TIME SERIES LECTURE NOTES ON THE KALMAN FILTER. The Kalman Filter. We will be concerned with state space systems of the form

ECONOMETRIC METHODS II: TIME SERIES LECTURE NOTES ON THE KALMAN FILTER. The Kalman Filter. We will be concerned with state space systems of the form ECONOMETRIC METHODS II: TIME SERIES LECTURE NOTES ON THE KALMAN FILTER KRISTOFFER P. NIMARK The Kalman Filter We will be concerned with state space systems of the form X t = A t X t 1 + C t u t 0.1 Z t

More information

Extended Kalman Filter Tutorial

Extended Kalman Filter Tutorial Extended Kalman Filter Tutorial Gabriel A. Terejanu Department of Computer Science and Engineering University at Buffalo, Buffalo, NY 14260 terejanu@buffalo.edu 1 Dynamic process Consider the following

More information

Control Systems Lab - SC4070 System Identification and Linearization

Control Systems Lab - SC4070 System Identification and Linearization Control Systems Lab - SC4070 System Identification and Linearization Dr. Manuel Mazo Jr. Delft Center for Systems and Control (TU Delft) m.mazo@tudelft.nl Tel.:015-2788131 TU Delft, February 13, 2015 (slides

More information

X t = a t + r t, (7.1)

X t = a t + r t, (7.1) Chapter 7 State Space Models 71 Introduction State Space models, developed over the past 10 20 years, are alternative models for time series They include both the ARIMA models of Chapters 3 6 and the Classical

More information

Grades will be determined by the correctness of your answers (explanations are not required).

Grades will be determined by the correctness of your answers (explanations are not required). 6.00 (Fall 2011) Final Examination December 19, 2011 Name: Kerberos Username: Please circle your section number: Section Time 2 11 am 1 pm 4 2 pm Grades will be determined by the correctness of your answers

More information

Gaussian, Markov and stationary processes

Gaussian, Markov and stationary processes Gaussian, Markov and stationary processes Gonzalo Mateos Dept. of ECE and Goergen Institute for Data Science University of Rochester gmateosb@ece.rochester.edu http://www.ece.rochester.edu/~gmateosb/ November

More information

Correlation, discrete Fourier transforms and the power spectral density

Correlation, discrete Fourier transforms and the power spectral density Correlation, discrete Fourier transforms and the power spectral density visuals to accompany lectures, notes and m-files by Tak Igusa tigusa@jhu.edu Department of Civil Engineering Johns Hopkins University

More information

ROBOTICS 01PEEQW. Basilio Bona DAUIN Politecnico di Torino

ROBOTICS 01PEEQW. Basilio Bona DAUIN Politecnico di Torino ROBOTICS 01PEEQW Basilio Bona DAUIN Politecnico di Torino Probabilistic Fundamentals in Robotics Gaussian Filters Course Outline Basic mathematical framework Probabilistic models of mobile robots Mobile

More information

Solutions for examination in TSRT78 Digital Signal Processing,

Solutions for examination in TSRT78 Digital Signal Processing, Solutions for examination in TSRT78 Digital Signal Processing, 2014-04-14 1. s(t) is generated by s(t) = 1 w(t), 1 + 0.3q 1 Var(w(t)) = σ 2 w = 2. It is measured as y(t) = s(t) + n(t) where n(t) is white

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

Derivation of the Kalman Filter

Derivation of the Kalman Filter Derivation of the Kalman Filter Kai Borre Danish GPS Center, Denmark Block Matrix Identities The key formulas give the inverse of a 2 by 2 block matrix, assuming T is invertible: T U 1 L M. (1) V W N P

More information

Grades will be determined by the correctness of your answers (explanations are not required).

Grades will be determined by the correctness of your answers (explanations are not required). 6.00 (Fall 20) Final Examination December 9, 20 Name: Kerberos Username: Please circle your section number: Section Time 2 am pm 4 2 pm Grades will be determined by the correctness of your answers (explanations

More information

4 Derivations of the Discrete-Time Kalman Filter

4 Derivations of the Discrete-Time Kalman Filter Technion Israel Institute of Technology, Department of Electrical Engineering Estimation and Identification in Dynamical Systems (048825) Lecture Notes, Fall 2009, Prof N Shimkin 4 Derivations of the Discrete-Time

More information

The Kalman Filter. Data Assimilation & Inverse Problems from Weather Forecasting to Neuroscience. Sarah Dance

The Kalman Filter. Data Assimilation & Inverse Problems from Weather Forecasting to Neuroscience. Sarah Dance The Kalman Filter Data Assimilation & Inverse Problems from Weather Forecasting to Neuroscience Sarah Dance School of Mathematical and Physical Sciences, University of Reading s.l.dance@reading.ac.uk July

More information

CCNY. BME I5100: Biomedical Signal Processing. Stochastic Processes. Lucas C. Parra Biomedical Engineering Department City College of New York

CCNY. BME I5100: Biomedical Signal Processing. Stochastic Processes. Lucas C. Parra Biomedical Engineering Department City College of New York BME I5100: Biomedical Signal Processing Stochastic Processes Lucas C. Parra Biomedical Engineering Department CCNY 1 Schedule Week 1: Introduction Linear, stationary, normal - the stuff biology is not

More information

Nonlinear Observers. Jaime A. Moreno. Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México

Nonlinear Observers. Jaime A. Moreno. Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México Nonlinear Observers Jaime A. Moreno JMorenoP@ii.unam.mx Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México XVI Congreso Latinoamericano de Control Automático October

More information

State-space Model. Eduardo Rossi University of Pavia. November Rossi State-space Model Fin. Econometrics / 53

State-space Model. Eduardo Rossi University of Pavia. November Rossi State-space Model Fin. Econometrics / 53 State-space Model Eduardo Rossi University of Pavia November 2014 Rossi State-space Model Fin. Econometrics - 2014 1 / 53 Outline 1 Motivation 2 Introduction 3 The Kalman filter 4 Forecast errors 5 State

More information

Factor Analysis and Kalman Filtering (11/2/04)

Factor Analysis and Kalman Filtering (11/2/04) CS281A/Stat241A: Statistical Learning Theory Factor Analysis and Kalman Filtering (11/2/04) Lecturer: Michael I. Jordan Scribes: Byung-Gon Chun and Sunghoon Kim 1 Factor Analysis Factor analysis is used

More information

Probabilistic Fundamentals in Robotics. DAUIN Politecnico di Torino July 2010

Probabilistic Fundamentals in Robotics. DAUIN Politecnico di Torino July 2010 Probabilistic Fundamentals in Robotics Gaussian Filters Basilio Bona DAUIN Politecnico di Torino July 2010 Course Outline Basic mathematical framework Probabilistic models of mobile robots Mobile robot

More information

Topic 3: Fourier Series (FS)

Topic 3: Fourier Series (FS) ELEC264: Signals And Systems Topic 3: Fourier Series (FS) o o o o Introduction to frequency analysis of signals CT FS Fourier series of CT periodic signals Signal Symmetry and CT Fourier Series Properties

More information

3.2 Complex Sinusoids and Frequency Response of LTI Systems

3.2 Complex Sinusoids and Frequency Response of LTI Systems 3. Introduction. A signal can be represented as a weighted superposition of complex sinusoids. x(t) or x[n]. LTI system: LTI System Output = A weighted superposition of the system response to each complex

More information

VIII. Coherence and Transfer Function Applications A. Coherence Function Estimates

VIII. Coherence and Transfer Function Applications A. Coherence Function Estimates VIII. Coherence and Transfer Function Applications A. Coherence Function Estimates Consider the application of these ideas to the specific problem of atmospheric turbulence measurements outlined in Figure

More information

Digital Filters Ying Sun

Digital Filters Ying Sun Digital Filters Ying Sun Digital filters Finite impulse response (FIR filter: h[n] has a finite numbers of terms. Infinite impulse response (IIR filter: h[n] has infinite numbers of terms. Causal filter:

More information

Estimation and Prediction Scenarios

Estimation and Prediction Scenarios Recursive BLUE BLUP and the Kalman filter: Estimation and Prediction Scenarios Amir Khodabandeh GNSS Research Centre, Curtin University of Technology, Perth, Australia IUGG 2011, Recursive 28 June BLUE-BLUP

More information

EE538 Final Exam Fall 2007 Mon, Dec 10, 8-10 am RHPH 127 Dec. 10, Cover Sheet

EE538 Final Exam Fall 2007 Mon, Dec 10, 8-10 am RHPH 127 Dec. 10, Cover Sheet EE538 Final Exam Fall 2007 Mon, Dec 10, 8-10 am RHPH 127 Dec. 10, 2007 Cover Sheet Test Duration: 120 minutes. Open Book but Closed Notes. Calculators allowed!! This test contains five problems. Each of

More information

State Estimation and Motion Tracking for Spatially Diverse VLC Networks

State Estimation and Motion Tracking for Spatially Diverse VLC Networks State Estimation and Motion Tracking for Spatially Diverse VLC Networks GLOBECOM Optical Wireless Communications Workshop December 3, 2012 Anaheim, CA Michael Rahaim mrahaim@bu.edu Gregary Prince gbprince@bu.edu

More information

Each problem is worth 25 points, and you may solve the problems in any order.

Each problem is worth 25 points, and you may solve the problems in any order. EE 120: Signals & Systems Department of Electrical Engineering and Computer Sciences University of California, Berkeley Midterm Exam #2 April 11, 2016, 2:10-4:00pm Instructions: There are four questions

More information

CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems. CDS 110b

CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems. CDS 110b CALIFORNIA INSTITUTE OF TECHNOLOGY Control and Dynamical Systems CDS 110b R. M. Murray Kalman Filters 25 January 2006 Reading: This set of lectures provides a brief introduction to Kalman filtering, following

More information

ECE531 Lecture 10b: Dynamic Parameter Estimation: System Model

ECE531 Lecture 10b: Dynamic Parameter Estimation: System Model ECE531 Lecture 10b: Dynamic Parameter Estimation: System Model D. Richard Brown III Worcester Polytechnic Institute 02-Apr-2009 Worcester Polytechnic Institute D. Richard Brown III 02-Apr-2009 1 / 14 Introduction

More information

EE Experiment 11 The Laplace Transform and Control System Characteristics

EE Experiment 11 The Laplace Transform and Control System Characteristics EE216:11 1 EE 216 - Experiment 11 The Laplace Transform and Control System Characteristics Objectives: To illustrate computer usage in determining inverse Laplace transforms. Also to determine useful signal

More information

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros)

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) J. McNames Portland State University ECE 222 Bode Plots Ver.

More information

GATE EE Topic wise Questions SIGNALS & SYSTEMS

GATE EE Topic wise Questions SIGNALS & SYSTEMS www.gatehelp.com GATE EE Topic wise Questions YEAR 010 ONE MARK Question. 1 For the system /( s + 1), the approximate time taken for a step response to reach 98% of the final value is (A) 1 s (B) s (C)

More information

Solutions to Problems in Chapter 4

Solutions to Problems in Chapter 4 Solutions to Problems in Chapter 4 Problems with Solutions Problem 4. Fourier Series of the Output Voltage of an Ideal Full-Wave Diode Bridge Rectifier he nonlinear circuit in Figure 4. is a full-wave

More information

Optimization-Based Control

Optimization-Based Control Optimization-Based Control Richard M. Murray Control and Dynamical Systems California Institute of Technology DRAFT v2.1a, January 3, 2010 c California Institute of Technology All rights reserved. This

More information

EE482: Digital Signal Processing Applications

EE482: Digital Signal Processing Applications Professor Brendan Morris, SEB 3216, brendan.morris@unlv.edu EE482: Digital Signal Processing Applications Spring 2014 TTh 14:30-15:45 CBC C222 Lecture 02 DSP Fundamentals 14/01/21 http://www.ee.unlv.edu/~b1morris/ee482/

More information

New Fast Kalman filter method

New Fast Kalman filter method New Fast Kalman filter method Hojat Ghorbanidehno, Hee Sun Lee 1. Introduction Data assimilation methods combine dynamical models of a system with typically noisy observations to obtain estimates of the

More information

From Bayes to Extended Kalman Filter

From Bayes to Extended Kalman Filter From Bayes to Extended Kalman Filter Michal Reinštein Czech Technical University in Prague Faculty of Electrical Engineering, Department of Cybernetics Center for Machine Perception http://cmp.felk.cvut.cz/

More information

ECE 3084 OCTOBER 17, 2017

ECE 3084 OCTOBER 17, 2017 Objective ECE 3084 LAB NO. 1: MEASURING FREQUENCY RESPONSE OCTOBER 17, 2017 The objective of this lab is to measure the magnitude response of a set of headphones or earbuds. We will explore three alternative

More information

Introduction to Biomedical Engineering

Introduction to Biomedical Engineering Introduction to Biomedical Engineering Biosignal processing Kung-Bin Sung 6/11/2007 1 Outline Chapter 10: Biosignal processing Characteristics of biosignals Frequency domain representation and analysis

More information

Comparision of Probabilistic Navigation methods for a Swimming Robot

Comparision of Probabilistic Navigation methods for a Swimming Robot Comparision of Probabilistic Navigation methods for a Swimming Robot Anwar Ahmad Quraishi Semester Project, Autumn 2013 Supervisor: Yannic Morel BioRobotics Laboratory Headed by Prof. Aue Jan Ijspeert

More information

EE482: Digital Signal Processing Applications

EE482: Digital Signal Processing Applications Professor Brendan Morris, SEB 3216, brendan.morris@unlv.edu EE482: Digital Signal Processing Applications Spring 2014 TTh 14:30-15:45 CBC C222 Lecture 11 Adaptive Filtering 14/03/04 http://www.ee.unlv.edu/~b1morris/ee482/

More information

Statistics 910, #15 1. Kalman Filter

Statistics 910, #15 1. Kalman Filter Statistics 910, #15 1 Overview 1. Summary of Kalman filter 2. Derivations 3. ARMA likelihoods 4. Recursions for the variance Kalman Filter Summary of Kalman filter Simplifications To make the derivations

More information

NOISE ROBUST RELATIVE TRANSFER FUNCTION ESTIMATION. M. Schwab, P. Noll, and T. Sikora. Technical University Berlin, Germany Communication System Group

NOISE ROBUST RELATIVE TRANSFER FUNCTION ESTIMATION. M. Schwab, P. Noll, and T. Sikora. Technical University Berlin, Germany Communication System Group NOISE ROBUST RELATIVE TRANSFER FUNCTION ESTIMATION M. Schwab, P. Noll, and T. Sikora Technical University Berlin, Germany Communication System Group Einsteinufer 17, 1557 Berlin (Germany) {schwab noll

More information

A NOVEL OPTIMAL PROBABILITY DENSITY FUNCTION TRACKING FILTER DESIGN 1

A NOVEL OPTIMAL PROBABILITY DENSITY FUNCTION TRACKING FILTER DESIGN 1 A NOVEL OPTIMAL PROBABILITY DENSITY FUNCTION TRACKING FILTER DESIGN 1 Jinglin Zhou Hong Wang, Donghua Zhou Department of Automation, Tsinghua University, Beijing 100084, P. R. China Control Systems Centre,

More information

Non-parametric identification

Non-parametric identification Non-parametric Non-parametric Transient Step-response using Spectral Transient Correlation Frequency function estimate Spectral System Identification, SSY230 Non-parametric 1 Non-parametric Transient Step-response

More information

I. Signals & Sinusoids

I. Signals & Sinusoids I. Signals & Sinusoids [p. 3] Signal definition Sinusoidal signal Plotting a sinusoid [p. 12] Signal operations Time shifting Time scaling Time reversal Combining time shifting & scaling [p. 17] Trigonometric

More information

2.6 The optimum filtering solution is defined by the Wiener-Hopf equation

2.6 The optimum filtering solution is defined by the Wiener-Hopf equation .6 The optimum filtering solution is defined by the Wiener-opf equation w o p for which the minimum mean-square error equals J min σ d p w o () Combine Eqs. and () into a single relation: σ d p p 1 w o

More information

CS 532: 3D Computer Vision 6 th Set of Notes

CS 532: 3D Computer Vision 6 th Set of Notes 1 CS 532: 3D Computer Vision 6 th Set of Notes Instructor: Philippos Mordohai Webpage: www.cs.stevens.edu/~mordohai E-mail: Philippos.Mordohai@stevens.edu Office: Lieb 215 Lecture Outline Intro to Covariance

More information

ECE 8440 Unit 13 Sec0on Effects of Round- Off Noise in Digital Filters

ECE 8440 Unit 13 Sec0on Effects of Round- Off Noise in Digital Filters ECE 8440 Unit 13 Sec0on 6.9 - Effects of Round- Off Noise in Digital Filters 1 We have already seen that if a wide- sense staonary random signal x(n) is applied as input to a LTI system, the power density

More information

Chapter 5 Frequency Domain Analysis of Systems

Chapter 5 Frequency Domain Analysis of Systems Chapter 5 Frequency Domain Analysis of Systems CT, LTI Systems Consider the following CT LTI system: xt () ht () yt () Assumption: the impulse response h(t) is absolutely integrable, i.e., ht ( ) dt< (this

More information

Dual Estimation and the Unscented Transformation

Dual Estimation and the Unscented Transformation Dual Estimation and the Unscented Transformation Eric A. Wan ericwan@ece.ogi.edu Rudolph van der Merwe rudmerwe@ece.ogi.edu Alex T. Nelson atnelson@ece.ogi.edu Oregon Graduate Institute of Science & Technology

More information

Image Alignment and Mosaicing Feature Tracking and the Kalman Filter

Image Alignment and Mosaicing Feature Tracking and the Kalman Filter Image Alignment and Mosaicing Feature Tracking and the Kalman Filter Image Alignment Applications Local alignment: Tracking Stereo Global alignment: Camera jitter elimination Image enhancement Panoramic

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

A Comparitive Study Of Kalman Filter, Extended Kalman Filter And Unscented Kalman Filter For Harmonic Analysis Of The Non-Stationary Signals

A Comparitive Study Of Kalman Filter, Extended Kalman Filter And Unscented Kalman Filter For Harmonic Analysis Of The Non-Stationary Signals International Journal of Scientific & Engineering Research, Volume 3, Issue 7, July-2012 1 A Comparitive Study Of Kalman Filter, Extended Kalman Filter And Unscented Kalman Filter For Harmonic Analysis

More information

Velocity (Kalman Filter) Velocity (knots) Time (sec) Kalman Filter Accelerations 2.5. Acceleration (m/s2)

Velocity (Kalman Filter) Velocity (knots) Time (sec) Kalman Filter Accelerations 2.5. Acceleration (m/s2) KALMAN FILERING 1 50 Velocity (Kalman Filter) 45 40 35 Velocity (nots) 30 25 20 15 10 5 0 0 10 20 30 40 50 60 70 80 90 100 ime (sec) 3 Kalman Filter Accelerations 2.5 Acceleration (m/s2) 2 1.5 1 0.5 0

More information

Massachusetts Institute of Technology

Massachusetts Institute of Technology Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.011: Introduction to Communication, Control and Signal Processing QUIZ 1, March 16, 2010 ANSWER BOOKLET

More information

Fourier Series Representation of

Fourier Series Representation of Fourier Series Representation of Periodic Signals Rui Wang, Assistant professor Dept. of Information and Communication Tongji University it Email: ruiwang@tongji.edu.cn Outline The response of LIT system

More information

Probability Space. J. McNames Portland State University ECE 538/638 Stochastic Signals Ver

Probability Space. J. McNames Portland State University ECE 538/638 Stochastic Signals Ver Stochastic Signals Overview Definitions Second order statistics Stationarity and ergodicity Random signal variability Power spectral density Linear systems with stationary inputs Random signal memory Correlation

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

NAME: 11 December 2013 Digital Signal Processing I Final Exam Fall Cover Sheet

NAME: 11 December 2013 Digital Signal Processing I Final Exam Fall Cover Sheet NAME: December Digital Signal Processing I Final Exam Fall Cover Sheet Test Duration: minutes. Open Book but Closed Notes. Three 8.5 x crib sheets allowed Calculators NOT allowed. This test contains four

More information

Timbral, Scale, Pitch modifications

Timbral, Scale, Pitch modifications Introduction Timbral, Scale, Pitch modifications M2 Mathématiques / Vision / Apprentissage Audio signal analysis, indexing and transformation Page 1 / 40 Page 2 / 40 Modification of playback speed Modifications

More information

Data assimilation with and without a model

Data assimilation with and without a model Data assimilation with and without a model Tim Sauer George Mason University Parameter estimation and UQ U. Pittsburgh Mar. 5, 2017 Partially supported by NSF Most of this work is due to: Tyrus Berry,

More information

Adaptive Systems Homework Assignment 1

Adaptive Systems Homework Assignment 1 Signal Processing and Speech Communication Lab. Graz University of Technology Adaptive Systems Homework Assignment 1 Name(s) Matr.No(s). The analytical part of your homework (your calculation sheets) as

More information

State-space Model. Eduardo Rossi University of Pavia. November Rossi State-space Model Financial Econometrics / 49

State-space Model. Eduardo Rossi University of Pavia. November Rossi State-space Model Financial Econometrics / 49 State-space Model Eduardo Rossi University of Pavia November 2013 Rossi State-space Model Financial Econometrics - 2013 1 / 49 Outline 1 Introduction 2 The Kalman filter 3 Forecast errors 4 State smoothing

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

Optimization-Based Control

Optimization-Based Control Optimization-Based Control Richard M. Murray Control and Dynamical Systems California Institute of Technology DRAFT v1.7b, 23 February 2008 c California Institute of Technology All rights reserved. This

More information

EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, Cover Sheet

EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, Cover Sheet EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, 2012 Cover Sheet Test Duration: 75 minutes. Coverage: Chaps. 5,7 Open Book but Closed Notes. One 8.5 in. x 11 in. crib sheet Calculators

More information

Course Background. Loosely speaking, control is the process of getting something to do what you want it to do (or not do, as the case may be).

Course Background. Loosely speaking, control is the process of getting something to do what you want it to do (or not do, as the case may be). ECE4520/5520: Multivariable Control Systems I. 1 1 Course Background 1.1: From time to frequency domain Loosely speaking, control is the process of getting something to do what you want it to do (or not

More information

State Estimation of Linear and Nonlinear Dynamic Systems

State Estimation of Linear and Nonlinear Dynamic Systems State Estimation of Linear and Nonlinear Dynamic Systems Part III: Nonlinear Systems: Extended Kalman Filter (EKF) and Unscented Kalman Filter (UKF) James B. Rawlings and Fernando V. Lima Department of

More information

Assignment 4 Solutions Continuous-Time Fourier Transform

Assignment 4 Solutions Continuous-Time Fourier Transform Assignment 4 Solutions Continuous-Time Fourier Transform ECE 3 Signals and Systems II Version 1.01 Spring 006 1. Properties of complex numbers. Let c 1 α 1 + jβ 1 and c α + jβ be two complex numbers. a.

More information