4 Optimal State Estimation

Size: px
Start display at page:

Download "4 Optimal State Estimation"

Transcription

1 4 Optimal State Estimation Consider the LTI system ẋ(t) = Ax(t)+B w w(t), y(t) = C y x(t)+d yw w(t), z(t) = C z x(t) Problem: Compute (Â,F) such that the output of the state estimator ˆx(t) = ˆx(t) Fy(t), ẑ(t) = C zˆx(t) stabilizes the state estimation error and minimizes the cost function J := lim t E [ (z(t) ẑ(t)) T (z(t) ẑ(t)) ]. Assumptions: a) (A,C y ) detectable; b) w(t) is a Gaussian zero mean white noise with variance W. MAE 28 B 46 Maurício de Oliveira

2 Solution: Define e(t) := x(t) ˆx(t) so that z(t) ẑ(t) = C z e(t). Now write the dynamics of the estimation error ė(t) = ẋ(t) ˆx(t), = Ax(t) ˆx(t)+Fy(t)+B ww(t), = (A Â+FC y)x(t)+âe(t)+(b w +FD yw )w(t) First observation: if A is unstable x(t) is unbounded and so is e(t), with one exception. If and  = A+FC y = A Â+FC y = ė(t) = (A+FC y )e(t)+(b w +FD yw )w(t). That is, the dynamics of e(t) and x(t) are decoupled! (note that z(t) ẑ(t) = C z e(t) is also decoupled from x(t)). This choice of  produces the state observer ˆx = Aˆx+F(ŷ y), ŷ = C yˆx, ẑ = C zˆx. in which the only unknown is the observer gain F. The problem has been reduced to find the gain F. MAE 28 B 47 Maurício de Oliveira

3 Simplified problem: Compute the stabilizing state estimation gain F so as to minimize J := lim t E [ e(t) T C T z C z e(t)] where e(t) is the state of the LTI system Assumptions: a) (A,C y ) is detectable; ė(t) = (A+FC y )e(t)+(b w +FD yw )w(t). b) w(t) is a Gaussian zero mean white noise with variance W. Solution: As before where X is the Gramian J = trace [ X(B w +FD yw )W(B w +FD yw ) T] (A+FC y ) T X +X(A+FC y )+C T z C z =. However, in this form, F appears simultaneously at the cost and at the Lyapunov equation, and we can not use completion of squares to determine F. Use duality! MAE 28 B 48 Maurício de Oliveira

4 4.1 Duality Assume W. Consider the cost function J = trace ( XBWB T), where X is the solution to the Lyapunov equation A T X +XA+C T C =. An alternative (dual) expression for J can be obtained from That is J = trace ( XBWB T), ([ ) = trace e ATt C T Ce At dt ]BWB T, ( = trace Ce At BWB T e ATt C T) dt, ( [ ) = trace C e At BWB T e ATt dt ]C T. J = trace ( CYC T), where Y is the solution to the Lyapunov equation AY +YA T +BWB T =. Recall that Y is also the state covariance matrix! MAE 28 B 49 Maurício de Oliveira

5 Back to the determination of F, using the dual formulation J = trace ( ) C z YCz T where (A+FC y )Y +Y(A+FC y ) T +(B w +FD yw )W(B w +FD yw ) T =. The gain F now appears only in the Lyapunov equation! Assuming that B w WD T yw =, D yw WDT yw, (for simplicity only, without loss of generality!) the above equation becomes (A+FC y )Y +Y(A+FC y ) T +B w WB T w +FD yw WD T ywf T =. We can now complete the squares to obtain the ARE AY +YA T YC T y (D yw WD T yw) 1 C y Y +B w WB T w = and the associated optimal gain F = YC T y (D yw WD T yw) 1. MAE 28 B 5 Maurício de Oliveira

6 4.2 Summary on Estimation Problem: Given the LTI system ẋ(t) = Ax(t)+B w w(t), y(t) = C y x(t)+d yw w(t), z(t) = C z x(t) compute the estimation gain F that stabilizes the state estimation erros and that the output of the state estimator minimizes the cost function ˆx(t) = Aˆx(t)+F(ŷ(t) y(t)), ŷ(t) = C yˆx(t), ẑ(t) = C zˆx(t) J := lim t E [ (z(t) ẑ(t)) T (z(t) ẑ(t)) ]. Assumptions: a) (A,C y ) detectable; b) w(t) is a Gaussian zero mean white noise with variance W ; c) B w WDyw T =, D yw WDT yw. Solution: Find the stabilizing solution to the ARE The optimal gain is AY +YA T YC T y (D yw WDT yw ) 1 C y Y +B w WB T w =. F = YC T y (D yw WD T yw) 1. MAE 28 B 51 Maurício de Oliveira

7 Things we can infer from the form of the solution: 1) A+FC y is stable even if A is not! What happens if A is unstable and  = A+FC y +δ? 2) The assumption D yw WDyw T is error free. reads no combination of the measurement 3) If D yw WD T yw, then part of the state could be reconstructed exactly from the measurements. While this might sounds easier, we do not know how to solve this problem :). 4) State estimation is equivalent to the state feedback problem for the LTI system minj = lim t E [ x T B w WB T w x+ut D yw WD T yw u], ẋ = A T x+c T y u+ct z w, u = F T x 5) The optimal gain F does not depend on C z! The optimal cost does! MAE 28 B 52 Maurício de Oliveira

8 4.3 Example: estimating the state of a satellite in circular orbit r u 1 u 2 m θ e Satellite of mass m with thrust in the radial direction u 1 and in the tangential direction u 2. Continuing... m( r r θ 2 ) = u 1 km r 2 +w 1, m(2ṙ θ+r θ) = u 2 +w 2, where w 1 and w 2 are independent white noise disturbances with variances δ 1 and δ 2. For the purpose of estimation we set u 1 = u 2 = for the moment. As before, putting in state space and linearizing ẋ = ω 2 2 r ω 2 ω/ r x+ 1/m 1/(m r) Consider that you have a noisy measurement of θ (x 2 ) where E{vv T } = δ 3. Problem: Given y = [ 1 ] x+v ( w1 m = 1 kg, r = R+3 km, k = GM where G N m 2 /kg 2 is the universal gravitational constant, and M kg and R km are the mass and radius of the earth. If the variances δ 1 = δ 2 = δ 3 =.1N, estimate the state of the satelite. w 2 ) MAE 28 B 53 Maurício de Oliveira

9 % MAE 28 B - Linear Control Design % Mauricio de Oliveira % % State estimation - Part I % m = 1; % 1 kg r = 3E3; % 3 km R = 6.37E6; % ˆ3 km G = 6.673E-11; % N mˆ2/kgˆ2 M = 5.98E24; % ˆ24 kg k = G * M; % gravitational force constant w = sqrt(k/((r+r)ˆ3)); % angular velocity (rad/s) v = w * (R + r); % "ground" velocity (m/s) % linearized system matrices A = [ 1 ; 1; 3*wˆ2 2*(r+R)*w; -2*w/(r+R) ]; Bu = [ ; ; 1/m ; 1/(m*(r+R))]; Bw = [ ; ; 1/m ; 1/(m*(r+R))]; % noise variances W =.1 * eye(2) W = 1.e-1 1.e-1 % any measurement that does not include x2 (theta) is not observable! % for instance Cy = [1 ; 1 ; 1]; % system sys = ss(a, Bw, Cy, ) a = x1 x2 x3 x4 x1 1 x2 1 x3 4.34e e+4 x e-1 b = u1 u2 x1 x2 x3.1 x e-9 c = x1 x2 x3 x4 y1 1 y2 1 y3 1 d = MAE 28 B 54 Maurício de Oliveira

10 u1 u2 y1 y2 y3 Continuous-time model. % take the comment out of next line to see error messages! %est = kalman(sys, W, eye(size(cy,1))); % back to the problem % measuring x2 (theta) Cy = [ r+r ]; % augment noise matrices Bwa = [Bw zeros(4,1)] Bwa = 1.e e-9 Dywa = [zeros(1,2) 1] Dywa = 1 % scale T = diag([1 r+r 1 r+r]) T = % similarity transformation At = T * A / T At = 1.e+ 1.e e e e-3 But = T * Bu But = 1.e-2 1.e-2 Bwt = T * Bwa Bwt = 1.e-2 1.e-2 Cyt = Cy / T Cyt = 1 Dywt = Dywa MAE 28 B 55 Maurício de Oliveira

11 Dywt = 1 Ww = W Ww = 1.e-1 1.e-1 Wv =.1 Wv = 1.e-1 Wt = [Ww zeros(2, 1); zeros(1, 2) Wv] Wt = 1.e-1 1.e-1 1.e-1 % compute using dual state feedback [F,X,S] = lqr(at, Cyt, Bwt * Wt * Bwt, Dywt * Wt * Dywt ); F = - F F = 8.973e e e e-2 % compute using matlab s kalman sys = ss(at, Bwt(:,1:2), Cyt, ); est = kalman(sys, Ww, Wv/rˆ2); F = -est.b F = e e+1 6.1e+3-3.4e+3 % error dynamics eig(at + F * Cyt) ans = e e e e+1i e e+1i % simulate estimator sys = ss(t * A / T, T * Bwa, Cy / T, Dywa); filt = est * sys; Tmax = 2; T = :.1 : Tmax; w = [randn(length(t),2)*sqrtm(ww) randn(length(t),1)*sqrtm(wv)]; % estimate stationary position figure(1) MAE 28 B 56 Maurício de Oliveira

12 x = [; ; ; ] x = xhat = [; ; -6; ] xhat = -6 [y,t,x] = lsim(sys, w, T, x); [yf,tf,xf] = lsim(filt, w, T, [xhat; x]); xhat = xf(:,1:4); figure(1) plot(t, x(:,[1 2]), g, t, xhat(:,[1 2]), b ), title( system and estimator trajectory (x_1 and x_2) ) xlim([, Tmax]) figure(2) plot(t, x(:,[3 4]), g, t, xhat(:,[3 4]), b ), title( system and estimator trajectory (x_3 and x_4) ) xlim([, Tmax]) figure(3) plot([ T(end)], [ ], g, t, x(:,[1 2])-xhat(:,[1 2]), b ), title( estimation error (x_1 and x_2) ) xlim([, Tmax]) figure(4) plot([ T(end)], [ ], g, t, x(:,[3 4])-xhat(:,[3 4]), b ), title( estimation error (x_3 and x_4) ) xlim([, Tmax]) diary off MAE 28 B 57 Maurício de Oliveira

13 4.4 Example: estimating position Dynamics of particle of mass m = 1 Kg in a line: mẍ = w 1, where w 1 is a zero-mean white noise disturbances with variance δ 1 = (1 N) 2. As a measurement we have a noisy measurement of position, say through GPS y 1 = x+w 2 where w 2 is a white noise disturbances with variance δ 2 = (1 m) 2. In state space [ ] [ ]( ) 1 w1 ẋ = x+, 1/m w 2 y = [ 1 ] x+ [ 1 ]( ) w 1 w 2 Problem #1: Estimate the state x. Problem #2: Can an accelerometer improve the estimate? MAE 28 B 58 Maurício de Oliveira

14 % MAE 28 B - Linear Control Design % Mauricio de Oliveira % % State estimation - Part II % m = 1; % 1 kg % linearized system matrices A = [ 1; ] A = 1 Bw = [; 1/m] Bw = 1.e-2 % position Cy = [1 ] Cy = 1 Dyw = Dyw = % noise variances Ww = 1ˆ2 Ww = 1 % augmented system Bwa = [Bw zeros(2,1)] Bwa = 1.e-2 Dywa = [zeros(1,1) 1] Dywa = 1 % measurement noise variances Wv = 1ˆ2 Wv = 1 Wa = [Ww zeros(1, 1); zeros(1, 1) Wv] Wa = 1 1 % compute using dual state feedback [F,X,S] = lqr(a, Cy, Bwa * Wa * Bwa, Dywa * Wa * Dywa ); F = - F F = MAE 28 B 59 Maurício de Oliveira

15 e-1-1.e-1 % compute using matlab s kalman sys = ss(a, Bw, Cy, Dyw); est = kalman(sys, Ww, Wv); F = -est.b F = e-1-1.e-1 % error dynamics eig(a + F * Cy) ans = e e-1i e e-1i % try to simulate estimator sys1 = ss(a, Bwa, Cy, Dywa); filt1 = est * sys1; Tmax = 24; T = :.1 : Tmax; w = [randn(length(t),1)*sqrtm(ww) randn(length(t),1)*sqrtm(wv)]; % estimate stationary position (no noise) figure(1) x = [1; ] x = 1 xhat = [; ] xhat = [y,t,x] = initial(sys1, x, T); [yf,tf,xf] = initial(filt1, [xhat; x], T); xhat = xf(:,1:2); figure(1) plot(t, x, t, xhat), title( system and estimator trajectory ) xlim([, Tmax]) figure(2) plot(t, x-xhat(:,1:2)), title( estimation error ) xlim([, Tmax]) pause % estimate stationary position (with measurement noise) wm = w; MAE 28 B 6 Maurício de Oliveira

16 wm(:,1) = ; x = [1; ] x = 1 xhat = [5; ] xhat = 5 [y,t,x] = lsim(sys1, wm, T, x); [yf,tf,xf] = lsim(filt1, wm, T, [xhat; x]); xhat = xf(:,1:2); figure(1) plot(t, x, g, t, xhat, b ), title( system and estimator trajectory ) xlim([, Tmax]) figure(2) plot([ T(end)], [ ], g, t, x-xhat(:,1:2), b ), title( estimation error ) xlim([, Tmax]) pause % estimate moving position (with measurement and process noise) x = [; ] x = xhat = zeros(2,1) xhat = [y,t,x] = lsim(sys1, w, T, x); [yf,tf,xf] = lsim(filt1, w, T, [xhat; x]); xhat = xf(:,1:2); figure(1) plot(t, x, g, t, xhat, b ), title( system and estimator trajectory ) xlim([, Tmax]) figure(2) plot([ T(end)], [ ], g, t, x-xhat(:,1:2), b ), title( estimation error ) xlim([, Tmax]) diary off MAE 28 B 61 Maurício de Oliveira

17 % MAE 28 B - Linear Control Design % Mauricio de Oliveira % % State estimation - Part III % m = 1; % 1 kg % linearized system matrices A = [ 1; ] A = 1 Bw = [; 1/m] Bw = 1.e-2 % position Cy1 = [1 ] Cy1 = 1 Dyw1 = Dyw1 = % accelerometer P = [ 1]; Cy2 = P*A Cy2 = Dyw2 = P*Bw Dyw2 = 1.e-2 Cy = [Cy1; Cy2]; Dyw = [Dyw1; Dyw2]; % noise variances Ww = 1ˆ2 Ww = 1 Wv = diag([1ˆ2 1]); % augmented system matrices Bwa = [Bw zeros(2,2)] Bwa = 1.e-2 Dywa = [zeros(2,1) eye(2)] Dywa = 1 1 Wa = [Ww zeros(1, 2); zeros(2, 1) Wv] MAE 28 B 62 Maurício de Oliveira

18 Wa = % compute using matlab s kalman sys = ss(a, Bw, Cy, Dyw); est = kalman(sys, Ww, Wv); F = -est.b F = e e e-3 % error dynamics eig(a + F * Cy) ans = e e-1i e e-1i % try to simulate estimator sys2 = ss(a, Bwa, Cy, Dywa); filt2 = est * sys2; Tmax = 24; T = :.1 : Tmax; w = [randn(length(t),1)*sqrtm(ww) randn(length(t),2)*sqrtm(wv)]; % estimate stationary position (with measurement noise) wm = w; wm(:,1) = ; x = [1; ] x = 1 xhat = [5; ] xhat = 5 [y,t,x] = lsim(sys2, wm, T, x); if exist( filt1 ) end [yf2,tf2,xf2] = lsim(filt2, wm, T, [xhat; x]); xhat2 = xf2(:,1:2); figure(1) if exist( filt1 ) else plot(t, x, g, t, xhat2, b ), end title( system and estimator trajectory ) xlim([, Tmax]) figure(2) MAE 28 B 63 Maurício de Oliveira

19 if exist( filt1 ) else plot([ T(end)], [ ], g, t, x-xhat2(:,1:2), b ), end title( estimation error ) xlim([, Tmax]) pause % estimate moving position (with measurement and process noise) x = [1; ] x = 1 xhat = [5; ] xhat = 5 [y,t,x] = lsim(sys2, w, T, x); if exist( filt1 ) end [yf2,tf2,xf2] = lsim(filt2, w, T, [xhat; x]); xhat2 = xf2(:,1:2); figure(1) if exist( filt1 ) else plot(t, x, g, t, xhat2, b ), end title( system and estimator trajectory ) xlim([, Tmax]) figure(2) if exist( filt1 ) else plot([ T(end)], [ ], g, t, x-xhat2(:,1:2), b ), end title( estimation error ) xlim([, Tmax]) diary off MAE 28 B 64 Maurício de Oliveira

9 The LQR Problem Revisited

9 The LQR Problem Revisited 9 he LQR Problem Revisited Problem: Compute a state feedback controller u(t) = Kx(t) that stabilizes the closed loop system and minimizes J := lim E [ z(t) z(t) ] t for the LI system Assumptions: a) D

More information

1 Controllability and Observability

1 Controllability and Observability 1 Controllability and Observability 1.1 Linear Time-Invariant (LTI) Systems State-space: Dimensions: Notation Transfer function: ẋ = Ax+Bu, x() = x, y = Cx+Du. x R n, u R m, y R p. Note that H(s) is always

More information

8 A First Glimpse on Design with LMIs

8 A First Glimpse on Design with LMIs 8 A First Glimpse on Design with LMIs 8.1 Conceptual Design Problem Given a linear time invariant system design a linear time invariant controller or filter so as to guarantee some closed loop indices

More information

6.241 Dynamic Systems and Control

6.241 Dynamic Systems and Control 6.241 Dynamic Systems and Control Lecture 24: H2 Synthesis Emilio Frazzoli Aeronautics and Astronautics Massachusetts Institute of Technology May 4, 2011 E. Frazzoli (MIT) Lecture 24: H 2 Synthesis May

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

Chapter 3. LQ, LQG and Control System Design. Dutch Institute of Systems and Control

Chapter 3. LQ, LQG and Control System Design. Dutch Institute of Systems and Control Chapter 3 LQ, LQG and Control System H 2 Design Overview LQ optimization state feedback LQG optimization output feedback H 2 optimization non-stochastic version of LQG Application to feedback system design

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

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

Computer Problem 1: SIE Guidance, Navigation, and Control

Computer Problem 1: SIE Guidance, Navigation, and Control Computer Problem 1: SIE 39 - Guidance, Navigation, and Control Roger Skjetne March 12, 23 1 Problem 1 (DSRV) We have the model: m Zẇ Z q ẇ Mẇ I y M q q + ẋ U cos θ + w sin θ ż U sin θ + w cos θ θ q Zw

More information

Lecture 8. Applications

Lecture 8. Applications Lecture 8. Applications Ivan Papusha CDS270 2: Mathematical Methods in Control and System Engineering May 8, 205 / 3 Logistics hw7 due this Wed, May 20 do an easy problem or CYOA hw8 (design problem) will

More information

1 Continuous-time Systems

1 Continuous-time Systems Observability Completely controllable systems can be restructured by means of state feedback to have many desirable properties. But what if the state is not available for feedback? What if only the output

More information

to have roots with negative real parts, the necessary and sufficient conditions are that:

to have roots with negative real parts, the necessary and sufficient conditions are that: THE UNIVERSITY OF TEXAS AT SAN ANTONIO EE 543 LINEAR SYSTEMS AND CONTROL H O M E W O R K # 7 Sebastian A. Nugroho November 6, 7 Due date of the homework is: Sunday, November 6th @ :59pm.. The following

More information

SYSTEMTEORI - KALMAN FILTER VS LQ CONTROL

SYSTEMTEORI - KALMAN FILTER VS LQ CONTROL SYSTEMTEORI - KALMAN FILTER VS LQ CONTROL 1. Optimal regulator with noisy measurement Consider the following system: ẋ = Ax + Bu + w, x(0) = x 0 where w(t) is white noise with Ew(t) = 0, and x 0 is a stochastic

More information

State Feedback MAE 433 Spring 2012 Lab 7

State Feedback MAE 433 Spring 2012 Lab 7 State Feedback MAE 433 Spring 1 Lab 7 Prof. C. Rowley and M. Littman AIs: Brandt Belson, onathan Tu Princeton University April 4-7, 1 1 Overview This lab addresses the control of an inverted pendulum balanced

More information

7.1 Linear Systems Stability Consider the Continuous-Time (CT) Linear Time-Invariant (LTI) system

7.1 Linear Systems Stability Consider the Continuous-Time (CT) Linear Time-Invariant (LTI) system 7 Stability 7.1 Linear Systems Stability Consider the Continuous-Time (CT) Linear Time-Invariant (LTI) system ẋ(t) = A x(t), x(0) = x 0, A R n n, x 0 R n. (14) The origin x = 0 is a globally asymptotically

More information

= m(0) + 4e 2 ( 3e 2 ) 2e 2, 1 (2k + k 2 ) dt. m(0) = u + R 1 B T P x 2 R dt. u + R 1 B T P y 2 R dt +

= m(0) + 4e 2 ( 3e 2 ) 2e 2, 1 (2k + k 2 ) dt. m(0) = u + R 1 B T P x 2 R dt. u + R 1 B T P y 2 R dt + ECE 553, Spring 8 Posted: May nd, 8 Problem Set #7 Solution Solutions: 1. The optimal controller is still the one given in the solution to the Problem 6 in Homework #5: u (x, t) = p(t)x k(t), t. The minimum

More information

Pole placement control: state space and polynomial approaches Lecture 2

Pole placement control: state space and polynomial approaches Lecture 2 : state space and polynomial approaches Lecture 2 : a state O. Sename 1 1 Gipsa-lab, CNRS-INPG, FRANCE Olivier.Sename@gipsa-lab.fr www.gipsa-lab.fr/ o.sename -based November 21, 2017 Outline : a state

More information

Observability. It was the property in Lyapunov stability which allowed us to resolve that

Observability. It was the property in Lyapunov stability which allowed us to resolve that Observability We have seen observability twice already It was the property which permitted us to retrieve the initial state from the initial data {u(0),y(0),u(1),y(1),...,u(n 1),y(n 1)} It was the property

More information

Observability and state estimation

Observability and state estimation EE263 Autumn 2015 S Boyd and S Lall Observability and state estimation state estimation discrete-time observability observability controllability duality observers for noiseless case continuous-time observability

More information

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University H 2 Optimal State Feedback Control Synthesis Raktim Bhattacharya Aerospace Engineering, Texas A&M University Motivation Motivation w(t) u(t) G K y(t) z(t) w(t) are exogenous signals reference, process

More information

Module 08 Observability and State Estimator Design of Dynamical LTI Systems

Module 08 Observability and State Estimator Design of Dynamical LTI Systems Module 08 Observability and State Estimator Design of Dynamical LTI Systems Ahmad F. Taha EE 5143: Linear Systems and Control Email: ahmad.taha@utsa.edu Webpage: http://engineering.utsa.edu/ataha November

More information

Lecture 19 Observability and state estimation

Lecture 19 Observability and state estimation EE263 Autumn 2007-08 Stephen Boyd Lecture 19 Observability and state estimation state estimation discrete-time observability observability controllability duality observers for noiseless case continuous-time

More information

ME 132, Fall 2015, Quiz # 2

ME 132, Fall 2015, Quiz # 2 ME 132, Fall 2015, Quiz # 2 # 1 # 2 # 3 # 4 # 5 # 6 Total NAME 14 10 8 6 14 8 60 Rules: 1. 2 sheets of notes allowed, 8.5 11 inches. Both sides can be used. 2. Calculator is allowed. Keep it in plain view

More information

Modeling and Analysis of Dynamic Systems

Modeling and Analysis of Dynamic Systems Modeling and Analysis of Dynamic Systems Dr. Guillaume Ducard Fall 2017 Institute for Dynamic Systems and Control ETH Zurich, Switzerland G. Ducard c 1 / 54 Outline 1 G. Ducard c 2 / 54 Outline 1 G. Ducard

More information

Automatic Control II Computer exercise 3. LQG Design

Automatic Control II Computer exercise 3. LQG Design Uppsala University Information Technology Systems and Control HN,FS,KN 2000-10 Last revised by HR August 16, 2017 Automatic Control II Computer exercise 3 LQG Design Preparations: Read Chapters 5 and 9

More information

A Crash Course on Kalman Filtering

A Crash Course on Kalman Filtering A Crash Course on Kalman Filtering Dan Simon Cleveland State University Fall 2014 1 / 64 Outline Linear Systems Probability State Means and Covariances Least Squares Estimation The Kalman Filter Unknown

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

Lecture 10: Linear Matrix Inequalities Dr.-Ing. Sudchai Boonto

Lecture 10: Linear Matrix Inequalities Dr.-Ing. Sudchai Boonto Dr-Ing Sudchai Boonto Department of Control System and Instrumentation Engineering King Mongkuts Unniversity of Technology Thonburi Thailand Linear Matrix Inequalities A linear matrix inequality (LMI)

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

14 - Gaussian Stochastic Processes

14 - Gaussian Stochastic Processes 14-1 Gaussian Stochastic Processes S. Lall, Stanford 211.2.24.1 14 - Gaussian Stochastic Processes Linear systems driven by IID noise Evolution of mean and covariance Example: mass-spring system Steady-state

More information

Topic # Feedback Control Systems

Topic # Feedback Control Systems Topic #17 16.31 Feedback Control Systems Deterministic LQR Optimal control and the Riccati equation Weight Selection Fall 2007 16.31 17 1 Linear Quadratic Regulator (LQR) Have seen the solutions to the

More information

Module 03 Linear Systems Theory: Necessary Background

Module 03 Linear Systems Theory: Necessary Background Module 03 Linear Systems Theory: Necessary Background Ahmad F. Taha EE 5243: Introduction to Cyber-Physical Systems Email: ahmad.taha@utsa.edu Webpage: http://engineering.utsa.edu/ taha/index.html September

More information

LQR, Kalman Filter, and LQG. Postgraduate Course, M.Sc. Electrical Engineering Department College of Engineering University of Salahaddin

LQR, Kalman Filter, and LQG. Postgraduate Course, M.Sc. Electrical Engineering Department College of Engineering University of Salahaddin LQR, Kalman Filter, and LQG Postgraduate Course, M.Sc. Electrical Engineering Department College of Engineering University of Salahaddin May 2015 Linear Quadratic Regulator (LQR) Consider a linear system

More information

EL 625 Lecture 10. Pole Placement and Observer Design. ẋ = Ax (1)

EL 625 Lecture 10. Pole Placement and Observer Design. ẋ = Ax (1) EL 625 Lecture 0 EL 625 Lecture 0 Pole Placement and Observer Design Pole Placement Consider the system ẋ Ax () The solution to this system is x(t) e At x(0) (2) If the eigenvalues of A all lie in the

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

6 OUTPUT FEEDBACK DESIGN

6 OUTPUT FEEDBACK DESIGN 6 OUTPUT FEEDBACK DESIGN When the whole sate vector is not available for feedback, i.e, we can measure only y = Cx. 6.1 Review of observer design Recall from the first class in linear systems that a simple

More information

Application of state observers in attitude estimation using low-cost sensors

Application of state observers in attitude estimation using low-cost sensors Application of state observers in attitude estimation using low-cost sensors Martin Řezáč Czech Technical University in Prague, Czech Republic March 26, 212 Introduction motivation for inertial estimation

More information

D(s) G(s) A control system design definition

D(s) G(s) A control system design definition R E Compensation D(s) U Plant G(s) Y Figure 7. A control system design definition x x x 2 x 2 U 2 s s 7 2 Y Figure 7.2 A block diagram representing Eq. (7.) in control form z U 2 s z Y 4 z 2 s z 2 3 Figure

More information

State estimation and the Kalman filter

State estimation and the Kalman filter State estimation and the Kalman filter PhD, David Di Ruscio Telemark university college Department of Technology Systems and Control Engineering N-3914 Porsgrunn, Norway Fax: +47 35 57 52 50 Tel: +47 35

More information

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS BALANCING-RELATED Peter Benner Professur Mathematik in Industrie und Technik Fakultät für Mathematik Technische Universität Chemnitz Computational Methods with Applications Harrachov, 19 25 August 2007

More information

STATISTICAL ORBIT DETERMINATION

STATISTICAL ORBIT DETERMINATION STATISTICAL ORBIT DETERMINATION Satellite Tracking Example of SNC and DMC ASEN 5070 LECTURE 6 4.08.011 1 We will develop a simple state noise compensation (SNC) algorithm. This algorithm adds process noise

More information

Optimal discrete-time H /γ 0 filtering and control under unknown covariances

Optimal discrete-time H /γ 0 filtering and control under unknown covariances International Journal of Control ISSN: 0020-7179 (Print) 1366-5820 (Online) Journal homepage: http://www.tandfonline.com/loi/tcon20 Optimal discrete-time H filtering and control under unknown covariances

More information

LQ Control of a Two Wheeled Inverted Pendulum Process

LQ Control of a Two Wheeled Inverted Pendulum Process Uppsala University Information Technology Dept. of Systems and Control KN,HN,FS 2000-10 Last rev. September 12, 2017 by HR Reglerteknik II Instruction to the laboratory work LQ Control of a Two Wheeled

More information

Robust Control 5 Nominal Controller Design Continued

Robust Control 5 Nominal Controller Design Continued Robust Control 5 Nominal Controller Design Continued Harry G. Kwatny Department of Mechanical Engineering & Mechanics Drexel University 4/14/2003 Outline he LQR Problem A Generalization to LQR Min-Max

More information

Student Solutions Manual for. Design of Nonlinear Control Systems with the Highest Derivative in Feedback

Student Solutions Manual for. Design of Nonlinear Control Systems with the Highest Derivative in Feedback Student Solutions Manual for Design of Nonlinear Control Systems with the Highest Derivative in Feedback World Scientific, 2004 ISBN 981-238-899-0 Valery D. Yurkevich Copyright c 2007 by Valery D. Yurkevich

More information

Represent this system in terms of a block diagram consisting only of. g From Newton s law: 2 : θ sin θ 9 θ ` T

Represent this system in terms of a block diagram consisting only of. g From Newton s law: 2 : θ sin θ 9 θ ` T Exercise (Block diagram decomposition). Consider a system P that maps each input to the solutions of 9 4 ` 3 9 Represent this system in terms of a block diagram consisting only of integrator systems, represented

More information

1 Some Facts on Symmetric Matrices

1 Some Facts on Symmetric Matrices 1 Some Facts on Symmetric Matrices Definition: Matrix A is symmetric if A = A T. Theorem: Any symmetric matrix 1) has only real eigenvalues; 2) is always iagonalizable; 3) has orthogonal eigenvectors.

More information

5. Observer-based Controller Design

5. Observer-based Controller Design EE635 - Control System Theory 5. Observer-based Controller Design Jitkomut Songsiri state feedback pole-placement design regulation and tracking state observer feedback observer design LQR and LQG 5-1

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

Chapter 5. Standard LTI Feedback Optimization Setup. 5.1 The Canonical Setup

Chapter 5. Standard LTI Feedback Optimization Setup. 5.1 The Canonical Setup Chapter 5 Standard LTI Feedback Optimization Setup Efficient LTI feedback optimization algorithms comprise a major component of modern feedback design approach: application problems involving complex models

More information

CONTROL DESIGN FOR SET POINT TRACKING

CONTROL DESIGN FOR SET POINT TRACKING Chapter 5 CONTROL DESIGN FOR SET POINT TRACKING In this chapter, we extend the pole placement, observer-based output feedback design to solve tracking problems. By tracking we mean that the output is commanded

More information

Problem Set 5 Solutions 1

Problem Set 5 Solutions 1 Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.245: MULTIVARIABLE CONTROL SYSTEMS by A. Megretski Problem Set 5 Solutions The problem set deals with Hankel

More information

x(n + 1) = Ax(n) and y(n) = Cx(n) + 2v(n) and C = x(0) = ξ 1 ξ 2 Ex(0)x(0) = I

x(n + 1) = Ax(n) and y(n) = Cx(n) + 2v(n) and C = x(0) = ξ 1 ξ 2 Ex(0)x(0) = I A-AE 567 Final Homework Spring 213 You will need Matlab and Simulink. You work must be neat and easy to read. Clearly, identify your answers in a box. You will loose points for poorly written work. You

More information

Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters

Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters Linear-Quadratic-Gaussian (LQG) Controllers and Kalman Filters Emo Todorov Applied Mathematics and Computer Science & Engineering University of Washington Winter 204 Emo Todorov (UW) AMATH/CSE 579, Winter

More information

= 0 otherwise. Eu(n) = 0 and Eu(n)u(m) = δ n m

= 0 otherwise. Eu(n) = 0 and Eu(n)u(m) = δ n m A-AE 567 Final Homework Spring 212 You will need Matlab and Simulink. You work must be neat and easy to read. Clearly, identify your answers in a box. You will loose points for poorly written work. You

More information

Georgia Institute of Technology Nonlinear Controls Theory Primer ME 6402

Georgia Institute of Technology Nonlinear Controls Theory Primer ME 6402 Georgia Institute of Technology Nonlinear Controls Theory Primer ME 640 Ajeya Karajgikar April 6, 011 Definition Stability (Lyapunov): The equilibrium state x = 0 is said to be stable if, for any R > 0,

More information

Time-Invariant Linear Quadratic Regulators Robert Stengel Optimal Control and Estimation MAE 546 Princeton University, 2015

Time-Invariant Linear Quadratic Regulators Robert Stengel Optimal Control and Estimation MAE 546 Princeton University, 2015 Time-Invariant Linear Quadratic Regulators Robert Stengel Optimal Control and Estimation MAE 546 Princeton University, 15 Asymptotic approach from time-varying to constant gains Elimination of cross weighting

More information

MAE 143B - Homework 8 Solutions

MAE 143B - Homework 8 Solutions MAE 43B - Homework 8 Solutions P6.4 b) With this system, the root locus simply starts at the pole and ends at the zero. Sketches by hand and matlab are in Figure. In matlab, use zpk to build the system

More information

FEL3210 Multivariable Feedback Control

FEL3210 Multivariable Feedback Control FEL3210 Multivariable Feedback Control Lecture 8: Youla parametrization, LMIs, Model Reduction and Summary [Ch. 11-12] Elling W. Jacobsen, Automatic Control Lab, KTH Lecture 8: Youla, LMIs, Model Reduction

More information

Classical Mechanics Comprehensive Exam Solution

Classical Mechanics Comprehensive Exam Solution Classical Mechanics Comprehensive Exam Solution January 31, 011, 1:00 pm 5:pm Solve the following six problems. In the following problems, e x, e y, and e z are unit vectors in the x, y, and z directions,

More information

Control Systems Design, SC4026. SC4026 Fall 2009, dr. A. Abate, DCSC, TU Delft

Control Systems Design, SC4026. SC4026 Fall 2009, dr. A. Abate, DCSC, TU Delft Control Systems Design, SC4026 SC4026 Fall 2009, dr. A. Abate, DCSC, TU Delft Lecture 4 Controllability (a.k.a. Reachability) vs Observability Algebraic Tests (Kalman rank condition & Hautus test) A few

More information

ME 234, Lyapunov and Riccati Problems. 1. This problem is to recall some facts and formulae you already know. e Aτ BB e A τ dτ

ME 234, Lyapunov and Riccati Problems. 1. This problem is to recall some facts and formulae you already know. e Aτ BB e A τ dτ ME 234, Lyapunov and Riccati Problems. This problem is to recall some facts and formulae you already know. (a) Let A and B be matrices of appropriate dimension. Show that (A, B) is controllable if and

More information

1 (30 pts) Dominant Pole

1 (30 pts) Dominant Pole EECS C8/ME C34 Fall Problem Set 9 Solutions (3 pts) Dominant Pole For the following transfer function: Y (s) U(s) = (s + )(s + ) a) Give state space description of the system in parallel form (ẋ = Ax +

More information

Time-Invariant Linear Quadratic Regulators!

Time-Invariant Linear Quadratic Regulators! Time-Invariant Linear Quadratic Regulators Robert Stengel Optimal Control and Estimation MAE 546 Princeton University, 17 Asymptotic approach from time-varying to constant gains Elimination of cross weighting

More information

Control Systems Design, SC4026. SC4026 Fall 2010, dr. A. Abate, DCSC, TU Delft

Control Systems Design, SC4026. SC4026 Fall 2010, dr. A. Abate, DCSC, TU Delft Control Systems Design, SC426 SC426 Fall 2, dr A Abate, DCSC, TU Delft Lecture 5 Controllable Canonical and Observable Canonical Forms Stabilization by State Feedback State Estimation, Observer Design

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

Lecture 9 Nonlinear Control Design

Lecture 9 Nonlinear Control Design Lecture 9 Nonlinear Control Design Exact-linearization Lyapunov-based design Lab 2 Adaptive control Sliding modes control Literature: [Khalil, ch.s 13, 14.1,14.2] and [Glad-Ljung,ch.17] Course Outline

More information

16.30/31, Fall 2010 Recitation # 13

16.30/31, Fall 2010 Recitation # 13 16.30/31, Fall 2010 Recitation # 13 Brandon Luders December 6, 2010 In this recitation, we tie the ideas of Lyapunov stability analysis (LSA) back to previous ways we have demonstrated stability - but

More information

Übersetzungshilfe / Translation aid (English) To be returned at the end of the exam!

Übersetzungshilfe / Translation aid (English) To be returned at the end of the exam! Prüfung Regelungstechnik I (Control Systems I) Prof. Dr. Lino Guzzella 3. 8. 24 Übersetzungshilfe / Translation aid (English) To be returned at the end of the exam! Do not mark up this translation aid

More information

Consider a particle in 1D at position x(t), subject to a force F (x), so that mẍ = F (x). Define the kinetic energy to be.

Consider a particle in 1D at position x(t), subject to a force F (x), so that mẍ = F (x). Define the kinetic energy to be. Chapter 4 Energy and Stability 4.1 Energy in 1D Consider a particle in 1D at position x(t), subject to a force F (x), so that mẍ = F (x). Define the kinetic energy to be T = 1 2 mẋ2 and the potential energy

More information

1. Find the solution of the following uncontrolled linear system. 2 α 1 1

1. Find the solution of the following uncontrolled linear system. 2 α 1 1 Appendix B Revision Problems 1. Find the solution of the following uncontrolled linear system 0 1 1 ẋ = x, x(0) =. 2 3 1 Class test, August 1998 2. Given the linear system described by 2 α 1 1 ẋ = x +

More information

Subject: Optimal Control Assignment-1 (Related to Lecture notes 1-10)

Subject: Optimal Control Assignment-1 (Related to Lecture notes 1-10) Subject: Optimal Control Assignment- (Related to Lecture notes -). Design a oil mug, shown in fig., to hold as much oil possible. The height and radius of the mug should not be more than 6cm. The mug must

More information

Denis ARZELIER arzelier

Denis ARZELIER   arzelier COURSE ON LMI OPTIMIZATION WITH APPLICATIONS IN CONTROL PART II.2 LMIs IN SYSTEMS CONTROL STATE-SPACE METHODS PERFORMANCE ANALYSIS and SYNTHESIS Denis ARZELIER www.laas.fr/ arzelier arzelier@laas.fr 15

More information

Nonlinear Observer Design for Dynamic Positioning

Nonlinear Observer Design for Dynamic Positioning Author s Name, Company Title of the Paper DYNAMIC POSITIONING CONFERENCE November 15-16, 2005 Control Systems I J.G. Snijders, J.W. van der Woude Delft University of Technology (The Netherlands) J. Westhuis

More information

Lecture 1: Pragmatic Introduction to Stochastic Differential Equations

Lecture 1: Pragmatic Introduction to Stochastic Differential Equations Lecture 1: Pragmatic Introduction to Stochastic Differential Equations Simo Särkkä Aalto University, Finland (visiting at Oxford University, UK) November 13, 2013 Simo Särkkä (Aalto) Lecture 1: Pragmatic

More information

LQR and H 2 control problems

LQR and H 2 control problems LQR and H 2 control problems Domenico Prattichizzo DII, University of Siena, Italy MTNS - July 5-9, 2010 D. Prattichizzo (Siena, Italy) MTNS - July 5-9, 2010 1 / 23 Geometric Control Theory for Linear

More information

Reduced Basis Method for Parametric

Reduced Basis Method for Parametric 1/24 Reduced Basis Method for Parametric H 2 -Optimal Control Problems NUMOC2017 Andreas Schmidt, Bernard Haasdonk Institute for Applied Analysis and Numerical Simulation, University of Stuttgart andreas.schmidt@mathematik.uni-stuttgart.de

More information

Introduction to Nonlinear Control Lecture # 4 Passivity

Introduction to Nonlinear Control Lecture # 4 Passivity p. 1/6 Introduction to Nonlinear Control Lecture # 4 Passivity È p. 2/6 Memoryless Functions ¹ y È Ý Ù È È È È u (b) µ power inflow = uy Resistor is passive if uy 0 p. 3/6 y y y u u u (a) (b) (c) Passive

More information

sc Control Systems Design Q.1, Sem.1, Ac. Yr. 2010/11

sc Control Systems Design Q.1, Sem.1, Ac. Yr. 2010/11 sc46 - Control Systems Design Q Sem Ac Yr / Mock Exam originally given November 5 9 Notes: Please be reminded that only an A4 paper with formulas may be used during the exam no other material is to be

More information

CHAPTER 3: STATE ESTIMATION

CHAPTER 3: STATE ESTIMATION CHAPTER 3: STATE ESTIMATION Overview State estimation is the process of determining the internal state of an energy system, from measurements of the input/output data. The algorithm is typically computer

More information

Numerics and Control of PDEs Lecture 1. IFCAM IISc Bangalore

Numerics and Control of PDEs Lecture 1. IFCAM IISc Bangalore 1/1 Numerics and Control of PDEs Lecture 1 IFCAM IISc Bangalore July 22 August 2, 2013 Introduction to feedback stabilization Stabilizability of F.D.S. Mythily R., Praveen C., Jean-Pierre R. 2/1 Q1. Controllability.

More information

University of Toronto Department of Electrical and Computer Engineering ECE410F Control Systems Problem Set #3 Solutions = Q o = CA.

University of Toronto Department of Electrical and Computer Engineering ECE410F Control Systems Problem Set #3 Solutions = Q o = CA. University of Toronto Department of Electrical and Computer Engineering ECE41F Control Systems Problem Set #3 Solutions 1. The observability matrix is Q o C CA 5 6 3 34. Since det(q o ), the matrix is

More information

Reduced basis method for H 2 optimal feedback control problems

Reduced basis method for H 2 optimal feedback control problems A. Schmidt a B. Haasdonk b Reduced basis method for H 2 optimal feedback control problems Stuttgart, November 215 a Institute for Applied Analysis and Numerical Simulation, University of Stuttgart, Pfaffenwaldring

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, April 1, 010 QUESTION BOOKLET Your

More information

Chapter 4: The State Space and Numerical Simulation

Chapter 4: The State Space and Numerical Simulation Chapter 4: The State Space and Numerical Simulation Samantha Ramirez Preview Questions What mathematical formulation might we apply to the models we derived in the previous chapter in order to facilitate

More information

FRTN 15 Predictive Control

FRTN 15 Predictive Control Department of AUTOMATIC CONTROL FRTN 5 Predictive Control Final Exam March 4, 27, 8am - 3pm General Instructions This is an open book exam. You may use any book you want, including the slides from the

More information

Topic # Feedback Control Systems

Topic # Feedback Control Systems Topic #15 16.31 Feedback Control Systems State-Space Systems Open-loop Estimators Closed-loop Estimators Observer Theory (no noise) Luenberger IEEE TAC Vol 16, No. 6, pp. 596 602, December 1971. Estimation

More information

LMIs for Observability and Observer Design

LMIs for Observability and Observer Design LMIs for Observability and Observer Design Matthew M. Peet Arizona State University Lecture 06: LMIs for Observability and Observer Design Observability Consider a system with no input: ẋ(t) = Ax(t), x(0)

More information

ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process

ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process Department of Electrical Engineering University of Arkansas ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process Dr. Jingxian Wu wuj@uark.edu OUTLINE 2 Definition of stochastic process (random

More information

Dynamical Systems & Lyapunov Stability

Dynamical Systems & Lyapunov Stability Dynamical Systems & Lyapunov Stability Harry G. Kwatny Department of Mechanical Engineering & Mechanics Drexel University Outline Ordinary Differential Equations Existence & uniqueness Continuous dependence

More information

EE363 homework 8 solutions

EE363 homework 8 solutions EE363 Prof. S. Boyd EE363 homework 8 solutions 1. Lyapunov condition for passivity. The system described by ẋ = f(x, u), y = g(x), x() =, with u(t), y(t) R m, is said to be passive if t u(τ) T y(τ) dτ

More information

Problem Set 3: Solution Due on Mon. 7 th Oct. in class. Fall 2013

Problem Set 3: Solution Due on Mon. 7 th Oct. in class. Fall 2013 EE 56: Digital Control Systems Problem Set 3: Solution Due on Mon 7 th Oct in class Fall 23 Problem For the causal LTI system described by the difference equation y k + 2 y k = x k, () (a) By first finding

More information

the EL equation for the x coordinate is easily seen to be (exercise)

the EL equation for the x coordinate is easily seen to be (exercise) Physics 6010, Fall 2016 Relevant Sections in Text: 1.3 1.6 Examples After all this formalism it is a good idea to spend some time developing a number of illustrative examples. These examples represent

More information

10/21/2003 PHY Lecture 14 1

10/21/2003 PHY Lecture 14 1 Announcements. Second exam scheduled for Oct. 8 th -- practice exams now available -- http://www.wfu.edu/~natalie/f03phy3/extrapractice/. Thursday review of Chapters 9-4 3. Today s lecture Universal law

More information

Chapter 9 Observers, Model-based Controllers 9. Introduction In here we deal with the general case where only a subset of the states, or linear combin

Chapter 9 Observers, Model-based Controllers 9. Introduction In here we deal with the general case where only a subset of the states, or linear combin Lectures on Dynamic Systems and Control Mohammed Dahleh Munther A. Dahleh George Verghese Department of Electrical Engineering and Computer Science Massachuasetts Institute of Technology c Chapter 9 Observers,

More information

Module 07 Controllability and Controller Design of Dynamical LTI Systems

Module 07 Controllability and Controller Design of Dynamical LTI Systems Module 07 Controllability and Controller Design of Dynamical LTI Systems Ahmad F. Taha EE 5143: Linear Systems and Control Email: ahmad.taha@utsa.edu Webpage: http://engineering.utsa.edu/ataha October

More information

Modeling nonlinear systems using multiple piecewise linear equations

Modeling nonlinear systems using multiple piecewise linear equations Nonlinear Analysis: Modelling and Control, 2010, Vol. 15, No. 4, 451 458 Modeling nonlinear systems using multiple piecewise linear equations G.K. Lowe, M.A. Zohdy Department of Electrical and Computer

More information

Stabilisation of Linear Time-Invariant Systems subject to Output Saturation

Stabilisation of Linear Time-Invariant Systems subject to Output Saturation Stabilisation of Linear Time-Invariant Systems subject to Output Saturation by Gijs Hilhorst, BSc A Thesis in Partial Fulfillment of the Requirement for the Degree of Master of Science at the Department

More information

Multivariable Control. Lecture 03. Description of Linear Time Invariant Systems. John T. Wen. September 7, 2006

Multivariable Control. Lecture 03. Description of Linear Time Invariant Systems. John T. Wen. September 7, 2006 Multivariable Control Lecture 3 Description of Linear Time Invariant Systems John T. Wen September 7, 26 Outline Mathematical description of LTI Systems Ref: 3.1-3.4 of text September 7, 26Copyrighted

More information

Kalman Filter Computer Vision (Kris Kitani) Carnegie Mellon University

Kalman Filter Computer Vision (Kris Kitani) Carnegie Mellon University Kalman Filter 16-385 Computer Vision (Kris Kitani) Carnegie Mellon University Examples up to now have been discrete (binary) random variables Kalman filtering can be seen as a special case of a temporal

More information