Lecture 6 Verification of Hybrid Systems

Size: px
Start display at page:

Download "Lecture 6 Verification of Hybrid Systems"

Transcription

1 Lecture 6 Verification of Hybrid Systems Ufuk Topcu Nok Wongpiromsarn Richard M. Murray AFRL, 25 April 2012 Outline: A hybrid system model Finite-state abstractions and use of model checking Deductive verification and optimization-based construction of certificates Approximate bisimulation functions

2 Hybrid systems: example gear = 1 ẋ = v v = f 1 (v)u gear = 2 gear = 3 gear = 2 ẋ = v v = f 2 (v)u gear = 3 ẋ = v v = f 3 (v)u gear = 1 gear = 2 Model and tools so far (in the course) help reason about discrete evolution of systems: does there exist a control sequence for which ϕ holds, or do all control sequences lead to executions for which ϕ holds with ϕ = (gear = 1 gear = 3)? Need to modify to capture continuous evolution: Can the car come to a stop from any (reasonable) speed within x meters? How to efficiently accelerate? efficiency,f i f 1 (v) f 2 (v) f 3 (v) v 2

3 Why to use hybrid system models? Continuous systems with multiple modes Discrete logic controlling continuous systems Continuous systems with hybrid specifications! * & $! *!"!"#$%&'()* +$,-./0&1)(2!&!* #!! "!!!) ( % & " Navigation stack of Alice Mission Planner 9$%*)./( 1$/8 :)/8 '()*&'.0/! '80;8/(&<&:)/8&=>! 6?85-*)./(&=> ' 3,$44.5& 6.,578 % # $ ( '!)!"#$%&'"()&"*$+%)&,-"." /012$3-%*"3-"%)&"40,53-6" 7$%"89$-&":;<"0,&" =)&>52$3-%*""""""""""""""""""""""""""!"!# Traffic Planner Path Planner Vehicle Actuation min T t 0 L(x, u)dt s.t. ẋ = f(x, u) g(x, u) 0 3

4 A (simple) hybrid system model X Hybrid system: H =(X, L, X 0,I,F,T) with X, continuous state space; I(α 1 ) I(α 3 ) L, finite set of locations (modes); Overall state space X = X L; X 0 X, set of initial states; I : L 2 X, invariant that maps l L to the set of possible continuous states while in location l; F : X 2 Rn, set of vector fields, i.e., ẋ F (l, x); T X X, relation capturing discrete transitions between locations. (l, x) (l,x ) I(α 2 ) L = {α 1, α 2, α 3 } 4

5 Given: H =(X,L,X 0,I,F,T) Specifications x 0 X 0 Solution at time t with the initial condition : φ(t; x 0 ) With the simple model H, specifying the initial state also specifies the initial mode. Sample temporal properties: Stability: Given equilibrium x e X, for all x 0 X 0 X, φ(t; x 0 ) X, t and φ(t; x 0 ) x e, t Safety: Given X unsafe X, safety property holds if there exists no t unsafe and trajectory with initial condition x 0 X 0, φ(t unsafe ; x 0 ) X unsafe φ(t; x 0 ) X, t [0,t unsafe ] X reach X Reachability: Given, reachability property holds if there exists finite t reach 0 and a trajectory with initial condition, X 0 x 0 X 0 φ(t reach ; x 0 ) X reach and φ(t; x 0 ) X, t [0,t reach ] X reach Eventuality: reachable from every initial condition Combinations of the above, e.g., starting in, reach both X B and X C, but will not be reached before X C is reached while staying safe. X A X B 5

6 Verification of hybrid systems: Overview Why not directly use model checking? Model checking applied to finite transitions systems exhaustively search for counterexamples... if found, property does not hold. if there is no counterexample in all possible executions, the property is verified. Exhaustive search is not possible over continuous state spaces. Approaches for hybrid system verification: X 1. Construct finite-state approximations and apply model checking preserve the meaning of the properties, i.e., proposition preserving partitions use over - or under -approximations 2. Deductive verification Construct Lyapunov-type certificates Account for the discrete jumps in the construction of the certificate 3. Explicitly construct the set of reachable states Limited classes of temporal properties (e.g., reachability and safety) Not covered in this lecture 6

7 Hybrid system: Finite-state, under- and over-approximations H =(X,L,X 0,I,F,T) Finite-transition system: TS =(Q,,Q 0 ) Define the map T : Q 2 X q T 1 (q) For discrete state, the corresponding cell in X. X is Under-approximation: TS is an under-approximation of H if the following two statements hold. Given q, q Q with q = q, if q q, then for all x 0 T 1 (q), there exists finite τ > 0 such that φ(τ; x 0 ) T 1 (q ), φ(t; x 0 ) T 1 (q) T 1 (q ), t [0, τ] If q q, then T 1 (q) is positively-invariant. In other words: Every discrete trajectory in an under-approximation TS can be implemented by H. TS simulates H. Over-approximation: TS is an over-approximation of H, if for each discrete transition in TS, there is a possibility to be implemented by H. Possibility induced by the coarseness of the partition. 7

8 Use of under-approximations Let the following be given. A hybrid system H, a finite-state, under-approximation TS1 for H, Verification Let an LTL specification ϕ be given. Question: H = ϕ? Model check TS1 = ϕ? Words( ϕ) Trace(TS1) Trace(H) Words( ϕ) Trace(TS1) is nonempty Words( ϕ) Trace(H) is nonempty H cannot satisfy the specification. TS1 = φ H = φ Words( ϕ) Trace(TS1) is empty Inconclusive Logic synthesis: If Words(ϕ) Trace(TS1) is nonempty, there exists a trajectory of TS1 which satisfies ϕ and can be implemented by H. Otherwise, inconclusive. 8

9 Use of over-approximations Hybrid system H and a finite-state, over-approximation TS2 for H. Verification Words(ϕ) Trace(TS2) is nonempty Inconclusive Words( ϕ) Trace(H) Trace(TS2) Words( ϕ) Trace(TS2) is empty Words( ϕ) Trace(H) isempty H satisfies the specification. TS2 = ϕ H = ϕ Logic synthesis: If Words(ϕ) Trace(TS2) is empty, no valid trajectories for TS2 or H. Otherwise, inconclusive. Remarks: Under- and over-approximations give partial results. Potential remedies: Finer approximations Bisimulations 9

10 Example: verification System models: Continuous vector field: Discrete over-approximation: (small dots: self transitions) Specifications: Both hold for the overapproximation; hence, they hold for the actual system. Example from Temporal logic analysis of gene networks under parametric uncertainty, Batt, Belta, Weiss, Joint special issue of IEEE TAC & Trans on Circuits,

11 Verification of hybrid systems: Overview Why not directly use model checking? Model checking applied to finite transitions systems exhaustively search for counterexamples... if found, property does not hold. if there is no counterexample in all possible executions, the property is verified. Exhaustive search is not possible over continuous state spaces. Approaches for hybrid system verification: 1. Construct finite-state approximations and apply model checking preserve the meaning of the properties, i.e., proposition preserving partitions use over - or under -approximations 2. Deductive verification Construct Lyapunov-type certificates Account for the discrete jumps in the construction of the certificate 3. Explicitly construct the set of reachable states Limited classes of temporal properties (e.g., reachability and safety) Not covered in this lecture 11

12 What does deductive verification mean? Example with continuous, nonlinear dynamics: ẋ(t) =f(x(t)) where x(t) R n, f(0) = 0,x=0 is an asymptotically stable equilibrium. Region-of-attraction: R := x : lim φ(t; x) =0 t Question 1 (a system analysis question): Given S R n, is S invariant and S R? the question we want to answer the question we attempt to answer Question 2 (an algebraic question): Does there exist a continuously differentiable function V : R n R V is positive definite, V(0) = 0, Ω := {x : V (x) 1} {x : V f(x) < 0} {0} S Ω? such that Yes to Question 2 Yes to Question 1. 12

13 Barrier Certificates - Safety Safety property holds if there exists no and trajectory such that: T 0 X X unsafe x = φ(0; x) X initial φ(t ; x) X unsafe φ(t; x) X t [0,T]. X initial Continuous dynamics: ẋ(t) =f(x(t)) Suppose there exists a differentiable function B such that Hybrid dynamics: H =(X,L,X 0,I,F,T ) Suppose there exist differentiable functions (for each mode) such that B l B(x) 0, x X initial B(x) > 0, x X unsafe B x f(x) 0, x X. Then, the safety property holds. B l (x) 0, x I(l) X initial B l (x) > 0, x I(l) X unsafe B l F (x) 0, x I(l) x B l (x ) B l (x) 0, for each jump (l, x) (l,x ) Then, the safety property holds. 13

14 Barrier Certificates - Eventuality ẋ(t) =f(x(t)) X X target Eventuality property holds if for all x 0 X initial, φ(t ; x 0 ) X target φ(t; x 0 ) X, t [0,T] for some non-negative T. notation: set closure X initial X, X target, X initial are bounded Suppose that f is continuously differentiable and there exists a continuously differentiable function B such that don t leave X before reaching X target leave X \X target in finite time B(x) 0, x X initial B(x) > 0, x X\ X target B x (x) f(x) < 0, x X \X target Then, the eventuality property holds. Straightforward extensions for hybrid dynamics as in safety verification are possible. 14

15 Composing Barrier Certificates X X A 1 X B x X C If system starts in X A, then both X B and X C are reached in finite time, but X C will not be reached before system reaches X B B 1 (x) 0 x X A, x 1 B 1 (x) > 0 x X X C, B 1 x (x)f(x, d) ɛ (x, d) (X \X B) D, B 2 (x) 0 x X A, B 2 (x) > 0 x X, Prajna, Ph.D. Thesis, B 2 x (x)f(x, d) ɛ x (X \X C) D, incorporating disturbances and uncertainties 15

16 General How procedure to construct to construct the certificates? certificates System properties Algebraic conditions Lyapunov, dissipation inequalities. { Problemdependent! Algebraic conditions Numerical optimization problems Restrict the attention to polynomial vector fields, polynomial certificates,... S-procedure like conditions (for set containment constraints) Sum-of-squares (SOS) relaxations for polynomial nonnegativity Pass to semidefinite programming (SDP) that are equivalent of SOS conditions Solve the resulting (linear or bilinear ) SDPs Construct polynomial certificates { Generally taken care of by software packages. 16

17 Some preliminaries Semidefinite programming problems Positive semidefinite polynomials and sum-of- squares (SOS) programming Set containment conditions and S-procedure 17

18 Linear and Bilinear Matrix Inequalities Linear and bilinear matrix inequalities Convex, efficient, generalpurpose solvers exist { Given matrices {F i } N i=0 Sn n, Linear Matrix Inequality (LMI) is a constraint on λ R N of the form: F 0 + N k=1 λ k F k 0 Non-convex, no efficient, generalpurpose solvers { Given matrices {F i } N i=0, {G j} M j=1, and {H k,j} N k=1 M j=1 S n n, a Bilinear Matrix Inequality (BMI) is a constraint on λ R N and γ R M of the form: F 0 + N k=1 λ k F k + M j=1 γ k G j + N k=1 M j=1 λ k γ j H k,j 0 Semidefinite program (?) very roughly speaking, optimization of affine objective subject to LMI or/and BMI constraints 18

19 Polynomials and Multipoly Toolbox Given α N n, a monomial in n variables is a function m α : R n R defined as m α (x) := x α 1 1 xα 2 2 xα n n. The degree of a monomial is defined as deg m α := n i=1 α i. Polynomial: Finite linear combination of monomials. : R n R p := c α m α = c α x α where A N n is a finite set and c α R α A. α A α A (available through workshop web page) { } Multipoly is a Matlab toolbox for the creation and manipulation of polynomials of one or more variables. ultipoly Toolbox Example: pvar x1 x2 p = 2*x1^4 + 2*x1^3*x2 - x1^2*x2^2 + 5*x2^4 q = x1^2 p*q = 2*x1^6 + 2*x1^5*x2 - x1^4*x2^2 + 5*x1^2*x2^4 jacobian(p, [x1;x2]) = [ 8*x1^3 + 6*x1^2*x2-2*x1*x2^2, 2*x1^3-2*x1^2*x2 + 20*x2^3 ] A A 19

20 Positive semidefinite polynomials Positive Semidefinite Polynomials R[x 1,...,x n ] or R[x] denotes the set of polynomials (with real coefficients) in the variables {x 1,...,x n }. p R [x] is positive semi-definite (PSD) if p(x) 0 x. The set of PSD polynomials in n variables {x 1,...,x n } will be denoted P [x 1,...,x n ] or P [x]. Testing if p P [x] is NP-hard when the polynomial degree is at least four. For a general class of functions, verifying global non-negativity is recursively undecidable. How about a quadratic polynomial? Reference: Parrilo, P., Structured Semidefinite Programs and Semialgebraic Geometry Methods in Robustness and Optimization, Ph.D. thesis, California Institute of Technology, (Chapter 4 of this thesis and the reference contained therein summarize the computational issues associated with verifying global non-negativity of functions.) 20

21 Sum-of-Squares Polynomials m of Squares Polynomials p is a sum of squares (SOS) if there exist polynomials {f i } N i=1 such p is that a sump of = squares N (SOS) if there exist polynomials {f i } N i=1 such that p = i=1 f i 2. The set of SOS polynomials N i=1 f i 2. in n variables {x 1,...,x n } will be The denoted set of SOS Σ [x 1 polynomials,...,x n ] or in Σ n [x]. variables {x 1,...,x n } will If p is a SOS then p is PSD. be denoted Σ [x 1,...,x n ] or Σ [x]. If p is a SOS then p is PSD. The Motzkin polynomial, p = x 2 y 4 + x 4 y x 2 y 2, is PSD but not SOS. p Hilbert (1888) showed that P [x] =Σ [x] only for a) n =1, b) d =2, and c) d =4, n =2. p(x) =z(x) T Qz(x) For every polynomial matrix Q such that of degree 2d, there exists a symmetric with p is a SOS iff there exists Q 0 such that p = z T Qz. z(x) := 1,x 1,...,x n,x 2 1,x 1 x 2,...,x 2 n,...,x d n T Reference: Choi, M., Lam, T., and Reznick, B., Sums of Squares of Real Polynomials, Proceedings of Symposia in Pure Mathematics, Vol. 58, No. 2, 1995, pp p is SOS if and only if there exists Q 0 s.t. p(x) =z(x) T Qz(x) Given p, can be verified as SDP. 21

22 SOS SOS Example Example SOS example All All possible possible Gram Gram matrix matrix representations representations of of p(x) =2x x 3 1x 2 x 2 1x x 4 2 p =2x =2x x 1 +2x 3 1x 3 2 1x 2 x 2 1x 2 1x x 2 +5x are are given given by by z T (Q (Q + λn) λn) z where: where: x z = x 1 x 2 1 2,Q= 1 0 0,Q=,N= 1 0 0,N= x p(x) =z(x) T Qz(x) 0=z(x) T Nz(x) (x 1 x 2 ) (x 1 x 2 )=x 2 1 x p is is SOS SOS iff iff Q + λn λn 0 for for some some λ R. R. LMI 22

23 GeneralSOS programming Programming SOS Programming: Given c R m and polynomials {f j,k } N s j=1 m k=0, solve: min α R ct α m subject to: f 1,0 (x)+f 1,1 (x)α f 1,m (x)α m Σ [x]. f Ns,0(x)+f Ns,1(x)α f Ns,m(x)α m Σ [x] There is freely available software (e.g. SOSTOOLS, YALMIP, SOSOPT) that: 1. Converts the SOS program to an SDP 2. Solves the SDP with available SDP codes (e.g. Sedumi) 3. Converts the SDP results back into polynomial solutions 23

24 Set containment conditions Given polynomials g 1 and g 2, define sets S 1 and S 2 : S 1 := {x R n : g 1 (x) 0} S 2 := {x R n : g 2 (x) 0} Is S 2 S 1? Polynomial S-procedure λ Σ[x] s.t. g 1 (x)+λ(x)g 2 (x) Σ[x] λ positive semidefinite polynomial s.t. g 1 (x)+λ(x)g 2 (x) 0 x {x : g 2 (x) 0} { x : g 1 (x) 0} Example: B(x) 0, x X initial Suppose X initial = {x : g(x) 0} for some g Sufficient condition: There exists positive semidefinite function s such that B(x)+s(x)g(x) = B(x) s(x)( g(x)) 0, x R n 24

25 Global Stability Theorem Global stability theorem Theorem: Let l 1,l 2 R [x] satisfy l i (0) = 0 and l i (x) > 0 x = 0 for i =1, 2. If there exists V R [x] such that: V (0) = 0 V l 1 Σ [x] V f l 2 Σ [x] Then R 0 = R n. Reference: Vidyasagar, M., Nonlinear Systems Analysis, SIAM, (Refer to Section 5.3 for theorems on Lyapunov s direct method.) V is positive definite, radially unbounded V is decreasing along the vector field 25

26 Global Stability Example with sosopt Global stability examples with sosopt % Code from Parrilo1_GlobalStabilityWithVec.m % Create vector field for dynamics pvar x1 x2; x = [x1;x2]; x1dot = -x1-2*x2^2; x2dot = -x2 - x1*x2-2*x2^3; xdot = [x1dot; x2dot]; % Use sosopt to find a Lyapunov function % that proves x = 0 is GAS % Define decision variable for quadratic % Lyapunov function zv = monomials(x,2); V = polydecvar( c,zv, vec ); % Constraint 1 : V(x) - L1 \in SOS L1 = 1e-6 * ( x1^2 + x2^2 ); sosconstr{1} = V - L1; % Constraint 2: -Vdot - L2 \in SOS L2 = 1e-6 * ( x1^2 + x2^2 ); Vdot = jacobian(v,x)*xdot; sosconstr{2} = -Vdot - L2; x2 % Solve with feasibility problem [info,dopt,sossol] = sosopt(sosconstr,x); Vsol = subs(v,dopt) Vsol = *x1^ e-017*x1*x *x2^ !1!2! !4!4! x

27 Approximate bisimulation relations & bisimulation functions Two systems with x i R n i,x i (0) I i R n i,u i (t) U i R m i,y i R p Φ 1 : ẋ1 (t) =f 1 (x 1 (t),u 1 (t)) y 1 (t) =g 1 (x 1 (t)) Φ 2 : ẋ2 (t) =f 2 (x 2 (t),u 2 (t)) y 2 (t) =g 2 (x 2 (t)) A relation R δ R m 1 R n 2 is a δ-approximate bisimulation relation between Φ 1 and Φ 2 if for all (x 1,x 2 ) R δ : g 1 (x 1 ) g 2 (x 2 ) δ; T >0 and u 1 ( ), u 2 ( ) s.t. (φ 1 (t; x 1 ) φ 2 (t; x 2 )) R δ t [0,T]; T >0 and u 2 ( ), u 1 ( ) s.t. (φ 1 (t; x 1 ) φ 2 (t; x 2 )) R δ t [0,T]. If start in relation, stay in relation. Observations are close. A function V : R n 1 R n 2 R + {+ } is a bisimulation function between Φ 1 and Φ 2 if for all δ 0: R δ = {(x 1,x 2 ) R n 1 R n 2 : V (x 1,x 2 ) δ} sublevel sets of V induce a relation is a closed set and a δ-approximate bisimulation relation between Φ 1 and Φ 2. 27

28 Approximate bisimulation relations & bisimulation functions Two systems with x i R n i,x i (0) I i R n i,u i (t) U i R m i,y i R p Φ 1 : ẋ1 (t) =f 1 (x 1 (t),u 1 (t)) y 1 (t) =g 1 (x 1 (t)) Φ 2 : ẋ2 (t) =f 2 (x 2 (t),u 2 (t)) y 2 (t) =g 2 (x 2 (t)) Let W : R n 1 R n 2 R + be a continuously differentiable function. If for all (x 1,x 2 ) R n 1 R n 2, W (x 1,x 2 ) g 1 (x 1 ) g 2 (x 2 ) 2 W f 1 (x 1,u 1 ) W f(x 2,u 2 ) 0, (x 1,x 2 ) R n 1 R n 2,u 1 R m 1,u 2 R m 2 x 1 x 2 then V := W is a bisimulation function between Φ 1 and Φ 2. guarantees that no matter what u 1 and u 2 do, the time derivative of W stays non-positive 28

29 Approximate bisimulations + safety Reach [0,T ] (Φ 1 ) 5 Reach [0,T ] (Φ 2 ) 10 Unsafe 10 Unsafe Φ 1 s.t. x 1 R 10 Φ 2 s.t. x 2 R 4 Φ 3 s.t. x 3 R Reach [0,T ] (Φ 3 ) Φ 1 is 1.90-approximate bisimilar to Φ 2 Φ 1 is 0.76-approximate bisimilar to Φ 3 10 Unsafe Figures from Girard & Pappas, Automatica,

Analytical Validation Tools for Safety Critical Systems

Analytical Validation Tools for Safety Critical Systems Analytical Validation Tools for Safety Critical Systems Peter Seiler and Gary Balas Department of Aerospace Engineering & Mechanics, University of Minnesota, Minneapolis, MN, 55455, USA Andrew Packard

More information

Lecture 8 Receding Horizon Temporal Logic Planning & Finite-State Abstraction

Lecture 8 Receding Horizon Temporal Logic Planning & Finite-State Abstraction Lecture 8 Receding Horizon Temporal Logic Planning & Finite-State Abstraction Ufuk Topcu Nok Wongpiromsarn Richard M. Murray AFRL, 26 April 2012 Contents of the lecture: Intro: Incorporating continuous

More information

Quantitative Local Analysis of Nonlinear Systems

Quantitative Local Analysis of Nonlinear Systems Quantitative Local Analysis of Nonlinear Systems Andrew Packard Department of Mechanical Engineering University of California, Berkeley Ufuk Topcu Control and Dynamical Systems California Institute of

More information

Polynomial level-set methods for nonlinear dynamical systems analysis

Polynomial level-set methods for nonlinear dynamical systems analysis Proceedings of the Allerton Conference on Communication, Control and Computing pages 64 649, 8-3 September 5. 5.7..4 Polynomial level-set methods for nonlinear dynamical systems analysis Ta-Chung Wang,4

More information

Demonstration of multipoly and sosopt packages

Demonstration of multipoly and sosopt packages Demonstration of multipoly and sosopt packages Demonstrated during Lecture 4 of CDS 270 on Oct 13th. By U. Topcu & A. Lamperski Contents Basic manipulations with multipoly Vector representation example

More information

Quantitative Local Analysis of Nonlinear Systems. Ufuk Topcu. B.S. (Bogazici University, Istanbul) 2003 M.S. (University of California, Irvine) 2005

Quantitative Local Analysis of Nonlinear Systems. Ufuk Topcu. B.S. (Bogazici University, Istanbul) 2003 M.S. (University of California, Irvine) 2005 Quantitative Local Analysis of Nonlinear Systems by Ufuk Topcu B.S. (Bogazici University, Istanbul) 2003 M.S. (University of California, Irvine) 2005 A dissertation submitted in partial satisfaction of

More information

Minimum Ellipsoid Bounds for Solutions of Polynomial Systems via Sum of Squares

Minimum Ellipsoid Bounds for Solutions of Polynomial Systems via Sum of Squares Journal of Global Optimization (2005) 33: 511 525 Springer 2005 DOI 10.1007/s10898-005-2099-2 Minimum Ellipsoid Bounds for Solutions of Polynomial Systems via Sum of Squares JIAWANG NIE 1 and JAMES W.

More information

Optimization of Polynomials

Optimization of Polynomials Optimization of Polynomials Matthew M. Peet Arizona State University Thanks to S. Lall and P. Parrilo for guidance and supporting material Lecture 03: Optimization of Polynomials Overview In this lecture,

More information

Converse Results on Existence of Sum of Squares Lyapunov Functions

Converse Results on Existence of Sum of Squares Lyapunov Functions 2011 50th IEEE Conference on Decision and Control and European Control Conference (CDC-ECC) Orlando, FL, USA, December 12-15, 2011 Converse Results on Existence of Sum of Squares Lyapunov Functions Amir

More information

Lecture 9 Synthesis of Reactive Control Protocols

Lecture 9 Synthesis of Reactive Control Protocols Lecture 9 Synthesis of Reactive Control Protocols Nok Wongpiromsarn Singapore-MIT Alliance for Research and Technology Richard M. Murray and Ufuk Topcu California Institute of Technology EECI, 16 May 2012

More information

Robust and Optimal Control, Spring 2015

Robust and Optimal Control, Spring 2015 Robust and Optimal Control, Spring 2015 Instructor: Prof. Masayuki Fujita (S5-303B) G. Sum of Squares (SOS) G.1 SOS Program: SOS/PSD and SDP G.2 Duality, valid ineqalities and Cone G.3 Feasibility/Optimization

More information

Local Stability Analysis For Uncertain Nonlinear Systems Using A Branch-and-Bound Algorithm

Local Stability Analysis For Uncertain Nonlinear Systems Using A Branch-and-Bound Algorithm 28 American Control Conference Westin Seattle Hotel, Seattle, Washington, USA June 11-13, 28 ThC15.2 Local Stability Analysis For Uncertain Nonlinear Systems Using A Branch-and-Bound Algorithm Ufuk Topcu,

More information

SOSTOOLS and its Control Applications

SOSTOOLS and its Control Applications SOSTOOLS and its Control Applications Stephen Prajna 1, Antonis Papachristodoulou 1, Peter Seiler 2, and Pablo A. Parrilo 3 1 Control and Dynamical Systems, California Institute of Technology, Pasadena,

More information

COMPLEX behaviors that can be exhibited by modern engineering

COMPLEX behaviors that can be exhibited by modern engineering IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 52, NO. 8, AUGUST 2007 1415 A Framework for Worst-Case and Stochastic Safety Verification Using Barrier Certificates Stephen Prajna, Member, IEEE, Ali Jadbabaie,

More information

Nonlinear Analysis of Adaptive Flight Control Laws

Nonlinear Analysis of Adaptive Flight Control Laws Nonlinear Analysis of Adaptive Flight Control Laws Andrei Dorobantu, Peter Seiler, and Gary Balas Department of Aerospace Engineering & Mechanics University of Minnesota, Minneapolis, MN, 55455, USA Adaptive

More information

Local Robust Performance Analysis for Nonlinear Dynamical Systems

Local Robust Performance Analysis for Nonlinear Dynamical Systems 2009 American Control Conference Hyatt Regency Riverfront, St. Louis, MO, USA June 10-12, 2009 WeB04.1 Local Robust Performance Analysis for Nonlinear Dynamical Systems Ufuk Topcu and Andrew Packard Abstract

More information

Analysis and synthesis: a complexity perspective

Analysis and synthesis: a complexity perspective Analysis and synthesis: a complexity perspective Pablo A. Parrilo ETH ZürichZ control.ee.ethz.ch/~parrilo Outline System analysis/design Formal and informal methods SOS/SDP techniques and applications

More information

Time Delay Margin Analysis for an Adaptive Controller

Time Delay Margin Analysis for an Adaptive Controller Time Delay Margin Analysis for an Adaptive Controller Andrei Dorobantu, Peter Seiler, and Gary J. Balas Department of Aerospace Engineering & Mechanics University of Minnesota, Minneapolis, MN, 55455,

More information

Safety Verification of Hybrid Systems Using Barrier Certificates

Safety Verification of Hybrid Systems Using Barrier Certificates Safety Verification of Hybrid Systems Using Barrier Certificates Stephen Prajna 1 and Ali Jadbabaie 2 1 Control and Dynamical Systems, California Institute of Technology, Pasadena, CA 91125 - USA, prajna@cds.caltech.edu

More information

APPROXIMATE SIMULATION RELATIONS FOR HYBRID SYSTEMS 1. Antoine Girard A. Agung Julius George J. Pappas

APPROXIMATE SIMULATION RELATIONS FOR HYBRID SYSTEMS 1. Antoine Girard A. Agung Julius George J. Pappas APPROXIMATE SIMULATION RELATIONS FOR HYBRID SYSTEMS 1 Antoine Girard A. Agung Julius George J. Pappas Department of Electrical and Systems Engineering University of Pennsylvania Philadelphia, PA 1914 {agirard,agung,pappasg}@seas.upenn.edu

More information

SUM-OF-SQUARES BASED STABILITY ANALYSIS FOR SKID-TO-TURN MISSILES WITH THREE-LOOP AUTOPILOT

SUM-OF-SQUARES BASED STABILITY ANALYSIS FOR SKID-TO-TURN MISSILES WITH THREE-LOOP AUTOPILOT SUM-OF-SQUARES BASED STABILITY ANALYSIS FOR SKID-TO-TURN MISSILES WITH THREE-LOOP AUTOPILOT Hyuck-Hoon Kwon*, Min-Won Seo*, Dae-Sung Jang*, and Han-Lim Choi *Department of Aerospace Engineering, KAIST,

More information

Hybrid Systems - Lecture n. 3 Lyapunov stability

Hybrid Systems - Lecture n. 3 Lyapunov stability OUTLINE Focus: stability of equilibrium point Hybrid Systems - Lecture n. 3 Lyapunov stability Maria Prandini DEI - Politecnico di Milano E-mail: prandini@elet.polimi.it continuous systems decribed by

More information

Simulation-aided Reachability and Local Gain Analysis for Nonlinear Dynamical Systems

Simulation-aided Reachability and Local Gain Analysis for Nonlinear Dynamical Systems Proceedings of the 47th IEEE Conference on Decision and Control Cancun, Mexico, Dec. 9-11, 28 ThTA1.2 Simulation-aided Reachability and Local Gain Analysis for Nonlinear Dynamical Systems Weehong Tan,

More information

Convex Optimization. (EE227A: UC Berkeley) Lecture 28. Suvrit Sra. (Algebra + Optimization) 02 May, 2013

Convex Optimization. (EE227A: UC Berkeley) Lecture 28. Suvrit Sra. (Algebra + Optimization) 02 May, 2013 Convex Optimization (EE227A: UC Berkeley) Lecture 28 (Algebra + Optimization) 02 May, 2013 Suvrit Sra Admin Poster presentation on 10th May mandatory HW, Midterm, Quiz to be reweighted Project final report

More information

Region of Attraction Estimation for the GTM Design Model

Region of Attraction Estimation for the GTM Design Model Region of Attraction Estimation for the GTM Design Model Peter Seiler, Gary Balas, and Andrew Packard peter.j.seiler@gmail.com, balas@musyn.com September 29, 29 1 Overview Region of attraction analysis

More information

Nonlinear Systems Theory

Nonlinear Systems Theory Nonlinear Systems Theory Matthew M. Peet Arizona State University Lecture 2: Nonlinear Systems Theory Overview Our next goal is to extend LMI s and optimization to nonlinear systems analysis. Today we

More information

Local Stability Analysis for Uncertain Nonlinear Systems

Local Stability Analysis for Uncertain Nonlinear Systems 1042 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 54, NO. 5, MAY 2009 Local Stability Analysis for Uncertain Nonlinear Systems Ufuk Topcu and Andrew Packard Abstract We propose a method to compute provably

More information

Estimating the Region of Attraction of Ordinary Differential Equations by Quantified Constraint Solving

Estimating the Region of Attraction of Ordinary Differential Equations by Quantified Constraint Solving Estimating the Region of Attraction of Ordinary Differential Equations by Quantified Constraint Solving Henning Burchardt and Stefan Ratschan October 31, 2007 Abstract We formulate the problem of estimating

More information

A Framework for Worst-Case and Stochastic Safety Verification Using Barrier Certificates

A Framework for Worst-Case and Stochastic Safety Verification Using Barrier Certificates University of Pennsylvania ScholarlyCommons Departmental Papers (ESE) Department of Electrical & Systems Engineering August 2007 A Framework for Worst-Case and Stochastic Safety Verification Using Barrier

More information

DOMAIN OF ATTRACTION: ESTIMATES FOR NON-POLYNOMIAL SYSTEMS VIA LMIS. Graziano Chesi

DOMAIN OF ATTRACTION: ESTIMATES FOR NON-POLYNOMIAL SYSTEMS VIA LMIS. Graziano Chesi DOMAIN OF ATTRACTION: ESTIMATES FOR NON-POLYNOMIAL SYSTEMS VIA LMIS Graziano Chesi Dipartimento di Ingegneria dell Informazione Università di Siena Email: chesi@dii.unisi.it Abstract: Estimating the Domain

More information

Op#mal Control of Nonlinear Systems with Temporal Logic Specifica#ons

Op#mal Control of Nonlinear Systems with Temporal Logic Specifica#ons Op#mal Control of Nonlinear Systems with Temporal Logic Specifica#ons Eric M. Wolff 1 Ufuk Topcu 2 and Richard M. Murray 1 1 Caltech and 2 UPenn University of Michigan October 1, 2013 Autonomous Systems

More information

Vector Barrier Certificates and Comparison Systems

Vector Barrier Certificates and Comparison Systems Vector Barrier Certificates and Comparison Systems Andrew Sogokon 1 Khalil Ghorbal 2 Yong Kiam Tan 1 André Platzer 1 1 - Carnegie Mellon University, Pittsburgh, USA 2 - Inria, Rennes, France 16 July 2018,

More information

Optimization-based Modeling and Analysis Techniques for Safety-Critical Software Verification

Optimization-based Modeling and Analysis Techniques for Safety-Critical Software Verification Optimization-based Modeling and Analysis Techniques for Safety-Critical Software Verification Mardavij Roozbehani Eric Feron Laboratory for Information and Decision Systems Department of Aeronautics and

More information

Optimization over Nonnegative Polynomials: Algorithms and Applications. Amir Ali Ahmadi Princeton, ORFE

Optimization over Nonnegative Polynomials: Algorithms and Applications. Amir Ali Ahmadi Princeton, ORFE Optimization over Nonnegative Polynomials: Algorithms and Applications Amir Ali Ahmadi Princeton, ORFE INFORMS Optimization Society Conference (Tutorial Talk) Princeton University March 17, 2016 1 Optimization

More information

EE C128 / ME C134 Feedback Control Systems

EE C128 / ME C134 Feedback Control Systems EE C128 / ME C134 Feedback Control Systems Lecture Additional Material Introduction to Model Predictive Control Maximilian Balandat Department of Electrical Engineering & Computer Science University of

More information

Discrete abstractions of hybrid systems for verification

Discrete abstractions of hybrid systems for verification Discrete abstractions of hybrid systems for verification George J. Pappas Departments of ESE and CIS University of Pennsylvania pappasg@ee.upenn.edu http://www.seas.upenn.edu/~pappasg DISC Summer School

More information

Hybrid Systems Course Lyapunov stability

Hybrid Systems Course Lyapunov stability Hybrid Systems Course Lyapunov stability OUTLINE Focus: stability of an equilibrium point continuous systems decribed by ordinary differential equations (brief review) hybrid automata OUTLINE Focus: stability

More information

V&V MURI Overview Caltech, October 2008

V&V MURI Overview Caltech, October 2008 V&V MURI Overview Caltech, October 2008 Pablo A. Parrilo Laboratory for Information and Decision Systems Massachusetts Institute of Technology Goals!! Specification, design, and certification!! Coherent

More information

Nonlinear Control. Nonlinear Control Lecture # 3 Stability of Equilibrium Points

Nonlinear Control. Nonlinear Control Lecture # 3 Stability of Equilibrium Points Nonlinear Control Lecture # 3 Stability of Equilibrium Points The Invariance Principle Definitions Let x(t) be a solution of ẋ = f(x) A point p is a positive limit point of x(t) if there is a sequence

More information

Constructing Lyapunov-Krasovskii Functionals For Linear Time Delay Systems

Constructing Lyapunov-Krasovskii Functionals For Linear Time Delay Systems Constructing Lyapunov-Krasovskii Functionals For Linear Time Delay Systems Antonis Papachristodoulou, Matthew Peet and Sanjay Lall Abstract We present an algorithmic methodology for constructing Lyapunov-Krasovskii

More information

Modeling & Control of Hybrid Systems Chapter 4 Stability

Modeling & Control of Hybrid Systems Chapter 4 Stability Modeling & Control of Hybrid Systems Chapter 4 Stability Overview 1. Switched systems 2. Lyapunov theory for smooth and linear systems 3. Stability for any switching signal 4. Stability for given switching

More information

Control Software Model Checking Using Bisimulation Functions for Nonlinear Systems

Control Software Model Checking Using Bisimulation Functions for Nonlinear Systems Proceedings of the 47th IEEE Conference on Decision and Control Cancun, Mexico, Dec. 9-11, 2008 Control Software Model Checking Using Bisimulation Functions for Nonlinear Systems James Kapinski 1, Alexandre

More information

Modern Optimal Control

Modern Optimal Control Modern Optimal Control Matthew M. Peet Arizona State University Lecture 19: Stabilization via LMIs Optimization Optimization can be posed in functional form: min x F objective function : inequality constraints

More information

Fast ADMM for Sum of Squares Programs Using Partial Orthogonality

Fast ADMM for Sum of Squares Programs Using Partial Orthogonality Fast ADMM for Sum of Squares Programs Using Partial Orthogonality Antonis Papachristodoulou Department of Engineering Science University of Oxford www.eng.ox.ac.uk/control/sysos antonis@eng.ox.ac.uk with

More information

Stability lectures. Stability of Linear Systems. Stability of Linear Systems. Stability of Continuous Systems. EECE 571M/491M, Spring 2008 Lecture 5

Stability lectures. Stability of Linear Systems. Stability of Linear Systems. Stability of Continuous Systems. EECE 571M/491M, Spring 2008 Lecture 5 EECE 571M/491M, Spring 2008 Lecture 5 Stability of Continuous Systems http://courses.ece.ubc.ca/491m moishi@ece.ubc.ca Dr. Meeko Oishi Electrical and Computer Engineering University of British Columbia,

More information

Distributed Stability Analysis and Control of Dynamic Networks

Distributed Stability Analysis and Control of Dynamic Networks Distributed Stability Analysis and Control of Dynamic Networks M. Anghel and S. Kundu Los Alamos National Laboratory, USA August 4, 2015 Anghel & Kundu (LANL) Distributed Analysis & Control of Networks

More information

Lecture Note 5: Semidefinite Programming for Stability Analysis

Lecture Note 5: Semidefinite Programming for Stability Analysis ECE7850: Hybrid Systems:Theory and Applications Lecture Note 5: Semidefinite Programming for Stability Analysis Wei Zhang Assistant Professor Department of Electrical and Computer Engineering Ohio State

More information

Estimating the Region of Attraction of Ordinary Differential Equations by Quantified Constraint Solving

Estimating the Region of Attraction of Ordinary Differential Equations by Quantified Constraint Solving Proceedings of the 3rd WSEAS/IASME International Conference on Dynamical Systems and Control, Arcachon, France, October 13-15, 2007 241 Estimating the Region of Attraction of Ordinary Differential Equations

More information

Converse Lyapunov theorem and Input-to-State Stability

Converse Lyapunov theorem and Input-to-State Stability Converse Lyapunov theorem and Input-to-State Stability April 6, 2014 1 Converse Lyapunov theorem In the previous lecture, we have discussed few examples of nonlinear control systems and stability concepts

More information

Approximate Bisimulations for Constrained Linear Systems

Approximate Bisimulations for Constrained Linear Systems Approximate Bisimulations for Constrained Linear Systems Antoine Girard and George J Pappas Abstract In this paper, inspired by exact notions of bisimulation equivalence for discrete-event and continuous-time

More information

Analysis and Control of Nonlinear Actuator Dynamics Based on the Sum of Squares Programming Method

Analysis and Control of Nonlinear Actuator Dynamics Based on the Sum of Squares Programming Method Analysis and Control of Nonlinear Actuator Dynamics Based on the Sum of Squares Programming Method Balázs Németh and Péter Gáspár Abstract The paper analyses the reachability characteristics of the brake

More information

Quantitative Local Analysis of Nonlinear Systems

Quantitative Local Analysis of Nonlinear Systems Quantitative Local Analysis of Nonlinear Systems Ufuk Topcu Control and Dynamical Systems California Institute of Technology September 17, 2009 Advertisement Another workshop on V&V September 23&24, 2009

More information

MCE/EEC 647/747: Robot Dynamics and Control. Lecture 8: Basic Lyapunov Stability Theory

MCE/EEC 647/747: Robot Dynamics and Control. Lecture 8: Basic Lyapunov Stability Theory MCE/EEC 647/747: Robot Dynamics and Control Lecture 8: Basic Lyapunov Stability Theory Reading: SHV Appendix Mechanical Engineering Hanz Richter, PhD MCE503 p.1/17 Stability in the sense of Lyapunov A

More information

Lecture Note 7: Switching Stabilization via Control-Lyapunov Function

Lecture Note 7: Switching Stabilization via Control-Lyapunov Function ECE7850: Hybrid Systems:Theory and Applications Lecture Note 7: Switching Stabilization via Control-Lyapunov Function Wei Zhang Assistant Professor Department of Electrical and Computer Engineering Ohio

More information

DSOS/SDOS Programming: New Tools for Optimization over Nonnegative Polynomials

DSOS/SDOS Programming: New Tools for Optimization over Nonnegative Polynomials DSOS/SDOS Programming: New Tools for Optimization over Nonnegative Polynomials Amir Ali Ahmadi Princeton University Dept. of Operations Research and Financial Engineering (ORFE) Joint work with: Anirudha

More information

Optimization over Polynomials with Sums of Squares and Moment Matrices

Optimization over Polynomials with Sums of Squares and Moment Matrices Optimization over Polynomials with Sums of Squares and Moment Matrices Monique Laurent Centrum Wiskunde & Informatica (CWI), Amsterdam and University of Tilburg Positivity, Valuations and Quadratic Forms

More information

Estimating the region of attraction of uncertain systems with Integral Quadratic Constraints

Estimating the region of attraction of uncertain systems with Integral Quadratic Constraints Estimating the region of attraction of uncertain systems with Integral Quadratic Constraints Andrea Iannelli, Peter Seiler and Andrés Marcos Abstract A general framework for Region of Attraction (ROA)

More information

Sum of Squares Relaxations for Polynomial Semi-definite Programming

Sum of Squares Relaxations for Polynomial Semi-definite Programming Sum of Squares Relaxations for Polynomial Semi-definite Programming C.W.J. Hol, C.W. Scherer Delft University of Technology, Delft Center of Systems and Control (DCSC) Mekelweg 2, 2628CD Delft, The Netherlands

More information

ANALYSIS OF ZENO STABILITY IN HYBRID SYSTEMS USING SUM-OF-SQUARES PROGRAMMING CHAITANYA MURTI

ANALYSIS OF ZENO STABILITY IN HYBRID SYSTEMS USING SUM-OF-SQUARES PROGRAMMING CHAITANYA MURTI ANALYSIS OF ZENO STABILITY IN HYBRID SYSTEMS USING SUM-OF-SQUARES PROGRAMMING BY CHAITANYA MURTI Submitted in partial fulfillment of the requirements for the degree of Master of Science in Electrical Engineering

More information

arxiv: v1 [math.ds] 23 Apr 2017

arxiv: v1 [math.ds] 23 Apr 2017 Estimating the Region of Attraction Using Polynomial Optimization: a Converse Lyapunov Result Hesameddin Mohammadi, Matthew M. Peet arxiv:1704.06983v1 [math.ds] 23 Apr 2017 Abstract In this paper, we propose

More information

Lecture 7 Synthesis of Reactive Control Protocols

Lecture 7 Synthesis of Reactive Control Protocols Lecture 7 Synthesis of Reactive Control Protocols Richard M. Murray Nok Wongpiromsarn Ufuk Topcu California Institute of Technology AFRL, 25 April 2012 Outline Review: networked control systems and cooperative

More information

Time Delay Margin Analysis Applied to Model Reference Adaptive Control

Time Delay Margin Analysis Applied to Model Reference Adaptive Control Time Delay Margin Analysis Applied to Model Reference Adaptive Control Andrei Dorobantu, Peter J. Seiler, and Gary J. Balas, Department of Aerospace Engineering & Mechanics University of Minnesota, Minneapolis,

More information

Global Analysis of Piecewise Linear Systems Using Impact Maps and Surface Lyapunov Functions

Global Analysis of Piecewise Linear Systems Using Impact Maps and Surface Lyapunov Functions IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL 48, NO 12, DECEMBER 2003 2089 Global Analysis of Piecewise Linear Systems Using Impact Maps and Surface Lyapunov Functions Jorge M Gonçalves, Alexandre Megretski,

More information

On the Difficulty of Deciding Asymptotic Stability of Cubic Homogeneous Vector Fields

On the Difficulty of Deciding Asymptotic Stability of Cubic Homogeneous Vector Fields On the Difficulty of Deciding Asymptotic Stability of Cubic Homogeneous Vector Fields Amir Ali Ahmadi Abstract It is well-known that asymptotic stability (AS of homogeneous polynomial vector fields of

More information

Minimum-Phase Property of Nonlinear Systems in Terms of a Dissipation Inequality

Minimum-Phase Property of Nonlinear Systems in Terms of a Dissipation Inequality Minimum-Phase Property of Nonlinear Systems in Terms of a Dissipation Inequality Christian Ebenbauer Institute for Systems Theory in Engineering, University of Stuttgart, 70550 Stuttgart, Germany ce@ist.uni-stuttgart.de

More information

Appendix A Solving Linear Matrix Inequality (LMI) Problems

Appendix A Solving Linear Matrix Inequality (LMI) Problems Appendix A Solving Linear Matrix Inequality (LMI) Problems In this section, we present a brief introduction about linear matrix inequalities which have been used extensively to solve the FDI problems described

More information

Synthesis of Reactive Switching Protocols from Temporal Logic Specifications

Synthesis of Reactive Switching Protocols from Temporal Logic Specifications 1 Synthesis of Reactive Switching Protocols from Temporal Logic Specifications Jun Liu, Necmiye Ozay, Ufuk Topcu, and Richard M. Murray Abstract We propose formal means for synthesizing switching protocols

More information

ROBUST STATE FEEDBACK CONTROL OF UNCERTAIN POLYNOMIAL DISCRETE-TIME SYSTEMS: AN INTEGRAL ACTION APPROACH

ROBUST STATE FEEDBACK CONTROL OF UNCERTAIN POLYNOMIAL DISCRETE-TIME SYSTEMS: AN INTEGRAL ACTION APPROACH International Journal of Innovative Computing, Information and Control ICIC International c 2013 ISSN 1349-4198 Volume 9, Number 3, March 2013 pp. 1233 1244 ROBUST STATE FEEDBACK CONTROL OF UNCERTAIN POLYNOMIAL

More information

Representations of Positive Polynomials: Theory, Practice, and

Representations of Positive Polynomials: Theory, Practice, and Representations of Positive Polynomials: Theory, Practice, and Applications Dept. of Mathematics and Computer Science Emory University, Atlanta, GA Currently: National Science Foundation Temple University

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

LMI Methods in Optimal and Robust Control

LMI Methods in Optimal and Robust Control LMI Methods in Optimal and Robust Control Matthew M. Peet Arizona State University Lecture 15: Nonlinear Systems and Lyapunov Functions Overview Our next goal is to extend LMI s and optimization to nonlinear

More information

Automatic Synthesis of Robust Embedded Control Software

Automatic Synthesis of Robust Embedded Control Software AAAI Spring Symposium on Embedded Reasoning (2224 Mar 2010, Stanford) http://www.cds.caltech.edu/~murray/papers/wtm10aaai.html Automatic Synthesis of Robust Embedded Control Software Tichakorn Wongpiromsarn,

More information

ONR MURI AIRFOILS: Animal Inspired Robust Flight with Outer and Inner Loop Strategies. Calin Belta

ONR MURI AIRFOILS: Animal Inspired Robust Flight with Outer and Inner Loop Strategies. Calin Belta ONR MURI AIRFOILS: Animal Inspired Robust Flight with Outer and Inner Loop Strategies Provable safety for animal inspired agile flight Calin Belta Hybrid and Networked Systems (HyNeSs) Lab Department of

More information

Power Systems Transient Stability Analysis via Optimal Rational Lyapunov Functions

Power Systems Transient Stability Analysis via Optimal Rational Lyapunov Functions Power Systems Transient Stability Analysis via Optimal Rational Lyapunov Functions Dongkun Han, Ahmed El-Guindy, and Matthias Althoff Department of Informatics, Technical University of Munich, 85748 Garching,

More information

SOS Methods for Delay-Dependent Stability of Neutral Differential Systems

SOS Methods for Delay-Dependent Stability of Neutral Differential Systems SOS Methods for Delay-Dependent Stability of Neutral Differential Systems Matthew M. Peet, Catherine Bonnet Özbay and Hitay 1 Introduction In this paper, we consider the problem of verification of certain

More information

Module 04 Optimization Problems KKT Conditions & Solvers

Module 04 Optimization Problems KKT Conditions & Solvers Module 04 Optimization Problems KKT Conditions & Solvers 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

From Convex Optimization to Linear Matrix Inequalities

From Convex Optimization to Linear Matrix Inequalities Dep. of Information Engineering University of Pisa (Italy) From Convex Optimization to Linear Matrix Inequalities eng. Sergio Grammatico grammatico.sergio@gmail.com Class of Identification of Uncertain

More information

An equilibrium-independent region of attraction formulation for systems with uncertainty-dependent equilibria

An equilibrium-independent region of attraction formulation for systems with uncertainty-dependent equilibria An equilibrium-independent region of attraction formulation for systems with uncertainty-dependent equilibria Andrea Iannelli 1, Peter Seiler 2 and Andrés Marcos 1 Abstract This paper aims to compute the

More information

Numerical Approaches for Developing Predictive Models

Numerical Approaches for Developing Predictive Models 1 Numerical Approaches for Developing Predictive Models Pete Seiler, Michael Frenklach, Andrew Packard, and Ryan Feeley This work was supported by the National Science Foundation, Information Technology

More information

Model Validation and Robust Stability Analysis of the Bacterial Heat Shock Response Using SOSTOOLS

Model Validation and Robust Stability Analysis of the Bacterial Heat Shock Response Using SOSTOOLS Model Validation and Robust Stability Analysis of the Bacterial Heat Shock Response Using SOSTOOLS H. El-Samad, S. Prajna, A. Papachristodoulou, M. Khammash, J.C. Doyle Mechanical and Environmental Engineering,

More information

Lecture 2 Automata Theory

Lecture 2 Automata Theory Lecture 2 Automata Theory Ufuk Topcu Nok Wongpiromsarn Richard M. Murray EECI, 18 March 2013 Outline Modeling (discrete) concurrent systems: transition systems, concurrency and interleaving Linear-time

More information

Navigation and Obstacle Avoidance via Backstepping for Mechanical Systems with Drift in the Closed Loop

Navigation and Obstacle Avoidance via Backstepping for Mechanical Systems with Drift in the Closed Loop Navigation and Obstacle Avoidance via Backstepping for Mechanical Systems with Drift in the Closed Loop Jan Maximilian Montenbruck, Mathias Bürger, Frank Allgöwer Abstract We study backstepping controllers

More information

Algorithmic Verification of Stability of Hybrid Systems

Algorithmic Verification of Stability of Hybrid Systems Algorithmic Verification of Stability of Hybrid Systems Pavithra Prabhakar Kansas State University University of Kansas February 24, 2017 1 Cyber-Physical Systems (CPS) Systems in which software "cyber"

More information

Rational Sums of Squares and Applications

Rational Sums of Squares and Applications f ΣR[X] 2 " f ΣQ[X] 2 Rational Sums of Squares and Applications Christopher Hillar (MSRI & Berkeley) A 2008 study found that adding a picture of a brain scan to a scientific argument about human nature

More information

THE objective of this paper is to synthesize switching. Synthesis of Reactive Switching Protocols from Temporal Logic Specifications

THE objective of this paper is to synthesize switching. Synthesis of Reactive Switching Protocols from Temporal Logic Specifications Synthesis of Reactive Switching Protocols from Temporal Logic Specifications Jun Liu, Member, IEEE, Necmiye Ozay, Member, IEEE, Ufuk Topcu, Member, IEEE, and Richard M Murray, Fellow, IEEE Abstract We

More information

On a decomposition of multivariable forms via LMI methods

On a decomposition of multivariable forms via LMI methods Proceedings of the American Control Conference Chicago, Illinois June 2000 On a decomposition of multivariable forms via LMI methods Pablo A. Parriilo pabloqcds. caltech. edu Control & Dynamical Systems

More information

STABILITY ANALYSIS AND CONTROL DESIGN

STABILITY ANALYSIS AND CONTROL DESIGN STABILITY ANALYSIS AND CONTROL DESIGN WITH IMPACTS AND FRICTION Michael Posa Massachusetts Institute of Technology Collaboration with Mark Tobenkin and Russ Tedrake ICRA Workshop on Robust Optimization-Based

More information

Learning Control Lyapunov Functions from Counterexamples and Demonstrations

Learning Control Lyapunov Functions from Counterexamples and Demonstrations Noname manuscript No. (will be inserted by the editor) Learning Control Lyapunov Functions from Counterexamples and Demonstrations Hadi Ravanbakhsh Sriram Sankaranarayanan Received: date / Accepted: date

More information

Lecture 2 Automata Theory

Lecture 2 Automata Theory Lecture 2 Automata Theory Ufuk Topcu Nok Wongpiromsarn Richard M. Murray Outline: Transition systems Linear-time properties Regular propereties EECI, 14 May 2012 This short-course is on this picture applied

More information

Stability Region Analysis using polynomial and composite polynomial Lyapunov functions and Sum of Squares Programming

Stability Region Analysis using polynomial and composite polynomial Lyapunov functions and Sum of Squares Programming Stability Region Analysis using polynomial and composite polynomial Lyapunov functions and Sum of Squares Programming Weehong Tan and Andrew Packard Abstract We propose using (bilinear) sum-of-squares

More information

Algorithmic Construction of Lyapunov Functions for Power System Stability Analysis

Algorithmic Construction of Lyapunov Functions for Power System Stability Analysis 1 Algorithmic Construction of Lyapunov Functions for Power System Stability Analysis M. Anghel, F. Milano, Senior Member, IEEE, and A. Papachristodoulou, Member, IEEE Abstract We present a methodology

More information

Course Outline. FRTN10 Multivariable Control, Lecture 13. General idea for Lectures Lecture 13 Outline. Example 1 (Doyle Stein, 1979)

Course Outline. FRTN10 Multivariable Control, Lecture 13. General idea for Lectures Lecture 13 Outline. Example 1 (Doyle Stein, 1979) Course Outline FRTN Multivariable Control, Lecture Automatic Control LTH, 6 L-L Specifications, models and loop-shaping by hand L6-L8 Limitations on achievable performance L9-L Controller optimization:

More information

Stability and Robustness Analysis of Nonlinear Systems via Contraction Metrics and SOS Programming

Stability and Robustness Analysis of Nonlinear Systems via Contraction Metrics and SOS Programming arxiv:math/0603313v1 [math.oc 13 Mar 2006 Stability and Robustness Analysis of Nonlinear Systems via Contraction Metrics and SOS Programming Erin M. Aylward 1 Pablo A. Parrilo 1 Jean-Jacques E. Slotine

More information

Pre- and Post-processing Sum-of-squares Programs in Practice

Pre- and Post-processing Sum-of-squares Programs in Practice IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL X, NO X, JANUARY 00X Pre- and Post-processing Sum-of-squares Programs in Practice Johan Löfberg Abstract Checking non-negativity of polynomials using sum-ofsquares

More information

Fast Algorithms for SDPs derived from the Kalman-Yakubovich-Popov Lemma

Fast Algorithms for SDPs derived from the Kalman-Yakubovich-Popov Lemma Fast Algorithms for SDPs derived from the Kalman-Yakubovich-Popov Lemma Venkataramanan (Ragu) Balakrishnan School of ECE, Purdue University 8 September 2003 European Union RTN Summer School on Multi-Agent

More information

The moment-lp and moment-sos approaches

The moment-lp and moment-sos approaches The moment-lp and moment-sos approaches LAAS-CNRS and Institute of Mathematics, Toulouse, France CIRM, November 2013 Semidefinite Programming Why polynomial optimization? LP- and SDP- CERTIFICATES of POSITIVITY

More information

arxiv: v1 [math.oc] 31 Jan 2017

arxiv: v1 [math.oc] 31 Jan 2017 CONVEX CONSTRAINED SEMIALGEBRAIC VOLUME OPTIMIZATION: APPLICATION IN SYSTEMS AND CONTROL 1 Ashkan Jasour, Constantino Lagoa School of Electrical Engineering and Computer Science, Pennsylvania State University

More information

EN Nonlinear Control and Planning in Robotics Lecture 3: Stability February 4, 2015

EN Nonlinear Control and Planning in Robotics Lecture 3: Stability February 4, 2015 EN530.678 Nonlinear Control and Planning in Robotics Lecture 3: Stability February 4, 2015 Prof: Marin Kobilarov 0.1 Model prerequisites Consider ẋ = f(t, x). We will make the following basic assumptions

More information

Formal Verification and Automated Generation of Invariant Sets

Formal Verification and Automated Generation of Invariant Sets Formal Verification and Automated Generation of Invariant Sets Khalil Ghorbal Carnegie Mellon University Joint work with Andrew Sogokon and André Platzer Toulouse, France 11-12 June, 2015 K. Ghorbal (CMU,

More information

Advanced SDPs Lecture 6: March 16, 2017

Advanced SDPs Lecture 6: March 16, 2017 Advanced SDPs Lecture 6: March 16, 2017 Lecturers: Nikhil Bansal and Daniel Dadush Scribe: Daniel Dadush 6.1 Notation Let N = {0, 1,... } denote the set of non-negative integers. For α N n, define the

More information