linear systems analysis - virginia techcdhall/courses/aoe5204/linears… ·  · 2006-09-27aoe 5204...

138
AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear equations, complete analytical solution Asymmetric, torque-free rigid body Nonlinear equations, analytical solution for angular velocities; linearized about principal axis spin

Upload: hakhanh

Post on 26-May-2018

216 views

Category:

Documents


1 download

TRANSCRIPT

Page 1: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems AnalysisLast time:

Axisymmetric, torque-free rigid bodyLinear equations, complete analytical solution

Asymmetric, torque-free rigid bodyNonlinear equations, analytical solution for angular velocities; linearized about principal axis spin

Page 2: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Rigid Body Dynamics Equations of MotionThe complete set of coupled

translational and rotational equa-

tions of motion for a rigid body:

ω = I−1h

v =1

mp

f = f(r,v,R,ω)

g = g(r,v,R,ω)

r =1

mp− ω×r

p = −ω×p+ f˙q = Q(q)ω

h = −ω×h+ g

The differential equations are

coupled through ω, as well as

through the dependence of force

and moment on position, velocity,

attitude, and angular velocity

The force and moment can also

include controls; for example,

the torque on a submersible ve-

hicle can include environmental

torques due to viscosity, buoy-

ancy, and gravity, as well as con-

trol torques due to actuators such

as momentum wheels and fins

The equations are also nonlinear

Page 3: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Control of Desired MotionsMany dynamics and control prob-

lems involve relatively simple,

steady motions

Examples

• straight and level flight of anairplane

• Earth-pointing attitude of a

satellite in a circular orbit

• straight and level motion of asubmersible vehicle

• straight motion of a surface ma-rine vessel

The nonlinear equations of mo-

tion are applicable

Disturbances affect the motion

(i.e., wind gusts, solar radiation

pressure, ocean currents, waves)

Controls are used to counter the

effects of the disturbances

Linearization about the desired

motion simplifies system analyis

and control synthesis

Page 4: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems Analysis and Control

•Linearization of the equations of motion•Stability analysis•Modal analysis•PID and LQR control synthesis•Controllability and observability•Stabilizability and detectability

Page 5: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

General Nonlinear System

The function f is sometimes

called the vector field

Often f will not depend on t, and

in that case the system is called

autonomous, or time-invariant

Furthermore, y usually does not

depend on u; if y does depend on

u, then the system is said to have

a feedforward connection between

the input and the output

Generally, the equations describ-

ing dynamics and control prob-

lems can be developed in the

form:

x = f(x,u, t)

y = g(x,u, t)

where x ∈ Rn, y ∈ Rm, and u ∈Rp

The vector x is the state vector,

the vector u is the input vector,

and the vector y is the output

vector

Page 6: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization

θ

Equations of motion for a pendu-

lum:

θ +g

lsin θ = 0

There is no input, but clearly

θ∗ = 0 and θ∗ = π are two equlib-

rium solutions

Using physical reasoning, we also

see that θ∗ = 0 is stable, whereas

θ∗ = π is unstable

Exercise

Suppose that there is some con-

stant input, u∗, and a constant

state vector, x∗, such that

x = f(x∗,u∗, t) = 0

This combination of input and

state is called an equilibrium,

since x = 0 implies that the state

remains constant

Dynamics and control analysts

are often interested in the stabil-

ity of equilibrium motions, and in

controlling motions near equilib-

rium motions

Page 7: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (2)Define small perturbations away from the equilibrium state and

control:

x = x∗ + δx

u = u∗ + δu

Recall that for a scalar function f(x), the Taylor series is

f(x) = f(x∗ + δx)

= f(x∗) + f 0(x∗)δx+1

2!f 00(x∗)δx2 + · · ·

For the vector functions of vector arguments here, the Taylor series

is expressed similarly:

f(x) = f(x∗ + δx) = f(x∗) +∂f

∂x(x∗)δx+ · · ·

where the · · · represent the higher order terms in the Taylor series.

Page 8: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (3)The vector field depends on x and u

x = f(x,u, t) = f(x∗ + δx,u∗ + δu, t)

Apply the Taylor series expansion to f(x,u, t) as

f(x,u, t) = f(x∗,u∗, t) +∂f

∂x(x∗,u∗, t)δx+

∂f

∂u(x∗,u∗, t)δu+ · · ·

By definition, the term f(x∗,u∗, t) = 0, so that the differential

equation is approximated as

˙δx =∂f

∂x(x∗,u∗, t)δx+

∂f

∂u(x∗,u∗, t)δu

The terms ∂f∂x (x

∗,u∗, t) and ∂f∂u(x

∗,u∗, t) are n× n and n× p ma-trices, respectively

Page 9: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (4)

The first matrix in the linearized equation

˙δx =∂f

∂x(x∗,u∗, t)δx+

∂f

∂u(x∗,u∗, t)δu

is

∂f

∂x(x∗,u∗, t) =

⎡⎢⎣∂f1∂x1

· · · ∂f1∂xn

... · · ·...

∂fn∂x1

· · · ∂fn∂xn

⎤⎥⎦¯¯(x∗,u∗)

≡ A(t)

where the notation |(x∗,u∗) denotes that the terms in the matrixare evaluated at (x,u) = (x∗,u∗)

This matrix, A(t) is the plant matrix, or simply The Plant

If A(t) does not depend on t, then the system is a time-invariant,

or constant-coefficient system

Page 10: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (5)

The second matrix in the linearized equation

˙δx =∂f

∂x(x∗,u∗, t)δx+

∂f

∂u(x∗,u∗, t)δu

is

∂f

∂u(x∗,u∗, t) =

⎡⎢⎢⎣∂f1∂u1

· · · ∂f1∂up

... · · ·...

∂fn∂u1

· · · ∂fn∂up

⎤⎥⎥⎦¯¯(x∗,u∗)

≡ B(t)

This matrix, B(t) is the input matrix

Using these matrix definitions, the linear equation can be written

˙δx = A(t)δx+B(t)δu

Page 11: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (6)

The linearized equation

˙δx =∂f

∂x(x∗,u∗, t)δx+

∂f

∂u(x∗,u∗, t)δu

is abbreviated as˙δx = A(t)δx+B(t)δu

Frequently, the “δ” and the time-dependence are understood, and

the equation is written

x = Ax+Bu

This is a standard form for the linear state-space differential equa-

tion

One also sees

x = Fx+Gu

Page 12: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization (7)The “output” equation is handled similarly

y = g(x,u, t)

y∗ + δy = g(x∗ + δx,u∗ + δu, t)

δy =∂g

∂x(x∗,u∗, t)δx+

∂g

∂u(x∗,u∗, t)δu

δy = C δx+D δu

y = Cx+Du

Thus, the general nonlinear system

x = f(x,u, t)

y = g(x,u, t)

is approximated by

x = Ax+Bu

y = Cx+Du

Page 13: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization ExampleConsider the motion of a spinning rigid body with a constant

“environmental” torque. The desired motion of spinning body is

ω∗ = [Ω1 Ω2 Ω3]. We want to linearize the equations of motion

about the desired motion.

Expressed in a principal frame, the environmental torque is ge.

The “control” torque, g∗, required to maintain the desired motion

is easily computed using Euler’s equations:

ω = −I−1ω×Iω + I−1ge + I−1g = f(x,u)0 = −I−1ω∗×Iω∗ + I−1ge + I−1g∗ = f(x∗,u∗)g∗ = ω∗×Iω∗ − ge

Given the desired motion, ω∗ and the environmental torque ge, we

can easily compute g∗, which is clearly constant

In this problem, x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Page 14: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example (2)Rosetta stone: x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Equations in scalar form:

ω1 =I2 − I3I1

ω2ω3 +ge1I1+g1I1= f1(x,u)

ω2 =I3 − I1I2

ω1ω3 +ge2I2+g2I2= f2(x,u)

ω3 =I1 − I2I3

ω1ω2 +ge3I3+g3I3= f3(x,u)

The matrix, ∂f∂x (x∗,u∗, t), is

∂f

∂x(x∗,u∗, t) =

⎡⎢⎣ 0 I2−I3I1

Ω3I2−I3I1

Ω2I3−I1I2

Ω3 0 I3−I1I2

Ω1I1−I2I3

Ω2I1−I2I3

Ω1 0

⎤⎥⎦ ≡ AClearly A depends only on the inertias and the desired steady

motion ω∗.

Page 15: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example (3)Rosetta stone: x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Equations of motion:

ω1 =I2 − I3I1

ω2ω3 +ge1I1+g1I1= f1(x,u)

ω2 =I3 − I1I2

ω1ω3 +ge2I2+g2I2= f2(x,u)

ω3 =I1 − I2I3

ω1ω2 +ge3I3+g3I3= f3(x,u)

The matrix ∂f∂u (x

∗,u∗, t) is

∂f

∂u(x∗,u∗, t) =

⎡⎣ 1I1

0 0

0 1I2

0

0 0 1I3

⎤⎦ ≡ BAs with A, the matrix B is constant and depends only on the

inertias. Note that B = I−1

Page 16: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example (4)Thus, the linearized equations of motion are

˙δω = A δω +B δg or x = Ax+Bu

where

A =

⎡⎢⎣ 0 I2−I3I1

Ω3I2−I3I1

Ω2I3−I1I2

Ω3 0 I3−I1I2

Ω1I1−I2I3

Ω2I1−I2I3

Ω1 0

⎤⎥⎦ and B =

⎡⎣ 1I1

0 0

0 1I2

0

0 0 1I3

⎤⎦Note that δω = ω−ω∗, and δg = g−g∗. A typical control problemis to determine the control δg that will maintain the desired motion

in the presence of initial condition errors and other disturbances.

A recommended exercise is to choose values of I, ge, and ω∗, and

then compare the results of integrating the nonlinear differential

equations with the results of integrating the linear equations.

Page 17: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability AnalysisThe linearization process serves

to shift the origin to the equilib-

rium of interest

Before applying a control, we

should determine whether the

origin is stable in the absence of

any control (i.e., u = 0)

x = Ax

We further assume that A is con-

stant, so that we have a time-

invariant system

Stability analysis is based on the

eigenvalues of A

Consider the special case where

A is diagonal

The differential equation decou-

ples into the n first-order differ-

ential equations

x1 = A11x1

xj = Ajjxj

xn = Annxn

and each solution is immediately

integrable as

xj(t) = eAjjtxj(0)

Exercise: Solve for xj(t)

Page 18: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability Analysis (2)If A is diagonal

xj(t) = eAjjtxj(0)

If Ajj < 0, then limt→∞ xj(t) = 0

If Ajj > 0, then limt→∞ xj(t) =

Thus, Ajj < 0⇒ stability,

And Ajj > 0⇒ instability

If all states are stable, then the

system is stable.

If any of the states are unstable,

then the system is unstable.

The diagonal elements of a diago-

nal matrix are the eigenvalues of

the matrix, typically denoted

λj(A), j = 1, ..., n

For a diagonal matrix,

λj < 0∀ j ⇒ stability

λj > 0 for any j ⇒ instability

Page 19: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability Analysis (3)More generally,A is not diagonal,

and its eigenvalues are either real,

or complex conjugate pairs

Denote the real and imaginary

parts of the eigenvalues by

Re λj and Im λj

The stability condition can then

be written as

Re λj < 0∀ j ⇒ stability

Re λj > 0 for any j ⇒ instabil-

ity

If any eigenvalue has Re λj = 0,

then the linear stability analysis

is inconclusive

We will develop the eigenvalue

decomposition next time

Page 20: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization ReviewThe general nonlinear system of equations is

x = f(x,u, t)

y = g(x,u, t)

where the state is x ∈ Rn, the input is u ∈ Rp, and the output isy ∈ Rm

Equilibrium motions, (x∗,u∗) satisfy

x = f(x∗,u∗, t) = 0

Linearization about (x∗,u∗), and simplifying notation with δx→ x

gives the linear system

x = Ax+Bu

y = Cx+Du

Page 21: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

State Feedback Control PreviewGeneral form for linear system is

x = Ax+Bu

y = Cx+Du

A standard control application is to let the input depend on the

state:

u = −Kx

With this form for the input, the state dynamics equation becomes

x = Ax−BKx= [A−BK]x= Ax

As we continue with linear stability analysis, keep in mind that the

analysis of x = Ax is equally applicable to x = Ax

Page 22: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability AnalysisThe linearization process serves

to shift the origin to the equilib-

rium of interest

Before applying a control, we

should determine whether the

origin is stable in the absence of

any control (i.e., u = 0)

x = Ax

We further assume that A is con-

stant, so that we have a time-

invariant system

Stability analysis is based on the

eigenvalues of A

Consider the special case where

A is diagonal

The differential equation decou-

ples into the n first-order differ-

ential equations

x1 = A11x1

xj = Ajjxj

xn = Annxn

and each solution is immediately

integrable as

xj(t) = eAjjtxj(0)

Exercise: Solve for xj(t)

Page 23: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability Analysis (2)If A is diagonal

xj(t) = eAjjtxj(0)

If Ajj < 0, then limt→∞ xj(t) = 0

If Ajj > 0, then limt→∞ xj(t) =

Thus, Ajj < 0⇒ stability,

And Ajj > 0⇒ instability

If all states are stable, then the

system is stable.

If any of the states are unstable,

then the system is unstable.

The diagonal elements of a diago-

nal matrix are the eigenvalues of

the matrix, typically denoted

λj(A), j = 1, ..., n

For a diagonal matrix,

λj < 0∀ j ⇒ stability

λj > 0 for any j ⇒ instability

Page 24: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stability Analysis (3)More generally,A is not diagonal,

and its eigenvalues are either real,

or complex conjugate pairs

Denote the real and imaginary

parts of the eigenvalues by

Re λj and Im λj

The stability condition can then

be written as

Re λj < 0∀ j ⇒ stability

Re λj > 0 for any j ⇒ instabil-

ity

If any eigenvalue has Re λj = 0,

then the linear stability analysis

is inconclusive

We will develop the eigenvalue

decomposition next time

Page 25: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of AWork with the zero-input state dynamics equation

x = Ax

Assume solutions of the form

x(t) = eλte, with constants λ ∈ C, e ∈ Cn

Substitute into the differential equation, and obtain

λeλte = Aeλte

The scalar, eλt can never be zero, so

λe = Ae

[λ1−A] e = 0

det [λ1−A] = 0

p(λ) = 0 characteristic polynomial

Page 26: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (2) Working with the zero-input state dynamics equation

x = Ax, x(t) = eλte

Leads to

det [λ1−A] = 0

p(λ) = 0 characteristic polynomial

Example:

A =

∙1 2−1 6

¸⇒ [λ1−A] =

∙λ− 1 −21 λ− 6

¸det [λ1−A] = 0 ⇒ p(λ) = (λ− 1)(λ− 6) + 2 = 0λ2 − 7λ+ 8 = 0 ⇒ λ = 5.5616, 1.4384

Matlab: eig([1 2; -1 6]) and roots([1 -7 8]) both give

this result.

Page 27: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (3) Generally, there are n eigenvalues (roots of the characteristic poly-

nomial), and they are distinct

There can be repeated eigenvalues

Eigenvalues can be real or complex; if complex, they always come

in complex conjugate pairs

If the eigenvalues are distinct, then there are n linearly independent

eigenvectors, ej , one associated with each eigenvalue, λj

Linear independence means that no eigenvector can be written as

a linear combination of the remaining eigenvectors

With n linearly independent eigenvectors, any vector x ∈ Rn canbe written as a linear combination of the eigenvectors:

x =nXj=1

cjej

Page 28: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (4) Each eigenvalue-eigenvector pair satisfies

Aej = λjej

We can rewrite as (Exercise)

A[e1 · · · en] = [e1 · · · en] diag[λ1 · · ·λn]⇒ AE = EΛ

Since the eigenvectors are linearly independent, the matrix E is

non-singular, so

A = EΛE−1

Thus, we have factored the matrix A into the product of three

matrices, one of which is diagonal (for distinct eigenvalues)

This factorization is called the eigenvalue decomposition; there are

other matrix decompositions

Page 29: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (5) We are still assuming distinct eigenvalues, in which case

A = EΛE−1

where E is the eigenvector matrix and Λ is the diagonal eigenvalue

matrix

Recall the assumed form of the solution to x = Ax:

xj(t) = eλjtej

Since the eigenvectors are linearly independent, any solution can

be written as a linear combination of these n solutions:

x(t) =nXj=1

cjeλjtej

where the constants cj depend on the initial conditions

Page 30: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (5)

The general solution to x = Ax is

x(t) =nXj=1

cjeλjtej

where the constants cj depend on the initial conditions

We can rewrite the summation as (Exercise):

x(t) = E diag£eλ1t · · · eλjt · · · eλnt

¤c = EeΛtc = EeΛtE−1x(0)

Note the similarity in the eigenvalue decomposition of A and its

application to the solution:

A = EΛE−1

x(t) = EeΛtE−1x(0)

Page 31: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of A (6)

For constant A with distinct eigenvalues, we have

A = EΛE−1

x(t) = EeΛtE−1x(0)

Where Λ is the diagonal eigenvalue matrix, E is the eigenvector

matrix, and x(0) is the initial state

Premultiply the solution by E−1 to obtain

E−1x(t) = eΛtE−1x(0)

Notice that E−1x appears on both sides. Define z(t) = E−1x(t),

and obtain

z(t) = eΛtz(0) z = Λz

Thus, for the constant-coefficient case, ifA has distinct eigenvalues,

we can transform the system to a decoupled system

Page 32: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition Example

A =

⎡⎣ −2 −1 1−0.5 −2.5 0.50.5 −0.5 −1.5

⎤⎦ Matlab: [E,Lambda]=eig(A)

Λ =

⎡⎣ −3 0 00 −1 00 0 −2

⎤⎦E =

⎡⎣ 0.7071 −0.7071 00.7071 0 0.7071

0 −0.7071 0.7071

⎤⎦Matlab check: E*Lambda*inv(E) should = A

Initial conditions

x(0) = [2 − 3 1]T

z(0) = E−1[2 − 3 1]T Matlab: z0 = E\x0z(0) = [−1.4142 − 4.2426 − 2.8284]T

Page 33: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition Example (2)

Started with

A =

⎡⎣ −2 −1 1−0.5 −2.5 0.50.5 −0.5 −1.5

⎤⎦Found the eigensystem. Transformed initial conditions from x(0)

to z(0). Now we can write the solution as

z(t) = z1(0)e−3t

⎡⎣ 100

⎤⎦+ z2(0)e−1t⎡⎣ 010

⎤⎦+ z3(0)e−2t⎡⎣ 001

⎤⎦or

x(t) = c1e−3t

⎡⎣ 0.70710.70710

⎤⎦+c2e−1t⎡⎣ −0.70710−0.7071

⎤⎦+c3e−2t⎡⎣ 00.70710.7071

⎤⎦

Page 34: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Complex λ Eigenvalue Example

A =

⎡⎣ −1 0 00 3 −20 5 −3

⎤⎦ Λ =

⎡⎣ i 0 00 −i 00 0 −1

⎤⎦E =

⎡⎣ 0 0 10.5071 + 0.1690i 0.5071− 0.1690i 0

0.8452 0.8452 0

⎤⎦Λ is diagonal, but it is also complex. We can create a block-diagonal

matrix and block-diagonal eigenvalue matrix as follows

Eb = [Re e1 Im e1 e3]

=

⎡⎣ 0 0 10.5071 0.1690 00.8452 0 0

⎤⎦Λb = E−1b AEb

=

⎡⎣ 0 1 0−1 0 00 0 −1

⎤⎦

Page 35: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Complex λ Eigenvalue Example (2)System is block-diagonalized. Not quite as good as diagonal, but

better than nothing.

Eb =

⎡⎣ 0 0 10.5071 0.1690 00.8452 0 0

⎤⎦Λb =

⎡⎣ 0 1 0−1 0 00 0 −1

⎤⎦x(t) = Ebe

ΛbtE−1b x(0)

What is eΛbt? It turns out to be

eΛbt =

⎡⎣ cos t sin t 0− sin t cos t 0

0 0 e−t

⎤⎦

Page 36: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Complex λ Eigenvalue Example (3)

x(t) = EbeΛbtE−1b x(0)

where

eΛbt =

⎡⎣ cos t sin t 0− sin t cos t 0

0 0 e−t

⎤⎦

z(t) = E−1b x(t)

z(t) = eΛbtz(0)

z(t) = z1(0)

⎡⎣ cos t− sin t

0

⎤⎦+ z2(0)⎡⎣ sin tcos t0

⎤⎦+ z3(0)⎡⎣ 0

0e−t

⎤⎦+The block-diagonalization procedure works for complex eigenvalues

of the form σ + ωi, and makes use of Euler’s identity:

eσ+ωi = eσeωieσ (cosω + i sinω)

Page 37: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems AnalysisLast time:

Review of linearization about equilibrium motions

Diagonal systems

Eigenvalue decomposition

Diagonalization and block-diagonalization

Page 38: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Decomposition of AIf A ∈ Rn×n has distinct eigenvalues, then we can factor A into

the product of three matrices:

A = EΛE−1

where Λ is the diagonal matrix of eigenvalues, and E is the matrix

of linearly independent eigenvectors.

In general, Λ ∈ Cn×n, and E ∈ Cn×n

With the eigenvalue decomposition, we can write

eAt = EeΛtE−1

The advantage of this formulation of the matrix exponential is that

eΛt = diag£eλ1t eλjt eλnt

¤T

Page 39: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Zero-Input SolutionThe solution to the differential equation

x = Ax

is

x(t) = eAtx(0) = EeΛtE−1x(0)

Decoupled system dynamics is obtained by transforming from x to

z

E−1x(t) = eΛtE−1x(0)

z(t) = eΛtz(0)

If Λ and E are complex, then a real-valued partial decoupling is

possible by defining Eb and Λb; e.g.

Eb = [Ree1 Ime1 e3] , Λb = E−1b AEb

Page 40: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Block Diagonalization ProcedureIf A has complex eigenvalues and eigenvectors, they always come

in complex conjugate pairs: λj,j+1 = σ ± iω, ej,j+1 = Reej ±iImej For each c.c. pair of eigenvalues and eigenvectors, replaceeigenvectors (j and j + 1 columns of E) with Reej and Imej;e.g.

Eb = [Ree1 Ime1 e3]

Then form the block-diagonal eigenvalue matrix using

Λb = E−1b AEb

The 2× 2 blocks of Λb associated with the complex conjugate pairwill always be in the form ∙

σ ω−ω σ

¸Diagonal blocks associated with real eigenvalues are unaffected

Page 41: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Eigenvalue Recognition: Pop QuizWhat are the eigenvalues of the following matrices?

(a)

∙1 00 −3

¸(b)

∙1 02 −3

¸(c)

∙1 40 −3

¸

(d)

⎡⎣ 1 0 00 −3 00 0 7

⎤⎦ (e)

⎡⎣ 1 0 011 −3 03 1 7

⎤⎦ (f)

⎡⎣ 1 11 30 −3 10 0 7

⎤⎦What are the roots of the following characteristic polynomials?

(g) λ2 + 3λ+ 2

(h) λ(λ2 + 3λ+ 2)

(i) (λ+ 2)(λ+ 1)

(j) λ(λ+ 2)(λ+ 1)

(k) (λ+ 7)(λ+ 2)(λ+ 1)

(l) (λ+ 7)(λ+ 2)(λ+ 1)(λ− 3)(λ− 9)

Page 42: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential and Matrix FunctionsThe matrix exponential eAt is defined so that its Taylor series is in

the same form as that for the scalar exponential

eat = 1 + at+1

2!a2t2 +

1

3!a3t3 + · · · 1

n!antn + · · ·

eAt = 1+At+1

2!A2t2 +

1

3!A3t3 + · · · 1

n!Antn + · · ·

The Cayley-Hamilton Theorem: A matrix A satisfies its own char-

acteristic polynomial:

p(λ) = λn + an−1λn−1 + · · ·+ a1λ+ a0 = 0

p(A) = An + an−1An−1 + · · ·+ a1A+ a01 = 0

Example application: Multiply p(A) by A−1 and solve for A−1:

A−1 = − 1a0

£An−1 + an−1A

n−2 + · · ·+ a11¤

Page 43: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential ExamplesTaylor series for scalar and matrix exponentials:

eat = 1 + at+1

2!a2t2 +

1

3!a3t3 + · · · 1

n!antn + · · ·

eAt = 1+At+1

2!A2t2 +

1

3!A3t3 + · · · 1

n!Antn + · · ·

Compute the exponential of a 2× 2 diagonal matrix.

A =

∙a1 00 a2

¸eAt = 1+At+

1

2!A2t2 +

1

3!A3t3 + · · · 1

n!Antn + · · ·

=

∙1 00 1

¸+

∙a1 00 a2

¸t+

1

2!

∙a1 00 a2

¸2t2 +

1

3!

∙a1 00 a2

¸3t3 + · · ·

=

∙1 + a1t+

12!a

21t2 + 1

3!a31t3 + · · · 0

0 1 + a2t+12!a

22t2 + 1

3!a32t3 + · · ·

¸=

∙ea1t 00 ea2t

¸

Page 44: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential Examples (2)Compute the exponential of a 2×2 block-diagonal matrix,A =

∙0 ω−ω 0

¸

eAt = 1+At+1

2!A2t2 +

1

3!A3t3 + · · · 1

n!Antn + · · ·

=

∙1 00 1

¸+

∙0 ω−ω 0

¸t+

1

2!

∙0 ω−ω 0

¸2t2 +

1

3!

∙0 ω−ω 0

¸3t3 + · · ·

=

∙1 00 1

¸+

∙0 ω−ω 0

¸t+

1

2!

∙−ω2 00 −ω2

¸t2 +

1

3!

∙0 −ω3ω3 0

¸t3 + · · ·

=

∙1− 1

2!ω2t2 + · · · ωt− 1

3!ω3t3 + · · ·

−ωt+ 13!ω

3t3 + · · · 1− 12!ω

2t2 + · · ·

¸=

∙cosωt sinωt− sinωt cosωt

¸

Page 45: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential Examples (3)Consider complex conjugate eigenvalues λ1,2 = σ ± iω

The 2× 2 block of Λb is

A =

∙σ ω−ω σ

¸Instead of Taylor series, apply eAt = EeΛtE−1

The eigenvector matrix and its inverse are

E =

∙1 1i −i

¸and E−1 =

∙1/2 −i/21/2 i/2

¸Note that these eigenvectors are not normalized, nor is

normalization of eigenvectors required

The exponential term is

eΛt =

∙e(σ+iω)t 00 e(σ−iω)t

¸

Page 46: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential Examples (4)Continuing with c.c. eigenvalues λ1,2 = σ ± iω

The diagonalized matrix exponential term is

eΛt =

∙e(σ+iω)t 00 e(σ−iω)t

¸Recall that e(σ+iω)t = eσt(cosωt+ i sinωt)

Carrying out the required matrix multiplication leads to

eAt = exp

∙σ ω−ω σ

¸t

=

∙1 1i −i

¸ ∙eσt(cosωt+ i sinωt) 0

0 eσt(cosωt− i sinωt)t

¸×∙

1/2 −i/21/2 i/2

¸=

∙cosωt sinωt− sinωt cosωt

¸eσt

Page 47: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Matrix Exponential Examples (5)An example with 5 eigenvalues: one real, λ1; two pure imaginary,

λ2,3 = ±iω1; and two complex conjugates, λ4,5 = σ ± iω2

Λb =

⎡⎢⎢⎢⎢⎣λ1 0 0 0 00 0 ω1 0 00 −ω1 0 0 00 0 0 σ ω20 0 0 −ω2 σ

⎤⎥⎥⎥⎥⎦

eΛbt =

⎡⎢⎢⎢⎢⎣eλ1t 0 0 0 00 cosω1t sinω1t 0 00 − sinω1t cosω1t 0 00 0 0 eσt cosω2t eσt sinω2t0 0 0 −eσt sinω2t eσt cosω2t

⎤⎥⎥⎥⎥⎦Any matrix A that has these five eigenvalues will have this block

diagonal structure

Page 48: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Cayley-HamiltonThe Cayley-Hamilton Theorem: A matrix A satisfies its own char-

acteristic polynomial:

p(A) = An + an−1An−1 + · · ·+ a1A+ a01 = 0

Example application: Multiply p(A) by A−1 and solve for A−1:

A−1 = − 1a0

£An−1 + an−1A

n−2 + · · ·+ a11¤

A 2× 2 example: A =

∙1 2−1 6

¸, p(λ) = λ2 − 7λ+ 8 = 0

A−1 = −18

½∙1 2−1 6

¸− 7∙1 00 1

¸¾=

∙0.7500 −0.25000.1250 0.1250

¸Exercise: check this calculation with Matlab, and try the procedure

on some matrices with larger n

Page 49: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Another Cayley-Hamilton ApplicationSince A satisfies its own characteristic polynomial,

p(A) = An + an−1An−1 + · · ·+ a1A+ a01 = 0

every higher order power of A can be written as a linear combina-

tion of 1,A,A2, · · ·An−1

A useful application of this fact is the expression of eAt:

eAt = 1+At+1

2!A2t2 + · · ·

= α0(t)1+ α1(t)A+ α2(t)A2 + · · ·+ αn−1(t)A

n−1

=n−1Xj=0

αj(t)Aj

where the αj(t) terms are independent functions of time

We can calculate the αj(t) functions, but the most useful applica-

tion of this expression is in the development of the conditions for

controllability and observability

Page 50: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal AnalysisWe have already seen the modal decomposition that arises when

we diagonalize or block-diagonalize a linear system

A more detailed example:

A =

⎡⎣ 4 −6 −12 −1 −14 −4 −4

⎤⎦has eigenvalues (−3.6252, 1.3126 ± i1.9478) (stable or unstable?),and eigenvectors

E =

⎡⎣ 0.2565 −0.8154 −0.81540.1673 −0.2967 + i0.2740 −0.2967− i0.27400.9520 −0.4109− i0.0556 −0.4109 + i0.0556

⎤⎦Block-diagonalize by defining

Eb = [e1 Ree2 Ime2] and Λb = E−1b AEb

Page 51: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (2)

A =

⎡⎣ 4 −6 −12 −1 −14 −4 −4

⎤⎦ Λ = diag

⎡⎣ −3.62521.3126 + i1.94781.3126− i1.9478

⎤⎦

E =

⎡⎣ 0.2565 −0.8154 −0.81540.1673 −0.2967 + i0.2740 −0.2967− i0.27400.9520 −0.4109− i0.0556 −0.4109 + i0.0556

⎤⎦

Eb =

⎡⎣ 0.2565 −0.8154 00.1673 −0.2967 0.27400.9520 −0.4109 −0.0556

⎤⎦Λb =

⎡⎣ −3.6252 0 00 1.3126 1.94780 −1.9478 1.3126

⎤⎦We can use x, z, or zb

Page 52: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (3)

x = Ax, z = Λz, zb = Λbzb

x is coupled; z is completely decoupled; zb is partially decoupled

With x, one cannot easily see how the three states relate to the

eigenvalues and eigenvectors

With z, the fact that two states are complex-valued makes it diffi-

cult to understand the dynamics

With zb, the coupling between z2 and z3 is natural and easily un-

derstood

Consider the initial condition x(0) = [1 0 0]T

Note that the period of the oscillatory motion is T = 2π/ω, where

ω is the imaginary part of the eigenvalue

Page 53: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (4)

0 0.5 1 1.5 2 2.5 3 3.5−40

−20

0

20

40

60

80

100

t

x

x1

x2

x3

Initial state is x(0) = [1 0 0]T . Even though x2(0) = x3(0), all

three states diverge due to the coupling and the instability

Page 54: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (5)

0 0.5 1 1.5 2 2.5 3 3.5−100

−80

−60

−40

−20

0

20

40

t

z

z1

z2

z3

Initial state is x(0) = [1 0 0]T ⇒ z(0) = [−0.6897 − 1.4433 −1.1421]T . The state associated with the stable eigenvalue is not

unstable

Page 55: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (6)

0 0.5 1 1.5 2 2.5 3 3.5−0.7

−0.6

−0.5

−0.4

−0.3

−0.2

−0.1

0

0.1

t

z

z1

z2

z3

Initial state is z(0) = [−0.6897 0 0]T , corresponding to the stable

mode. The other states remain zero

Page 56: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (7)

0 0.5 1 1.5 2 2.5 3 3.5−100

−80

−60

−40

−20

0

20

40

t

z

z1

z2

z3

Initial state is z(0) = [0 − 1.4433 − 1.1421]T , corresponding tothe unstable mode. The other state remains zero

Page 57: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (8)

Modal analysis is based on block-diagonalizing x = Ax to obtain

zb = Λbzb

Whereas x is coupled, zb is partially decoupled

The real eigenvalues have one-dimensional real modes with expo-

nential (aka first-order) behavior

The complex conjugate eigenvalues have two-dimensional real

modes with exponential+oscillatory (aka second-order) behavior

By decomposing the motion into different modes, we can determine

the behavior of a dynamic system and focus attention on specific

modes of interest

Typically unstable, marginally stable, or barely stable modes are of

the most interest

Page 58: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the SolutionThe solution to the differential equation x = Ax is x(t) =

eAtx(0) = EeΛtE−1x(0), but what about

x = Ax+Bu ?

Consider the n = p = 1 case

x = ax+ u ⇒ x− ax = u

where a is constant and u is time-varying

One way to solve this first-order ODE is to turn the left-hand side

into a total derivative

Multiply by an unknown function y(t) and determine the form of

y(t) so that the left-hand side is d(xy)/dt

xy − axy = d

dt(xy) = xy + xy

Page 59: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the Solution (2)

We are seeking y(t) so that

xy − axy = d

dt(xy) = xy + xy

Subtract xy from both sides to obtain

−axy = xy ⇒ −ay = y ⇒ y(t) = e−aty(0)

Choose y(0) = 1, so y(t) = e−at

Now, back to the original differential equation (with y(t) in it):

d

dt(xy) = uy ⇒ d(xy) = uy dtZ (·)(t)

(·)(0)d(xy) =

Z t

0

uy(τ) dτ

x(t)y(t)− x(0)y(0) =

Z t

0

uy(τ) dτ

Page 60: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the Solution (2)

x(t)y(t)− x(0)y(0) =

Z t

0

uy(τ) dτ

x(t)e−at − x(0) =

Z t

0

ue−aτ dτ

x(t)e−at = x(0) +

Z t

0

ue−aτ dτ

x(t) = eatx(0) + eatZ t

0

ue−aτ dτ

The form of the solution for general n and p is the same as above:

x(t) = eAtx(0) + eAtZ t

0

e−AτBu(τ) dτ

The first term is the zero-input solution, and the second term isthe zero-state solution:

x(t) = xzi(t) + xzs(t)

Page 61: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability and Observability

The general solution to x = Ax+Bu is

x(t) = eAtx(0) + eAtZ t

0

e−AτBu(τ) dτ

The first term is the zero-input solution, and the second term isthe zero-state solution:

x(t) = xzi(t) + xzs(t)

Controllability. Does a control exist such that xzs(tf ) = xf forany xf and finite tf? If yes, then the system is controllable.

The output equation is y = Cx+Du

Observability. Does an initial state x(0) exist such that the zero-input solution produces identically zero output? If so, then thesystem is unobservable.

Page 62: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems AnalysisLast time:

Diagonalization and block-diagonalization

Eigenvalue recognition

Cayley-Hamilton Theorem

Matrix Exponential

Page 63: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Another Cayley-Hamilton ApplicationSince A satisfies its own characteristic polynomial,

p(A) = An + an−1An−1 + · · ·+ a1A+ a01 = 0

every higher order power of A can be written as a linear combina-

tion of 1,A,A2, · · ·An−1

A useful application of this fact is the expression of eAt:

eAt = 1+At+1

2!A2t2 + · · ·

= α0(t)1+ α1(t)A+ α2(t)A2 + · · ·+ αn−1(t)A

n−1

=n−1Xj=0

αj(t)Aj

where the αj(t) terms are independent functions of time

We can calculate the αj(t) functions, but the most useful applica-

tion of this expression is in the development of the conditions for

controllability and observability

Page 64: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal AnalysisWe have already seen the modal decomposition that arises when

we diagonalize or block-diagonalize a linear system

A more detailed example:

A =

⎡⎣ 4 −6 −12 −1 −14 −4 −4

⎤⎦has eigenvalues (−3.6252, 1.3126 ± i1.9478) (stable or unstable?),and eigenvectors

E =

⎡⎣ 0.2565 −0.8154 −0.81540.1673 −0.2967 + i0.2740 −0.2967− i0.27400.9520 −0.4109− i0.0556 −0.4109 + i0.0556

⎤⎦Block-diagonalize by defining

Eb = [e1 Ree2 Ime2] and Λb = E−1b AEb

Page 65: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (2)

A =

⎡⎣ 4 −6 −12 −1 −14 −4 −4

⎤⎦ Λ = diag

⎡⎣ −3.62521.3126 + i1.94781.3126− i1.9478

⎤⎦

E =

⎡⎣ 0.2565 −0.8154 −0.81540.1673 −0.2967 + i0.2740 −0.2967− i0.27400.9520 −0.4109− i0.0556 −0.4109 + i0.0556

⎤⎦

Eb =

⎡⎣ 0.2565 −0.8154 00.1673 −0.2967 0.27400.9520 −0.4109 −0.0556

⎤⎦Λb =

⎡⎣ −3.6252 0 00 1.3126 1.94780 −1.9478 1.3126

⎤⎦We can use x, z, or zb

Page 66: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (3)

x = Ax, z = Λz, zb = Λbzb

x is coupled; z is completely decoupled; zb is partially decoupled

With x, one cannot easily see how the three states relate to the

eigenvalues and eigenvectors

With z, the fact that two states are complex-valued makes it diffi-

cult to understand the dynamics

With zb, the coupling between z2 and z3 is natural and easily un-

derstood

Consider the initial condition x(0) = [1 0 0]T

Note that the period of the oscillatory motion is T = 2π/ω, where

ω is the imaginary part of the eigenvalue

Page 67: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (4)

0 0.5 1 1.5 2 2.5 3 3.5−40

−20

0

20

40

60

80

100

t

x

x1

x2

x3

Initial state is x(0) = [1 0 0]T . Even though x2(0) = x3(0), all

three states diverge due to the coupling and the instability

Page 68: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (5)

0 0.5 1 1.5 2 2.5 3 3.5−100

−80

−60

−40

−20

0

20

40

t

z

z1

z2

z3

Initial state is x(0) = [1 0 0]T ⇒ z(0) = [−0.6897 − 1.4433 −1.1421]T . The state associated with the stable eigenvalue is not

unstable

Page 69: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (6)

0 0.5 1 1.5 2 2.5 3 3.5−0.7

−0.6

−0.5

−0.4

−0.3

−0.2

−0.1

0

0.1

t

z

z1

z2

z3

Initial state is z(0) = [−0.6897 0 0]T , corresponding to the stable

mode. The other states remain zero

Page 70: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (7)

0 0.5 1 1.5 2 2.5 3 3.5−100

−80

−60

−40

−20

0

20

40

t

z

z1

z2

z3

Initial state is z(0) = [0 − 1.4433 − 1.1421]T , corresponding tothe unstable mode. The other state remains zero

Page 71: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Modal Analysis (8)

Modal analysis is based on block-diagonalizing x = Ax to obtain

zb = Λbzb

Whereas x is coupled, zb is partially decoupled

The real eigenvalues have one-dimensional real modes with expo-

nential (aka first-order) behavior

The complex conjugate eigenvalues have two-dimensional real

modes with exponential+oscillatory (aka second-order) behavior

By decomposing the motion into different modes, we can determine

the behavior of a dynamic system and focus attention on specific

modes of interest

Typically unstable, marginally stable, or barely stable modes are of

the most interest

Page 72: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the SolutionThe solution to the differential equation x = Ax is x(t) =

eAtx(0) = EeΛtE−1x(0), but what about

x = Ax+Bu ?

Consider the n = p = 1 case

x = ax+ u ⇒ x− ax = u

where a is constant and u is time-varying

One way to solve this first-order ODE is to turn the left-hand side

into a total derivative

Multiply by an unknown function y(t) and determine the form of

y(t) so that the left-hand side is d(xy)/dt

xy − axy = d

dt(xy) = xy + xy

Page 73: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the Solution (2)

We are seeking y(t) so that

xy − axy = d

dt(xy) = xy + xy

Subtract xy from both sides to obtain

−axy = xy ⇒ −ay = y ⇒ y(t) = e−aty(0)

Choose y(0) = 1, so y(t) = e−at

Now, back to the original differential equation (with y(t) in it):

d

dt(xy) = uy ⇒ d(xy) = uy dtZ (·)(t)

(·)(0)d(xy) =

Z t

0

uy(τ) dτ

x(t)y(t)− x(0)y(0) =

Z t

0

uy(τ) dτ

Page 74: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Back to the Solution (2)

x(t)y(t)− x(0)y(0) =

Z t

0

uy(τ) dτ

x(t)e−at − x(0) =

Z t

0

ue−aτ dτ

x(t)e−at = x(0) +

Z t

0

ue−aτ dτ

x(t) = eatx(0) + eatZ t

0

ue−aτ dτ

The form of the solution for general n and p is the same as above:

x(t) = eAtx(0) + eAtZ t

0

e−AτBu(τ) dτ

The first term is the zero-input solution, and the second term isthe zero-state solution:

x(t) = xzi(t) + xzs(t)

Page 75: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability and Observability

The general solution to x = Ax+Bu is

x(t) = eAtx(0) + eAtZ t

0

e−AτBu(τ) dτ

The first term is the zero-input solution, and the second term isthe zero-state solution:

x(t) = xzi(t) + xzs(t)

Controllability. Does a control exist such that xzs(tf ) = xf forany xf and finite tf? If yes, then the system is controllable.

The output equation is y = Cx+Du

Observability. Does an initial state x(0) exist such that the zero-input solution produces identically zero output? If so, then thesystem is unobservable.

Page 76: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

ControllabilityThe zero-state solution to x = Ax+Bu is

xzs(t) = eAtZ t

0

e−AτBu(τ) dτ

Controllability. Does a control exist such that xzs(tf ) = xf forany xf and finite tf? If yes, then the system is controllable.

Keep in mind that x ∈ Rn, u ∈ Rp, A ∈ Rn×n, and B ∈ Rn×p

Also recall that the Cayley-Hamilton Theorem leads to

eAt =n−1Xj=0

αj(t)Aj

where the αj(t) terms are independent functions of time

Remember, the question is: Can we get from zero to anywhere infinite time?

Page 77: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (2)Consider the system with

A =

∙1 00 3

¸, B =

∙01

¸Since the system is diagonal, the dynamics are decoupled and thetwo states are governed by

x1 = x1 and x2 = 3x2 + u

The control has no effect on x1; thus x1 is uncontrollable. Thereis no control u that can drive x1 to any non-zero value in finite (oreven infinite) time.

Page 78: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (3)One way to add controllability to the problem in the previous ex-ample is to modify the B matrix

Consider the system with

A =

∙1 00 3

¸, B =

∙11

¸Since the system is diagonal, the dynamics are decoupled and thetwo states are governed by

x1 = x1 + u and x2 = 3x2 + u

The control affects both states, and, as we show later, the systemis controllable

Controllability depends on A and B

Page 79: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (4)The zero-state solution to x = Ax+Bu is

xzs(t) = eAtZ t

0

e−AτBu(τ) dτ

and we want to determine whether any xzs(t) is possible.

xzs(t) = eAtZ t

0

e−AτBu(τ) dτ

=

Z t

0

eA(t−τ)Bu(τ) dτ

Recall that Cayley-Hamilton leads to

eAt =n−1Xj=0

αj(t)Aj

Substitute this sum into the integral

Page 80: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (5)

xzs(t) =n−1Xj=0

Z t

0

αj(t− τ)AjBu(τ) dτ

=n−1Xj=0

AjB

Z t

0

αj(t− τ)u(τ) dτ

=n−1Xj=0

Aj

∙b1

Z t

0

αj(t− τ)u1(τ) dτ+

b2

Z t

0

αj(t− τ)u2(τ) dτ + · · ·+

bp

Z t

0

αj(t− τ)up(τ) dτ¸

The integrals are functions of t:

γjk(t) =

Z t

0

αj(t− τ)uk(τ) dτ, k = 1, · · · , p

Page 81: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (6)

xzs(t) =n−1Xj=0

Aj

∙b1

Z t

0

αj(t− τ)u1(τ) dτ+

b2

Z t

0

αj(t− τ)u2(τ) dτ + · · ·+

bp

Z t

0

αj(t− τ)up(τ) dτ¸

The integrals are functions of t:

γjk(t) =

Z t

0

αj(t− τ)uk(τ) dτ, k = 1, · · · , p

The zero-state solution is

xzs(t) =n−1Xj=0

Aj [b1γj1(t) + b2γj2(t) + · · ·+ b1γjp(t)]

Page 82: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (7)The zero-state solution is

xzs(t) =n−1Xj=0

Aj [b1γj1(t) + b2γj2(t) + · · ·+ bpγjp(t)]

Suppose that the set of n× 1 vectors©b1,Ab1, · · · ,An−1b1

ªis linearly independent.

Then any state xzs(t) can be written as a linear combination ofthese n vectors, and the system is controllable

One way to state mathematically that the set of vectors is inde-pendent is to state that

rank£b1 Ab1 · · · An−1b1

¤= n

Page 83: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (8)The zero-state solution is

xzs(t) =n−1Xj=0

Aj [b1γj1(t) + b2γj2(t) + · · ·+ bpγjp(t)]

If the set of vectors ©b1,Ab1, · · · ,An−1b1

ªis not linearly independent, then it has rank < n

However, there are still p− 1 controls remaining, and perhaps theadditional Ajbk vectors can be used to construct a linearly inde-pendent set of n vectors

One way to state mathematically that the set of vectors providesa set of n linearly independent vectors is

rank£B AB · · · An−1B

¤= n

Page 84: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (9)The test for controllability, therefore, is to construct the controlla-bility matrix,

Mc =£B AB · · · An−1B

¤and determine whether it has rank n.

If rank B = p, the reduced controllability matrix can be used:

Mc =£B AB · · · An−pB

¤The controllability test for this case is also

rank Mc = n

What are the dimensions of these two controllability matrices?

Page 85: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (10)Determine whether system

A =

∙1 00 3

¸, B =

∙01

¸is controllable.

Note that n = 2 and p = 1.

Mc = [B AB] =

∙01

03

¸The columns are linearly dependent and thus rank Mc = 1

The system is not controllable

Page 86: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability (11)Determine whether system

A =

∙1 00 3

¸, B =

∙11

¸is controllable.

Note that n = 2 and p = 1.

Mc = [B AB] =

∙11

13

¸The columns are linearly independent and thus rank Mc = 2

The system is controllable

Page 87: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

ObservabilityThe zero-input solution to x = Ax+Bu is

xzi(t) = eAtx(0)

The output equation is

yzi(t) = Cx = CeAtx(0)

Observability. Is there an initial condition, x(0) such thatyzi(t) = 0 for all time? If not, then the system is observable.

Keep in mind that x ∈ Rn, y ∈ Rm, A ∈ Rn×n, and C ∈ Rm×n

Also recall that the Cayley-Hamilton Theorem leads to

eAt =n−1Xj=0

αj(t)Aj

where the αj(t) terms are independent functions of time

Page 88: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems AnalysisLast time:

Modal Analysis

Controllability

Page 89: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear System RecapStandard form for nonlinear system

x = f(x,u, t)

y = g(x,u, t)

Equilibrium motions: constant (x∗,u∗) such that

f(x∗,u∗, t) = 0

Linearization about (x∗,u∗) to obtain

x = Ax+Bu

y = Cx+Du

General solution for time-invariant system

x(t) = eAtx(0) + eAtZ t

0

e−AτBu(τ) dτ

= xzi(t) + xzs(t)

Page 90: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear System With State and Output Feedback

Standard form for linear systems

x = Ax+Bu

y = Cx+Du

Two types of feedback: full-state, and output

u = −Kxx = [A−BK]x = Ax

u = −Kyx = [A−BKC]x = Ax

(Assuming no feedforward)

In both cases, the solution can be written as

x(t) = eAtx(0)

Page 91: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

An Aside on Linear AlgebraLinear systems analysis depends on many results from linear alge-bra, so a strong background in linear algebra is important

Linear algebra is much more than matrix multiplication, but muchof linear algebra involves how matrices multiply other matrices

An excellent reference is

Gilbert Strang, Linear Algebra and Its Applications

An n× n matrix A is nonsingular if and only if

F its rank is nF its rows are linearly independentF its columns are linearly independentF its determinant is non-zeroF none of its eigenvalues are zeroF the dimension of its nullspace is zero

All of these conditions are equivalent

Page 92: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

An Aside on Linear Algebra (2)Many of the matrices we see in linear systems analysis are notsquare

• The input matrix is usually (but not always) tall† (rows >columns)

• The output matrix is usually (but not always) short (rows <columns)

• The controllability matrix is always wide

• The observability matrix is always tall

The rank of a non-square matrix is the maximum of the number ofindependent rows or the number of independent columns

The rank cannot exceed the smallest dimension of the matrix

† These terms are not necessarily standard, but are suggestive

Page 93: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Controllability RecapControllability depends on the two matrices A, B

(A, B) is controllable if the controllability matrix

Mc =£B AB · · · An−1B

¤has rank n

If rank B = p, the reduced controllability matrix can be used:

Mc =£B AB · · · An−pB

¤The controllability test for this case is also rankMc = n

If a system is controllable, then the eigenvalues of

A = A−BK

can be placed anywhere in the complex plane by appropriate choiceof K (provided that the complex eigenvalues come in c.c. pairs)

Page 94: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Another Controllability Test

Another way to test for controllability is to apply the Popov-Hautus-Rosenbrock (PHR) test

rank [(λ1−A) B] = n

for all λ

Since λ1−A has rank n for all values of λ except for the eigenvaluesof A, the test only has to be applied at the eigenvalues

Using the controllability matrix test, rankMc = n, we form asingle n× np matrix and test its rank

Using the PHR test, we form nmatrices, each of which is n×(n+p),and test the rank of each of them

Page 95: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Some Controllability Applications

Suppose rank B = n; then (A, B) is controllable because the firstn columns of the controllability matrix are linearly independent

Suppose p = 1, and B ∈ Rn is an eigenvector ofA; then the systemis uncontrollable

rank Mc = rank£B AB · · · An−pB

¤= rank

£B λB · · · λn−1B

¤= 1

Relate to the PHR Test

Suppose 1 < p < n, and the columns of B, bk ∈ Rn, k = 1, · · · , p,are all eigenvectors of A; then the system is uncontrollable

rank Mc = rank£B AB · · · An−pB

¤= rank

£B BΛs · · · B Λn−ps

¤= p

where Λs is the diagonal matrix of the eigenvalues correspondingto the columns of B

Page 96: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Pole Placement

If (A, B) is controllable then the state-feedback closed-loop eigen-values (or poles) of

A = A−BKcan be arbitrarily placed in the complex plane by appropriate choiceof K, with the restriction that complex eigenvalues must be c.c.pairs

Suppose we want the closed-loop characteristic equation to be

p(λ) = λn + an−1λn−1 + · · ·+ a1λ+ a0

We can form the characteristic polynomial p(λ) and match its co-efficients with those of p(λ) to determine K

There are numerous methods for constructing K to match the co-efficients

Page 97: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Pole Placement (2)Consider the linear system with

A =

∙1 00 2

¸and B =

∙1 00 1

¸Clearly the system is controllable, since the controllability matrix

Mc = [B AB] = [1 A] =

∙1 0 1 00 1 0 2

¸has rank n

Suppose we want u = −Kx, such that λ1,2 = (−1,−2)

Select the elements of K to place the eigenvalues of

A = A−BK =

∙1 00 2

¸−∙1 00 1

¸ ∙K11 K12

K21 K22

¸=

∙1−K11 −K12

−K21 2−K22

¸

Page 98: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Pole Placement (3)The characteristic polynomial is

p(λ) = (λ− 1 +K11)(λ− 2 +K22)−K21K12

= λ2 + (K11 +K22 − 3)λ+ (K11 − 1)(K22 − 2)−K12K21

Evidently, for this example, we can choose K12 = K21 = 0, so that

p(λ) = λ2 + (K11 +K22 − 3)λ+ (K11 − 1)(K22 − 2)

The roots are

λ1,2 =1

2

h−(K11 +K22 − 3)±

p(K11 −K22 + 1)2

i=

1

2[−(K11 +K22 − 3)± (K11 −K22 + 1)]

= 1−K11, 2−K22

Thus K11 = 2,K22 = 4⇒ λ1,2 = (−1,−2)

Determine gains to place the eigenvalues at a specific complex con-jugate pair, λ1,2 = σ ± iω. May require non-zero K12 and K21

Page 99: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Pole Placement (4)The characteristic polynomial is

p(λ) = λ2 + (K11 +K22 − 3)λ+ (K11 − 1)(K22 − 2)−K12K21

Determine gains to place the eigenvalues at a specific complex con-jugate pair, λ1,2 = σ ± iω

The desired characteristic polynomial is

p(λ) = (λ− σ − iω)(λ− σ + iω)= λ2 − 2σλ+ σ2 + ω2

For pole placement, we require

(K11 +K22 − 3) = −2σK11K22 −K12K21 − 2K11 −K22 + 2 = σ2 + ω2

Try K11 = K22 = K1 ⇒ K1 = (3− 2σ)/2K12K21 = 2− σ2 − ω2 +K2

1 − 3K1

• • •

Page 100: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

StabilizabilityStabilizability is a less stringent variation of controllability

(A, B) is stabilizable if the eigenvalues of

A = A−BK

can be placed in the left half of the complex plane by appropriatechoice of K

If a system is controllable, then it is stabilizable

The Popov-Hautus-Rosenbrock (PHR) test applies to stabilizabil-ity as well as to controllability

Page 101: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Stabilizability (2)

(A, B) is stabilizable if λ(A = A−BK) can be placed in the lefthalf of the complex plane by appropriate choice of K

Stability ⇒ Stabilizability and Controllability ⇒ Stabilizability

The Popov-Hautus-Rosenbrock (PHR) test applies to stabilizabil-ity with slight modification

rank [(λ1−A) B] = n

for all λ with Re λ ≥ 0

Since λ1−A has rank n for all values of λ except for the eigenvaluesof A, the test only has to be applied at the eigenvalues, and onlyat the marginally stable and unstable eigenvalues

The essence of stabilizability is that all uncontrollable modes arestable and all unstable modes are controllable

If a system is unstabilizable, then the D&C folks are in trouble!

Page 102: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

ObservabilityThe zero-input solution to x = Ax+Bu is

xzi(t) = eAtx(0)

The output equation is

yzi(t) = Cx = CeAtx(0)

Observability. Is there an initial condition, x(0) such thatyzi(t) = 0 for all time? If not, then the system is observable.

Keep in mind that x ∈ Rn, y ∈ Rm, A ∈ Rn×n, and C ∈ Rm×n

Also recall that the Cayley-Hamilton Theorem leads to

eAt =n−1Xj=0

αj(t)Aj

where the αj(t) terms are independent functions of time

Page 103: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Observability (2)Consider a linear system with

A =

∙1 00 3

¸, C =

£0 1

¤Since the states are completely decoupled, the solution to the statezero-input dynamics are

x1 = etx1(0) and x2 = e

3tx2(0)

The output dynamics are described by

y = Cx = x2 = e3tx2(0)

Clearly, if we choose any value for x1(0) and choose x2(0) = 0, theny = 0 for all time. Thus the system is unobservable, and clearlythe unobservability is caused by the lack of a connection betweenx1 and y.

Page 104: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Observability (3)

We can obtain observability by adding another sensor, or connec-tion, between the state and the output:

A =

∙1 00 3

¸, C =

£1 1

¤The state zero-input dynamics are

x1 = etx1(0) and x2 = e

3tx2(0)

The output dynamics are described by

y = Cx = x1 + x2 = etx1(0) + e

3tx2(0)

Clearly, there are no choices for x1(0) and x2(0), such that y = 0for all time. Thus the system is observable.

Page 105: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Observability (4)

Recall that the zero-input solution is xzi(t) = eAtx(0). Thus theoutput solution for zero-input dynamics can be written as

yzi = Cxzi(t)

= CeAtx(0)

Incorporating the Cayley-Hamilton summation for eAt, we canrewrite yzi as

yzi = Cn−1Xj=0

Ajαj(t)x(0)

= Cn−1Xj=0

Ajx(0)αj(t)

Recall that C ∈ Rm×n, and note that CA ∈ Rm×n also.

Page 106: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Observability (5)

For there to be a non-zero initial condition x(0) such that yzi = 0,that initial condition would have to satisfy

CAjx(0) = 0 for each j = 0, · · · , n

This requirement can be written in matrix form as⎡⎢⎣ CA0

...CAn−1

⎤⎥⎦x(0) = 0, or Mox(0) = 0

If rank Mo = n, the system is observable

If rankMo < n, then the system is unobservable⇒ there are initialconditions such that the output is identically zero for all time

A PHR test for detectability is

rank

∙λ1−AC

¸= n for each eigenvalue

Page 107: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Observability (6)

Consider the linear system:

A =

∙1 00 3

¸, C =

£0 1

¤The observability matrix is

Mo =

∙CCA

¸=

∙0 10 3

¸Clearly the rows of Mo are linearly dependent, and hence (A,C)is unobservable

If an additional sensor were added, so that C = [1 1], then thesystem would be observable

Page 108: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Detectability

Detectability is related to observability in much the same way thatstabilizability is related to controllability

A system is detectable if the output observes all the unstable modes

In the concept of stabilizability, we are concerned with the eigen-values of the matrixA−BK, which arises due to a feedback controlof the form u = −Kx

A system is said to be detectable if an output-injection matrixL exists, such that the matrix A − LC is stable (i.e., has all itseigenvalues in the left-half plane)

A PHR test for detectability is

rank

∙λ1−AC

¸= n

for each unstable eigenvalue

Page 109: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Duality

There is a duality between controllability and observability

The system (A,B) is controllable if and only if the system(AT ,BT ) is observable

Similarly, the system (A,B) is stabilizable if and only if (AT ,BT )is detectable

Page 110: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Summary of C, O, S, D

Controllability means any statecan be reached in finite time

Tests:

rank Mc = n

rank [(λ1−A) B] = n

for each eigenvalue

Stabilizability means all eigenval-ues can be made stable with feed-back

Test:

rank [(λ1−A) B] = n

for each eigenvalue with Re λ ≥ 0

Observability means any statecan be detected in the output

Tests:

rank Mo = n

rank

∙λ1−AC

¸= n

for each eigenvalue

Detectability means all unstablemodes can be detected in the out-put

Test:

rank

∙λ1−A)C

¸= n

for each eigenvalue with Re λ ≥ 0

Page 111: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems Analysis

Last time:

Controllability

Stabilizability

Observability

Detectability

Page 112: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Summary of C, O, S, D

Controllability means any statecan be reached in finite time

Tests:

rank Mc = n

rank [(λ1−A) B] = n

for each eigenvalue

Stabilizability means all eigenval-ues can be made stable with feed-back

Test:

rank [(λ1−A) B] = n

for each eigenvalue with Re λ ≥ 0

Observability means any statecan be detected in the output

Tests:

rank Mo = n

rank

∙λ1−AC

¸= n

for each eigenvalue

Detectability means all unstablemodes can be detected in the out-put

Test:

rank

∙λ1−A)C

¸= n

for each eigenvalue with Re λ ≥ 0

Page 113: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

… - ilities: Pop QuizFor each of the following systems, determine stability, controllabil-

ity, and observability, and explain your reasoning

A =

∙1 00 1

¸B =

∙1 00 1

¸C =

∙1 00 1

¸

A =

⎡⎣ 1 0 00 1 00 0 1

⎤⎦ B =

⎡⎣ 1 00 11 1

⎤⎦ C =

∙1 0 00 1 1

¸

A =

⎡⎣ −1 0 00 −2 00 0 −3

⎤⎦ B =

⎡⎣ 1 0 10 1 −11 1 0

⎤⎦ C =

∙1 0 00 1 1

¸

A =

⎡⎣ −5 0 01 −4 03 4 4

⎤⎦ B =

⎡⎣ 1 00 11 1

⎤⎦ C =

∙1 0 00 1 1

¸

Page 114: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

… - ilities: Pop Quiz (2)For each of the following systems, determine stability, controllabil-

ity, and observability, and explain your reasoning

A =

∙−1 3−3 −1

¸B =

∙10

¸C =

£1 0

¤

A =

⎡⎣ 1 0 00 −2 40 −4 −2

⎤⎦ B =

⎡⎣ 011

⎤⎦ C =£0 1 1

¤

A =

⎡⎣ −2 3 0−3 −2 00 0 −3

⎤⎦ B =

⎡⎣ 111

⎤⎦ C =£1 1 1

¤

A =

⎡⎣ −5 0 30 −4 0−3 0 −5

⎤⎦ B =

⎡⎣ 010

⎤⎦ C =£0 1 0

¤

Page 115: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example RevisitedConsider the motion of a spinning rigid body with a constant

“environmental” torque. The desired motion of spinning body is

ω∗ = [Ω1 Ω2 Ω3]. We want to linearize the equations of motion

about the desired motion.

Expressed in a principal frame, the environmental torque is ge.

The “control” torque, g∗, required to maintain the desired motion

is easily computed using Euler’s equations:

ω = −I−1ω×Iω + I−1ge + I−1g = f(x,u)0 = −I−1ω∗×Iω∗ + I−1ge + I−1g∗ = f(x∗,u∗)g∗ = ω∗×Iω∗ − ge

Given the desired motion, ω∗ and the environmental torque ge, we

can easily compute g∗, which is clearly constant

In this problem, x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Page 116: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (2)Rosetta stone: x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Equations in scalar form:

ω1 =I2 − I3I1

ω2ω3 +ge1I1+g1I1= f1(x,u)

ω2 =I3 − I1I2

ω1ω3 +ge2I2+g2I2= f2(x,u)

ω3 =I1 − I2I3

ω1ω2 +ge3I3+g3I3= f3(x,u)

The matrix, ∂f∂x (x∗,u∗, t), is

∂f

∂x(x∗,u∗, t) =

⎡⎢⎣ 0 I2−I3I1

Ω3I2−I3I1

Ω2I3−I1I2

Ω3 0 I3−I1I2

Ω1I1−I2I3

Ω2I1−I2I3

Ω1 0

⎤⎥⎦ ≡ AClearly A depends only on the inertias and the desired steady

motion ω∗.

Page 117: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (3)Rosetta stone: x = ω, u = g, x∗ = ω∗, and u∗ = g∗

Equations of motion:

ω1 =I2 − I3I1

ω2ω3 +ge1I1+g1I1= f1(x,u)

ω2 =I3 − I1I2

ω1ω3 +ge2I2+g2I2= f2(x,u)

ω3 =I1 − I2I3

ω1ω2 +ge3I3+g3I3= f3(x,u)

The matrix ∂f∂u (x

∗,u∗, t) is

∂f

∂u(x∗,u∗, t) =

⎡⎣ 1I1

0 0

0 1I2

0

0 0 1I3

⎤⎦ ≡ BAs with A, the matrix B is constant and depends only on the

inertias. Note that B = I−1

Page 118: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (4)Thus, the linearized equations of motion are

˙δω = A δω +B δg or x = Ax+Bu

where

A =

⎡⎢⎣ 0 I2−I3I1

Ω3I2−I3I1

Ω2I3−I1I2

Ω3 0 I3−I1I2

Ω1I1−I2I3

Ω2I1−I2I3

Ω1 0

⎤⎥⎦ and B =

⎡⎣ 1I1

0 0

0 1I2

0

0 0 1I3

⎤⎦Note that δω = ω−ω∗, and δg = g−g∗. A typical control problemis to determine the control δg that will maintain the desired motion

in the presence of initial condition errors and other disturbances.

A recommended exercise is to choose values of I, ge, and ω∗, and

then compare the results of integrating the nonlinear differential

equations with the results of integrating the linear equations.

Page 119: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (5)Use the numerical values from Homework 7:

ω∗ = [10 0 6]T ⇒ A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦B = diag[0.0333 0.0250 0.0200]

Clearly the input matrixB has rank n, so the system is controllable

What if the torque actuator about one of the axes were to fail?

Three possibilities:

B = B12 =

⎡⎣ 0.0333 00 0.02500 0

⎤⎦ , B13 =⎡⎣ 0.0333 0

0 00 0.0200

⎤⎦ ,B23 =

⎡⎣ 0 00.0250 0

0 0.0200

⎤⎦

Page 120: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (6)Assuming no control torque about b3, we have

A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦B = B12 =

⎡⎣ 0.0333 00 0.02500 0

⎤⎦Controllability matrix:

Mc12 =

⎡⎣ 0.0333 0 0 −0.05000 0.0250 0.1000 00 0 0 −0.0500

⎤⎦Clearly, rank Mc12 = 3, so system is controllable with missing

input u3 (control torque about b3)

Note that we used the reduced dimension version of Mc

Page 121: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (7)With no control torque capability about b2, we have

A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦B13 =

⎡⎣ 0.0333 00 00 0.0200

⎤⎦Controllability matrix:

Mc13 =

⎡⎣ 0.0333 0 0 00 0 0.1000 0.100000 0.0200 0 0

⎤⎦Clearly, rank Mc13 = 3, so system is controllable with missing

input u2 (control torque about b2)

Exercise: Determine the controllability for other failed actuator

cases

Page 122: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (8)Block-diagonalization

A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦ ⇒ E =

⎡⎣ 0.8575 0.4082i −0.4082i0 0.8165 0.8165

−0.5145 0.4082i −0.4082i

⎤⎦

Eb =

⎡⎣ 0.8575 0 0.40820 0.8165 0

−0.5145 0 0.4082

⎤⎦ , Λb =⎡⎣ 0 0 00 0 40 −4 0

⎤⎦

eΛbt =

⎡⎣ e0t 0 00 cos 4t sin 4t0 − sin 4t cos 4t

⎤⎦ = R1(4t)

The matrix exponential, eΛt, turns out to be a rotation matrix

The real mode is marginally stable, as are the coupled oscillatory

modes

Page 123: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (9)

-1

0

1-1 -0.8 -0.6 -0.4 -0.2 0 0.2 0.4 0.6 0.8 1

-0.6

-0.4

-0.2

0

0.2

0.4

0.6

0.8

1

b1b

b 3

Block-diagonalization

Eb =

⎡⎣ 0.8575 0 0.40820 0.8165 0

−0.5145 0 0.4082

⎤⎦The real mode is marginally stable, as are the coupled oscillatory

modes

Page 124: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (10)To consider observability, we need to define an output vector

Suppose we have three rate gyros capable of measuring the rates

about the three principal body axes

y = ω = g(x,u, t) = g(x)

We want to linearize g(x) about x∗ to obtain the output matrix C

The matrix, C = ∂g∂x

¯x∗, is

∂g

∂x

¯x∗

= 1 ≡ C

Since C has rank n, the system is observable if all the sensors are

operable

What if a sensor fails?

Page 125: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (11)Suppose two of three rate gyros fail; then C is simply one row of

the identity matrix

C ∈

⎧⎪⎨⎪⎩⎡⎣ 100

⎤⎦T ,⎡⎣ 010

⎤⎦T ,⎡⎣ 001

⎤⎦T⎫⎪⎬⎪⎭ , A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦The three observability matrices are

Mo ∈

⎧⎨⎩⎡⎣ 1 0 0

0 −2 0−6 0 −10

⎤⎦ ,⎡⎣ 0 1 03 0 50 −16 0

⎤⎦ ,⎡⎣ 0 0 1

0 −2 0−6 0 −10

⎤⎦⎫⎬⎭Clearly the first and third of these observability matrices both have

rank 3, but the second has rank 2

The system is unobservable with only a rate gyro on the b2 axis,

but is observable with a rate gyro on the first or third axes

Page 126: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (12)Look more closely at the unobservable case

C = [0 1 0] , A =

⎡⎣ 0 −2 03 0 50 −2 0

⎤⎦The observability matrix is

Mo =

⎡⎣ 0 1 03 0 50 −16 0

⎤⎦The initial condition state that is unobservable is the vector x(0)

such that Mox(0) = 0

That is, x(0) ∈ N (Mo); in words, x(0) is in the nullspace of Mo

What initial state x(0) satisfies this condition?

Page 127: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (13)We want to solve Mox(0) = 0

Mox(0) =

⎡⎣ 0 1 03 0 50 −16 0

⎤⎦⎡⎣ x1x2x3

⎤⎦ = 0

Carrying out the matrix multiplication, we obtain

x2 = 0⇒ x2 = 0

3x1 + 5x3 = 0⇒ x1 = −5x3/3−16x2 = 0⇒ x2 = 0

Clearly, any solution must lie along the line spanned by

x(0) =£−5/3 0 1]T

This line is the same as the eigenvector associated with the zero

real eigenvalue (check this claim); this mode is unobservable with

a 2-axis rate gyro

Page 128: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linearization Example Revisited (14)

Use the PHR test for detectability

rank

∙(λ1−A)

C

¸= n

for each unstable or marginally stable eigenvalue

rank

∙(01−A)

C

¸= n

rank

⎡⎢⎢⎣0 2 0−3 0 −50 2 00 1 0

⎤⎥⎥⎦ = 2

Therefore the system is undetectable, as well as unobservable

Page 129: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Linear Systems Analysis

Last time:

Examples of Controllability,Stabilizability, Observability, and Detectability

This time:

PID (Proportional + Integral + Derivative) Control

Page 130: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Way Back to Translational Motion

x1 = x

x2 = y

x3 = z

x4 = x

x5 = y

x6 = z

↓x ∈ R6

In general, the forces fx, fy, and fz could depend on xj and xj , aswell as on time t. The forces could also be nonlinear in the states.

x1 = x4

x2 = x5

x3 = x6

x4 = fx/m

x5 = fy/m

x6 = fz/m

x = f(x,u, t)

Page 131: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System

Simple rearrangement of the equations of motion leads to the standard form:

Clearly this system is controllable and stabilizable (exercise)Also, the system is in a decoupled form that is common for mechanical systems

x =

⎡⎢⎢⎢⎢⎢⎢⎣0 0 0 1 0 00 0 0 0 1 00 0 0 0 0 10 0 0 0 0 00 0 0 0 0 00 0 0 0 0 0

⎤⎥⎥⎥⎥⎥⎥⎦x+⎡⎢⎢⎢⎢⎢⎢⎣0 0 00 0 00 0 01 0 00 1 00 0 1

⎤⎥⎥⎥⎥⎥⎥⎦u= Ax+Bu

What are the eigenvalues of A?

Page 132: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (2)

Looking back to the origin of these equations, recall that

x =

⎡⎢⎢⎢⎢⎢⎢⎣0 0 0 1 0 00 0 0 0 1 00 0 0 0 0 10 0 0 0 0 00 0 0 0 0 00 0 0 0 0 0

⎤⎥⎥⎥⎥⎥⎥⎦x+⎡⎢⎢⎢⎢⎢⎢⎣0 0 00 0 00 0 01 0 00 1 00 0 1

⎤⎥⎥⎥⎥⎥⎥⎦u= Ax+Bu

Consider using a full-state feedback that maintains this decoupling

x = fx/m(= u1), so

xj = uj

xj = xj+3 and xj+3 = uj

Page 133: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (3)We have the coupled pairs of equations:

xj = xj+3 and xj+3 = uj

If we let uj = −kpxj − kdxj+3, then

xj = xj+3 and xj+3 = −kpxj − kdxj+3xj + kdxj+3 + kpxj = 0

xj + kdxj + kpxj = 0

x+ kdx+ kpx = 0We can pick the gains kd and kp so that the eigenvalues have neg-ative real parts (detectability)

λ = σ ± iωp(λ) = λ2 − 2σλ+ σ2 + ω2

kd = −2σ and kp = σ2 + ω2

Page 134: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (4)

x+ kdx+ kpx = 0

Gain selection for pole placement

λ = σ ± iωp(λ) = λ2 − 2σλ+ σ2 + ω2

kd = −2σ and kp = σ2 + ω2

A standard form for this second-order system is

p(λ) = λ2 + 2ζωnλ+ ω2n

kd = 2ζωn and kp = ω2n

The damping ratio, ζ is usually chosen so that ζ ∈[0.5, 0.707], and the natural frequency ωn is the bandwidthof the system with PD control

Page 135: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (5)

Gain selection in terms of ζ andωn:

kd = 2ζωn and kp = ω2n

Solution to ODE:

x(t) = e−ζωnt (c1 cosωdt+ c2 sinωdt)

where ωd = ωnp1− ζ2

The damping ratio, ζ is usuallychosen so that ζ ∈ [0.5, 0.707],and the natural frequency ωn isthe bandwidth of the system withPD control

Re λ

Im λ

×sin−1 ζ

ωn

×

ωd

σ

Page 136: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (6)

Suppose the second order systemwith PD control is subject to aunit step disturbance:

x+ kdx+ kpx = ustep

where

ustep = 0 ∀ t ≤ 0ustep = 1 ∀ t > 0

What happens as t→∞?

0

0.1

0.2

0.3

0.4

0.5

To: O

ut(1

)

0 0.5 1 1.5 2 2.5 3 3.5 40

0.05

0.1

0.15

0.2

0.25

0.3

0.35

0.4

To:

Out

(2)

S tep Response

Time (sec)

Am

plitu

de

Answer: The output (x) does not stabilize to theorigin. Rather, x(∞)− > 1/kp

Page 137: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

Translational Linear System (7)

The differential equation be-comes

x+ kdx+ kpx = ustep + uI

Differentiate once to get

xiii + kdx+ kpx+ kIx = 0

The roots of the characteristicequation include the two PDeigenvalues and an additionalpole at −kI/ω2nThe term kI/ω

2n is typically

denoted 1/T , where T is theintegral or reset time

How can we stabilize in pres-ence of step disturbance:

x+ kdx+ kpx = ustep ?

We have feedback controlforces that are proportionalto the error (kp) and propor-tional to the derivative of theerror (kd).

Introduce a feedback controlforce that is proportional tothe integral of the error (kI)

uI = −kIZ t

t0

x(τ ) dτ

Page 138: Linear Systems Analysis - Virginia Techcdhall/courses/aoe5204/LinearS… ·  · 2006-09-27AOE 5204 Linear Systems Analysis Last time: Axisymmetric, torque-free rigid body Linear

AOE 5204

PID Control

PID Control includes threeterms: proportional, deriva-tive, and integral:

up = −kpxud = −kdx

uI = kI

Z t

t0

x(τ) dτ

This type of control makesthe output robust to constantdisturbances, but also makesthe system less stable (or lessdamped)

Typically, PID control is writ-ten as

u = −kx− kTDx

− kTI

Z t

t0

x(τ) dτ

There are several ways to tunethe three parameters appear-ing in the PID control