Global optimization seeks to find the best solution to a

Size: px
Start display at page:

Download "Global optimization seeks to find the best solution to a"

Transcription

1 » PRODUCT REVIEW Global Optimization Toolbox for Maple DIDIER HENRION Global optimization seeks to find the best solution to a constrained nonlinear optimization problem by performing a complete search over a set of feasible solutions. In contrast with local optimization, a complete search exhaustively checks the entire feasible region under a Lipschitz-continuity assumption with a known bound on the Lipschitz constant. Some online information on global optimization is available at [1]. As surveyed in [2], many mathematical and engineering problems require a complete search. An example is the 300- year-old Kepler problem of finding the densest packing of equal spheres in three-dimensional Euclidean space, for which a computer-assisted proof is discussed in [3]. The proof involves reducing the problem to several thousand linear programs and using interval calculations to ensure rigorous handling of rounding errors for establishing the correctness of inequalities. Many other difficult problems, such as the traveling salesman and protein folding problems, are global optimization problems. ALGORITHMS The Global Optimization Toolbox (GOT), first released in June 2004 with Maple 9.5, is part of the Maple Professional Toolbox series of add-on products that can be purchased separately. GOT is jointly developed by Maplesoft and Pintér Consulting Services (PCS). PCS is led by János D. Pintér, who has been developing optimization software for over 15 years in collaboration with academic and industrial partners. The core of GOT is the Lipschitz Global Optimizer (LGO), an integrated suite of global and local solvers based on the research summarized in the monograph [4], which was awarded the 2000 INFORMS Computing Society Prize for Research Excellence. A detailed manual is expected to be available by the time this review is published [5]. LGO is at the core of many commercial global optimization packages [6]. Solver engines using LGO are available for C and Fortran compiler platforms, Excel, AIMMS, GAMS, MATLAB (through Tomlab), MPL, and Mathematica. Within GOT, LGO first performs a global search using either a branch and probability bound algorithm, an adaptive stochastic search, or a multistart stochastic search, which is the default option. Constraints are incorporated into a penalty term with a search algorithm that ensures that constraints are satisfied to high precision. After the global search, the solver attempts to refine the solution with a local search based on a generalized reduced-gradient algorithm (a standard technique for local nonlinear optimization) using the approximate solution from the global search as the initial point. If desired, the user can disable the global search phase so that only local search is performed. Recent versions of Maple include an alternative internal optimization package based on the NAG optimization library, which serves exclusively for local optimization. Global convergence of LGO is guaranteed theoretically under the assumption that the objective function and constraints are continuous when using the stochastic methods or Lipschitz continuous when using the branch and bound method [4]. Although optimization problems not satisfying these conditions can still be handled, the quality of the results may vary. For example, since LGO estimates Lipschitz constants numerically using function values only, with genuine black-box knowledge of the objective function, nondifferentiable functions can be handled. The local search phase uses gradient approximations, but does not use the penalty function. First- or higher order derivative information is not used by LGO. FEATURES Besides the well-written online help available under Maple, the main features of GOT are described in [7] through several small, but nontrivial numerical examples. It is immediately apparent that the core LGO solver is perfectly integrated within the Maple environment. In particular, the user can provide optimization model functions and constraints as high-level Maple algebraic, functional, or matrix expressions. See [7, sect. 5] for two illustrative examples of this interaction, namely, minimization of a Bessel function and spline curve fitting. Many other interesting examples are described in the colorful and didactical online example Maple worksheet [8]. Although the input to GOT can be symbolic, the underlying computation is numeric. Maple provides both hardware floating-point arithmetic and software floating-point arithmetic of arbitrary precision; however, GOT uses only hardware arithmetic. Nevertheless, the user can exploit Maple s ability to evaluate the model functions using higher precision arithmetic. 106 IEEE CONTROL SYSTEMS MAGAZINE» OCTOBER X/06/$ IEEE

2 PERFORMANCE The LGO solver was recently benchmarked by Arnold Neumaier s team within the COCONUT project funded by the European Union [9]. The recent survey [2] reports a dozen high-quality solvers for constrained global optimization, including LGO in its GAMS implementation. With the methodology and criteria chosen in [9], LGO is not among the best codes in terms of performance or reliability, although it is one of the few available codes that require only function values. According to Pintér, much better performance in these tests could have been achieved if the ratio between the global and local search efforts was chosen in proportion to the model size, as recommended in the LGO user manual. This automatic parameter tuning is available in both GAMS and GOT but not for the implementation in [9]. See also [10] for a performance evaluation of LGO on a test model set available in GAMS. It is claimed in [7] that, in its current implementations, LGO can handle problems with up to several thousand variables and constraints with corresponding running times on a standard desktop computer ranging from minutes to hours. Recall that the theoretical computational complexity of global optimization algorithms is non-polynomial. Moreover, at fixed dimension, some problem instances can be much more difficult numerically than others. It must also be emphasized that LGO finds only one global optimizer even when multiple optimizers are present. Bound constraints on optimization variables must be explicitly specified when using GOT. As recalled in [9], however, some global optimization packages do not require explicit bounds but rather use bound estimates, which are automatically calculated by the package based on the problem data. Thus, this distinction can be viewed as a limitation of GOT. On the other hand, citing [2, sect. 23], unbounded variables are perhaps the dominant reason for failure of current complete global optimization codes on problems with few variables. One can then argue whether it is reasonable or not to assume that a designer has an a priori good knowledge of bounds on all of the decision variables in a given optimization problem. EXAMPLES We now illustrate the main features of GOT on several nonconvex optimization problems arising in control. Robust Stability Example 1 Our first example is a classical robust stability margin computation problem for a linear system affected by interval uncertainty [11]. This example appears as Example in the optimization benchmark database compiled in [12] and is available for download at titan.princeton. edu/testproblems. The optimization problem reads as min Many difficult problems are global optimization problems. subject to k 10q 2 2 q q3 2 q q2 2 q q3 2 q q 2 q q 1q 2 q q 1q 2 2 q 3 + 1, 000q 2 q q 1 q , 000q2 2 q 3 + 8q 1 q q 1q 2 q 3 q q 1q q 1 q 2 200q 1 0, k q k, 4 2k q k, 6 3k q k, where the decision variables are the scalar parameters k, q 1, q 2, q 3. This problem can be solved with GOT by entering >with(globaloptimization): >GlobalSolve(k, {10*q2^2*q3^3 + 10*q2^3*q3^ *q2^2*q3^ *q2^3*q *q2*q3^3 + q1*q2*q3^2 + q1*q2^2*q *q2*q3^2 + 8*q1*q3^ *q2^2*q3 + 8*q1*q2^2 + 6*q1*q2*q3 - q1^2 + 60*q1*q3 + 60*q1*q2-200*q1 <= 0, -800*k - q1 <= -800, -800*k + q1 <= 800, -2*k - q2 <= -4, -2*k + q2 <= 4, -3*k - q3 <= -6, -3*k + q3 <= 6}, k = , q1 = , q2 = , q3 = ); The first input argument is the objective function to be minimized, the second input argument (the list placed between curly braces) collects the problem constraints, and the remaining input arguments are explicit bounds on the decision variables. Note that it is not possible to omit these bounds. Here we simply choose large intervals. By invoking GOT with these commands, we use the default multistart algorithm. Rounded here to five significant digits, GOT immediately returns the solution k = , q 1 = , q 2 = , and q 3 = , which is the global optimizer reported in [12]. For comparison, we use the Minimize command of the Maple Optimization Package using the same input arguments as above, which yields k = , q 1 = , q 2 = , and q 3 = In this case, a sequential quadratic programming algorithm is used, and a suboptimal solution is returned with k larger by a factor of about 3. This example illustrates the advantage of using GOT over a local optimization algorithm. OCTOBER 2006 «IEEE CONTROL SYSTEMS MAGAZINE 107

3 The Global Optimization Toolbox (GOT), first released in June 2004 with Maple 9.5, is part of the Maple Professional Toolbox series of add-on products that can be purchased separately. Robust Stability Example 2 Example in [12], see also [13], involves five parameters and has the form min subject to k q q 1 w + 16q 2 w + 16w q 1 q 2 78w = 0, 16q 1 w q 1 8q 2 q 3 24w = 0, k q k, k q k, k q k. For this problem, with bounds on all decision variables and its default multistart algorithm, GOT quickly returns the point k = , q 1 = , q 2 = , q 3 = , w = Although this point satisfies the constraints, it is not possible to know whether the solution is globally optimal over this range. This aspect is not specific to GOT, since few global optimization codes provide numerical certificates of global optimality; see [2,sect. 20]. With the additional argument method=branchandbound, the branch-and-bound algorithm of GOT yields the point k = , q 1 = , q 2 = , q 3 = , w = This point satisfies the constraints but yields a 33% larger objective function than the point returned by the multi-start algorithm. Although this solution might be locally optimal, GOT does not provide such information. Next, by refining the search bounds to for all five variables, the multistart algorithm of GOT returns k = , q 1 = , q 2 = , q 3 = , w = , which yields a 10% lower objective function value than the point obtained with larger search bounds. It turns out that this point is the global optimum reported in [12]. It can thus be seen that the solver performance depends on the tightness of the bounds on the decision variables. Fixed-Order Controller Design Next, we seek a fixed-order linear controller maximizing the closed-loop asymptotic decay rate of a linear system. Mathematically speaking, this problem involves spectral abscissa minimization. Given matrices A R n n, B R n m, and C R p n, the problem consists of finding a matrix K R m p that minimizes the spectral abscissa α(a + BKC) defined as the largest real part of the eigenvalues of matrix A + BKC. Note that the condition α(a + BKC) <0 is equivalent to closed-loop asymptotic stabilization. This optimization problem is difficult for at least two reasons. First, as in the two problems considered above, α(a + BKC) is a nonconvex function of K and thus may have multiple local minimizers and stationary points. Second, α(a + BKC) is continuous but, unlike the two problems considered above, is not necessarily differentiable in K [15]. In particular, α(a + BKC) is typically nondifferentiable at local minimizers. Note also that this problem is unconstrained, that is, we have no a priori knowledge of the magnitudes of the entries of a globally optimal matrix K. Moreover, we do not know whether the objective function is bounded below, that is, whether the global minimum α(a + BK C) is finite and attained. We consider a simple but nontrivial example, namely, asymptotic decay rate minimization for the standard twomass-spring benchmark [14] controlled with a secondorder linear controller. Normalized problem data for the closed-loop system are given by A = , B = , C = We note that, if the controller were chosen to be of the order three or four, then the spectral abscissa can be made arbitrarily negative. To apply GOT, we first construct a Maple procedure to compute the spectral abscissa α(a + BKC) given a matrix K. This procedure, which we call specabs, invokes the Eigenvalues function of the LinearAlgebra package, extracts the real parts, and sorts the eigenvalues. LGO is called from GOT with the main command GlobalSolve. In its simplest form for unconstrained optimization, GlobalSolve accepts two input arguments, 108 IEEE CONTROL SYSTEMS MAGAZINE» OCTOBER 2006

4 Control engineering is not among the many existing and potential application areas of the LGO solver implementations listed on the PCS Web site. namely, an objective function to be minimized and a list of lower and upper bounds for all variables. Since the decision variable K is unconstrained, we choose large bounds to begin. For example, we select as the search interval for all variables. As observed for the previous example, this choice may have a significant impact on the performance of LGO. First we run the built-in local search using method=reducedgradient as a third input argument to the command GlobalSolve. After 66 function evaluations, we obtain a spectral abscissa approximately equal to zero. As far as the underlying control problem is concerned, this solution is of a little interest since the resulting controller gain K is not stabilizing. Surprisingly, we obtain the same result using the branch-andbound global search, using method=branchandbound and 2136 function evaluations. With method=singlestart to implement the adaptive random search with a single starting point, GOT can stabilize the plant but convergence of the search is slow. We thus use a timelimit =60 option to stop the solver after 60 s of computation. The best achieved spectral abscissa is This value can be improved with method=multistart using adaptive random search with multiple starting points. After 60 s, the spectral abscissa is pushed further to with K 1 = Relaxing the maximum computation time to 5 min does not significantly improve the result over the same search region. Optimizing over tighter intervals around the estimate K 1 reduces the spectral abscissa to with K 2 = The corresponding closed-loop input step response is satisfactory, with a slight overshoot of 5%, a rise time (required for the step response to rise from 10% to 90% of its final value) of 3.4 s, and a settling time (required for the step response to decline and stay at 5% of its final value) of 9.4 s. Note, however, that we are still quite far from the best known (but not necessarily the globally optimal) spectral abscissa for this example, which, obtained using pole placement methods, is α = ( 15/5) , achieved with, for example, K = Local optimality of this point is proved in [15] using results from nonsmooth variational analysis. We believe that GOT is not able to decrease the spectral abscissa from down to precisely because, as shown in [15], the objective function is a nonsmooth function at local optimizers. Furthermore, in the vicinity of a local optimizer, first-order derivatives of the spectral abscissa are typically very large. Practically speaking, a tiny perturbation around the locally optimal matrix K results in a significant change on the value of α(a + BKC). In other words, the performance achieved by K is highly nonrobust. This feature is typical of an ill-posed optimization problem in control. Indeed, in a realistic control engineering problem, a decay rate constraint is only one of many closed-loop performance requirements in a typical multiobjective optimization setting, together with time-domain, H 2, or H constraints. In summary, on the one hand, GOT cannot find a globally optimal controller because the spectral abscissa function is sensitive around local optima. On the other hand, such a locally optimal controller is highly nonrobust and thus of limited use in practice. CONCLUSIONS Interestingly, control engineering is not among the many existing and potential application areas of the LGO solver implementations listed on the PCS Web site [6]. In fact, one might wonder why global optimization software is not more popular in the control community. Although control-related publications that use global optimization have appeared in the control and global optimization literature, see, for example, [16], [17], and references therein, no genuine computer-aided control system design tools based on global optimization codes have emerged. This situation is in sharp contrast with numerical linear algebra, which is at the core of many control packages (for example, Lyapunov or Riccati equation solvers for MATLAB or Scilab), or, to a lesser extent, convex semidefinite programming over linear matrix inequalities. OCTOBER 2006 «IEEE CONTROL SYSTEMS MAGAZINE 109

5 In summary, the Global Optimization Toolbox for Maple provides a widely applicable, fully integrated development environment that can support control engineering applications and help realize the significant potential that global optimization has as a valuable tool in control system design. ACKNOWLEDGMENTS This review benefited from many constructive comments by Vikram Kapila, Marcel Mongeau, Arnold Neumaier, and János Pintér. Thanks to David Linder of Maplesoft for the core code implementation of function specabs. GOT calculations for the fixed-order controller design problem were carried out by János Pintér. [16] V. Balakrishnan and S.P. Boyd, Global optimization in control system analysis and design, Contr. Dynam. Syst., vol. 53, [17] D. Henrion and J.B. Lasserre, Solving nonconvex optimization problems How GloptiPoly is applied to problems in robust and nonlinear control. IEEE Control Sys. Mag., vol. 24, no. 3, pp , Didier Henrion (henrion@laas.fr) is with LAAS-CNRS, Toulouse, France and the faculty of electrical engineering, Czech Technical University in Prague, Czech Republic. His research interests include numerical algorithms for polynomial matrices, convex optimization over linear matrix inequalities (LMI), robust multivariable control, and computer-aided control system design (CACSD). REFERENCES [1] A. Neumaier, Global optimization, [Online].Available: neum /glopt.html. [2] A. Neumaier, Complete search in continuous global optimization and constraint satisfaction, in Acta Numerica 2004, A. Iserles, Ed. Cambridge, UK: Cambridge Univ. Press, 2004, pp [3] T.C. Hales, A proof of the Kepler conjecture, Ann. Math., vol. 162, pp , [4] J.D. Pintér, Global Optimization in Action., Dordrecht, The Netherlands: Kluwer Academic, [5] J.D. Pintér, Global Optimization with Maple: An INtrocution with Illustrative Examples. Maplesoft, [6] Pintér Consulting Services, [Online]. Available: http// [7] J.D. Pintér, D. Linder, and P. Chin, Global Optimization Toolbox for Maple. An introduction with illustrative applications, Optimiza.Methods Software, vol. 21, no. 4, pp , [8] Maplesoft Worksheet, Applications of the Global Optimization Toolbox, Waterloo Maple Inc., Nov [Online]. Available: [9] A. Neumaier, O. Shcherbina, W. Huyer, and T. Vinkó, A comparison of complete global optimization solvers, Math. Program. B, vol. 103, pp , [10] J.D. Pintér, GAMS/LGO nonlinear solver suite: key features, usage and numerical performance, GAMS Development Corp., Washington, USA, Nov [Online]. [11] R.R.E. de Gaston and M.G. Safonov, Exact calculation of the multiloop stability margin, IEEE Trans. Automat. Control, vol. 33, no. 2. pp , [12] C.A. Floudas and P.M. Pardalos et al., Handbook of Test Problems for Local and Global Optimization. Dordrecht, The Netherlands: Kluwer Academic, [13] J. Ackermann, D. Kaesbauer, and R. Muench, Robust gamma-stability analysis in a plant parameter space, Automatica, vol. 27, no. 1, pp , [14] B. Wie and D.S. Bernstein, Benchmark problems for robust control design, AIAA J. Guidance, Contr. Dynam., vol. 15, no. 5, pp , [15] D. Henrion and M.L. Overton, Maximizing the closedloop asymptotic decay rate for the two-mass-spring control problem, preprint. Albert Einstein on a Bike (6 February 1933) Life is like riding a bicycle. To keep your balance you must keep moving. Albert Einstein (REPRODUCED COURTESY OF THE ARCHIVES, CALIFORNIA INSTITUTE OF TECHNOLOGY) 110 IEEE CONTROL SYSTEMS MAGAZINE» OCTOBER 2006

Optimization based robust control

Optimization based robust control Optimization based robust control Didier Henrion 1,2 Draft of March 27, 2014 Prepared for possible inclusion into The Encyclopedia of Systems and Control edited by John Baillieul and Tariq Samad and published

More information

Maximizing the Closed Loop Asymptotic Decay Rate for the Two-Mass-Spring Control Problem

Maximizing the Closed Loop Asymptotic Decay Rate for the Two-Mass-Spring Control Problem Maximizing the Closed Loop Asymptotic Decay Rate for the Two-Mass-Spring Control Problem Didier Henrion 1,2 Michael L. Overton 3 May 12, 2006 Abstract We consider the following problem: find a fixed-order

More information

Detecting global optimality and extracting solutions in GloptiPoly

Detecting global optimality and extracting solutions in GloptiPoly Detecting global optimality and extracting solutions in GloptiPoly Didier HENRION 1,2 Jean-Bernard LASSERRE 1 1 LAAS-CNRS Toulouse 2 ÚTIA-AVČR Prague Part 1 Description of GloptiPoly Brief description

More information

SPECTRA - a Maple library for solving linear matrix inequalities in exact arithmetic

SPECTRA - a Maple library for solving linear matrix inequalities in exact arithmetic SPECTRA - a Maple library for solving linear matrix inequalities in exact arithmetic Didier Henrion Simone Naldi Mohab Safey El Din Version 1.0 of November 5, 2016 Abstract This document briefly describes

More information

Didier HENRION henrion

Didier HENRION   henrion POLYNOMIAL METHODS FOR ROBUST CONTROL Didier HENRION www.laas.fr/ henrion henrion@laas.fr Laboratoire d Analyse et d Architecture des Systèmes Centre National de la Recherche Scientifique Université de

More information

Advice for Mathematically Rigorous Bounds on Optima of Linear Programs

Advice for Mathematically Rigorous Bounds on Optima of Linear Programs Advice for Mathematically Rigorous Bounds on Optima of Linear Programs Jared T. Guilbeau jtg7268@louisiana.edu Md. I. Hossain: mhh9786@louisiana.edu S. D. Karhbet: sdk6173@louisiana.edu R. B. Kearfott:

More information

Solving Global Optimization Problems by Interval Computation

Solving Global Optimization Problems by Interval Computation Solving Global Optimization Problems by Interval Computation Milan Hladík Department of Applied Mathematics, Faculty of Mathematics and Physics, Charles University in Prague, Czech Republic, http://kam.mff.cuni.cz/~hladik/

More information

Strong duality in Lasserre s hierarchy for polynomial optimization

Strong duality in Lasserre s hierarchy for polynomial optimization Strong duality in Lasserre s hierarchy for polynomial optimization arxiv:1405.7334v1 [math.oc] 28 May 2014 Cédric Josz 1,2, Didier Henrion 3,4,5 Draft of January 24, 2018 Abstract A polynomial optimization

More information

Riccati difference equations to non linear extended Kalman filter constraints

Riccati difference equations to non linear extended Kalman filter constraints International Journal of Scientific & Engineering Research Volume 3, Issue 12, December-2012 1 Riccati difference equations to non linear extended Kalman filter constraints Abstract Elizabeth.S 1 & Jothilakshmi.R

More information

CHAPTER 2: QUADRATIC PROGRAMMING

CHAPTER 2: QUADRATIC PROGRAMMING CHAPTER 2: QUADRATIC PROGRAMMING Overview Quadratic programming (QP) problems are characterized by objective functions that are quadratic in the design variables, and linear constraints. In this sense,

More information

Global Optimization by Interval Analysis

Global Optimization by Interval Analysis Global Optimization by Interval Analysis Milan Hladík Department of Applied Mathematics, Faculty of Mathematics and Physics, Charles University in Prague, Czech Republic, http://kam.mff.cuni.cz/~hladik/

More information

Control of linear systems subject to time-domain constraints with polynomial pole placement and LMIs

Control of linear systems subject to time-domain constraints with polynomial pole placement and LMIs Control of linear systems subject to time-domain constraints with polynomial pole placement and LMIs Didier Henrion 1,2,3,4 Sophie Tarbouriech 1 Vladimír Kučera 3,5 February 12, 2004 Abstract: The paper

More information

Positive Semidefiniteness and Positive Definiteness of a Linear Parametric Interval Matrix

Positive Semidefiniteness and Positive Definiteness of a Linear Parametric Interval Matrix Positive Semidefiniteness and Positive Definiteness of a Linear Parametric Interval Matrix Milan Hladík Charles University, Faculty of Mathematics and Physics, Department of Applied Mathematics, Malostranské

More information

H controller design on the COMPLIB problems with the Robust Control Toolbox for Matlab

H controller design on the COMPLIB problems with the Robust Control Toolbox for Matlab H controller design on the COMPLIB problems with the Robust Control Toolbox for Matlab Didier Henrion 1,2 Draft of August 30, 2005 1 Introduction The COMPLIB library is a freely available Matlab package

More information

Multiobjective Robust Control with HIFOO 2.0

Multiobjective Robust Control with HIFOO 2.0 Multiobjective Robust Control with HIFOO 2.0 Suat Gumussoy Didier Henrion Marc Millstone Michael L. Overton Katholieke Universiteit Leuven, Department of Computer Science, Belgium suat.gumussoy@cs.kuleuven.be

More information

Fixed Order H Controller for Quarter Car Active Suspension System

Fixed Order H Controller for Quarter Car Active Suspension System Fixed Order H Controller for Quarter Car Active Suspension System B. Erol, A. Delibaşı Abstract This paper presents an LMI based fixed-order controller design for quarter car active suspension system in

More information

Optimizing simultaneously over the numerator and denominator polynomials in the Youla-Kučera parametrization

Optimizing simultaneously over the numerator and denominator polynomials in the Youla-Kučera parametrization Optimizing simultaneously over the numerator and denominator polynomials in the Youla-Kučera parametrization Didier Henrion Vladimír Kučera Arturo Molina-Cristóbal Abstract Traditionally when approaching

More information

On parameter-dependent Lyapunov functions for robust stability of linear systems

On parameter-dependent Lyapunov functions for robust stability of linear systems On parameter-dependent Lyapunov functions for robust stability of linear systems Didier Henrion, Denis Arzelier, Dimitri Peaucelle, Jean-Bernard Lasserre Abstract For a linear system affected by real parametric

More information

GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi

GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi Didier Henrion,2, Jean-Bernard Lasserre henrion@laas.fr, lasserre@laas.fr www.laas.fr/ henrion, www.laas.fr/ lasserre Version 2.0

More information

Constrained global optimization. Arnold Neumaier University of Vienna Vienna, Austria

Constrained global optimization. Arnold Neumaier University of Vienna Vienna, Austria Constrained global optimization Arnold Neumaier University of Vienna Vienna, Austria In a constraint satisfaction problem (CSP), one asks about existence, and one or several examples: Can 13 balls of radius

More information

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics).

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics). 1 Introduction Read sections 1.1, 1.2.1 1.2.4, 1.2.6, 1.3.8, 1.3.9, 1.4. Review questions 1.1 1.6, 1.12 1.21, 1.37. The subject of Scientific Computing is to simulate the reality. Simulation is the representation

More information

Solving polynomial static output feedback problems with PENBMI

Solving polynomial static output feedback problems with PENBMI Solving polynomial static output feedback problems with PENBMI Didier Henrion, Johan Löfberg, Michal Kočvara, Michael Stingl Abstract An algebraic formulation is proposed for the static output feedback

More information

An approach to constrained global optimization based on exact penalty functions

An approach to constrained global optimization based on exact penalty functions DOI 10.1007/s10898-010-9582-0 An approach to constrained global optimization based on exact penalty functions G. Di Pillo S. Lucidi F. Rinaldi Received: 22 June 2010 / Accepted: 29 June 2010 Springer Science+Business

More information

M E M O R A N D U M. Faculty Senate approved November 1, 2018

M E M O R A N D U M. Faculty Senate approved November 1, 2018 M E M O R A N D U M Faculty Senate approved November 1, 2018 TO: FROM: Deans and Chairs Becky Bitter, Sr. Assistant Registrar DATE: October 23, 2018 SUBJECT: Minor Change Bulletin No. 5 The courses listed

More information

Fixed-Order Robust H Controller Design with Regional Pole Assignment

Fixed-Order Robust H Controller Design with Regional Pole Assignment SUBMITTED 1 Fixed-Order Robust H Controller Design with Regional Pole Assignment Fuwen Yang, Mahbub Gani, and Didier Henrion Abstract In this paper, the problem of designing fixed-order robust H controllers

More information

ROBUST CONSTRAINED REGULATORS FOR UNCERTAIN LINEAR SYSTEMS

ROBUST CONSTRAINED REGULATORS FOR UNCERTAIN LINEAR SYSTEMS ROBUST CONSTRAINED REGULATORS FOR UNCERTAIN LINEAR SYSTEMS Jean-Claude HENNET Eugênio B. CASTELAN Abstract The purpose of this paper is to combine several control requirements in the same regulator design

More information

Robust Anti-Windup Compensation for PID Controllers

Robust Anti-Windup Compensation for PID Controllers Robust Anti-Windup Compensation for PID Controllers ADDISON RIOS-BOLIVAR Universidad de Los Andes Av. Tulio Febres, Mérida 511 VENEZUELA FRANCKLIN RIVAS-ECHEVERRIA Universidad de Los Andes Av. Tulio Febres,

More information

A Generalized Uncertainty Principle and Sparse Representation in Pairs of Bases

A Generalized Uncertainty Principle and Sparse Representation in Pairs of Bases 2558 IEEE TRANSACTIONS ON INFORMATION THEORY, VOL 48, NO 9, SEPTEMBER 2002 A Generalized Uncertainty Principle Sparse Representation in Pairs of Bases Michael Elad Alfred M Bruckstein Abstract An elementary

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

Stability of linear time-varying systems through quadratically parameter-dependent Lyapunov functions

Stability of linear time-varying systems through quadratically parameter-dependent Lyapunov functions Stability of linear time-varying systems through quadratically parameter-dependent Lyapunov functions Vinícius F. Montagner Department of Telematics Pedro L. D. Peres School of Electrical and Computer

More information

Stochastic Optimization with Inequality Constraints Using Simultaneous Perturbations and Penalty Functions

Stochastic Optimization with Inequality Constraints Using Simultaneous Perturbations and Penalty Functions International Journal of Control Vol. 00, No. 00, January 2007, 1 10 Stochastic Optimization with Inequality Constraints Using Simultaneous Perturbations and Penalty Functions I-JENG WANG and JAMES C.

More information

Rank-one LMIs and Lyapunov's Inequality. Gjerrit Meinsma 4. Abstract. We describe a new proof of the well-known Lyapunov's matrix inequality about

Rank-one LMIs and Lyapunov's Inequality. Gjerrit Meinsma 4. Abstract. We describe a new proof of the well-known Lyapunov's matrix inequality about Rank-one LMIs and Lyapunov's Inequality Didier Henrion 1;; Gjerrit Meinsma Abstract We describe a new proof of the well-known Lyapunov's matrix inequality about the location of the eigenvalues of a matrix

More information

GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi

GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi GloptiPoly: Global Optimization over Polynomials with Matlab and SeDuMi Didier Henrion,, Jean-Bernard Lasserre henrion@laas.fr, lasserre@laas.fr www.laas.fr/ henrion, www.laas.fr/ lasserre Version of February,

More information

Bounding the parameters of linear systems with stability constraints

Bounding the parameters of linear systems with stability constraints 010 American Control Conference Marriott Waterfront, Baltimore, MD, USA June 30-July 0, 010 WeC17 Bounding the parameters of linear systems with stability constraints V Cerone, D Piga, D Regruto Abstract

More information

Strong stability of neutral equations with dependent delays

Strong stability of neutral equations with dependent delays Strong stability of neutral equations with dependent delays W Michiels, T Vyhlidal, P Zitek, H Nijmeijer D Henrion 1 Introduction We discuss stability properties of the linear neutral equation p 2 ẋt +

More information

Filter Design for Linear Time Delay Systems

Filter Design for Linear Time Delay Systems IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 49, NO. 11, NOVEMBER 2001 2839 ANewH Filter Design for Linear Time Delay Systems E. Fridman Uri Shaked, Fellow, IEEE Abstract A new delay-dependent filtering

More information

LMI Based Model Order Reduction Considering the Minimum Phase Characteristic of the System

LMI Based Model Order Reduction Considering the Minimum Phase Characteristic of the System LMI Based Model Order Reduction Considering the Minimum Phase Characteristic of the System Gholamreza Khademi, Haniyeh Mohammadi, and Maryam Dehghani School of Electrical and Computer Engineering Shiraz

More information

1760 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 51, NO. 11, NOVEMBER 2006

1760 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 51, NO. 11, NOVEMBER 2006 1760 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 51, NO. 11, NOVEMBER 2006 Stabilization via Nonsmooth, Nonconvex Optimization James V. Burke, Didier Henrion, Adrian S. Lewis, and Michael L. Overton Abstract

More information

Convergence rates of moment-sum-of-squares hierarchies for volume approximation of semialgebraic sets

Convergence rates of moment-sum-of-squares hierarchies for volume approximation of semialgebraic sets Convergence rates of moment-sum-of-squares hierarchies for volume approximation of semialgebraic sets Milan Korda 1, Didier Henrion,3,4 Draft of December 1, 016 Abstract Moment-sum-of-squares hierarchies

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

A Brief Introduction To. GRTensor. On MAPLE Platform. A write-up for the presentation delivered on the same topic as a part of the course PHYS 601

A Brief Introduction To. GRTensor. On MAPLE Platform. A write-up for the presentation delivered on the same topic as a part of the course PHYS 601 A Brief Introduction To GRTensor On MAPLE Platform A write-up for the presentation delivered on the same topic as a part of the course PHYS 601 March 2012 BY: ARSHDEEP SINGH BHATIA arshdeepsb@gmail.com

More information

Parameterized Linear Matrix Inequality Techniques in Fuzzy Control System Design

Parameterized Linear Matrix Inequality Techniques in Fuzzy Control System Design 324 IEEE TRANSACTIONS ON FUZZY SYSTEMS, VOL. 9, NO. 2, APRIL 2001 Parameterized Linear Matrix Inequality Techniques in Fuzzy Control System Design H. D. Tuan, P. Apkarian, T. Narikiyo, and Y. Yamamoto

More information

Linear State Feedback Controller Design

Linear State Feedback Controller Design Assignment For EE5101 - Linear Systems Sem I AY2010/2011 Linear State Feedback Controller Design Phang Swee King A0033585A Email: king@nus.edu.sg NGS/ECE Dept. Faculty of Engineering National University

More information

Research overview. Seminar September 4, Lehigh University Department of Industrial & Systems Engineering. Research overview.

Research overview. Seminar September 4, Lehigh University Department of Industrial & Systems Engineering. Research overview. Research overview Lehigh University Department of Industrial & Systems Engineering COR@L Seminar September 4, 2008 1 Duality without regularity condition Duality in non-exact arithmetic 2 interior point

More information

Global Optimality Conditions in Maximizing a Convex Quadratic Function under Convex Quadratic Constraints

Global Optimality Conditions in Maximizing a Convex Quadratic Function under Convex Quadratic Constraints Journal of Global Optimization 21: 445 455, 2001. 2001 Kluwer Academic Publishers. Printed in the Netherlands. 445 Global Optimality Conditions in Maximizing a Convex Quadratic Function under Convex Quadratic

More information

The Rationale for Second Level Adaptation

The Rationale for Second Level Adaptation The Rationale for Second Level Adaptation Kumpati S. Narendra, Yu Wang and Wei Chen Center for Systems Science, Yale University arxiv:1510.04989v1 [cs.sy] 16 Oct 2015 Abstract Recently, a new approach

More information

LMI optimization for fixed-order H controller design

LMI optimization for fixed-order H controller design LMI optimization for fixed-order H controller design Didier Henrion 1,2,3 February 13, 2003 Abstract A general H controller design technique is proposed for scalar linear systems, based on properties of

More information

State feedback gain scheduling for linear systems with time-varying parameters

State feedback gain scheduling for linear systems with time-varying parameters State feedback gain scheduling for linear systems with time-varying parameters Vinícius F. Montagner and Pedro L. D. Peres Abstract This paper addresses the problem of parameter dependent state feedback

More information

Lyapunov Stability of Linear Predictor Feedback for Distributed Input Delays

Lyapunov Stability of Linear Predictor Feedback for Distributed Input Delays IEEE TRANSACTIONS ON AUTOMATIC CONTROL VOL. 56 NO. 3 MARCH 2011 655 Lyapunov Stability of Linear Predictor Feedback for Distributed Input Delays Nikolaos Bekiaris-Liberis Miroslav Krstic In this case system

More information

Graph and Controller Design for Disturbance Attenuation in Consensus Networks

Graph and Controller Design for Disturbance Attenuation in Consensus Networks 203 3th International Conference on Control, Automation and Systems (ICCAS 203) Oct. 20-23, 203 in Kimdaejung Convention Center, Gwangju, Korea Graph and Controller Design for Disturbance Attenuation in

More information

arxiv: v1 [math.na] 28 Jun 2013

arxiv: v1 [math.na] 28 Jun 2013 A New Operator and Method for Solving Interval Linear Equations Milan Hladík July 1, 2013 arxiv:13066739v1 [mathna] 28 Jun 2013 Abstract We deal with interval linear systems of equations We present a new

More information

A Computational Comparison of Branch and Bound and. Outer Approximation Algorithms for 0-1 Mixed Integer. Brian Borchers. John E.

A Computational Comparison of Branch and Bound and. Outer Approximation Algorithms for 0-1 Mixed Integer. Brian Borchers. John E. A Computational Comparison of Branch and Bound and Outer Approximation Algorithms for 0-1 Mixed Integer Nonlinear Programs Brian Borchers Mathematics Department, New Mexico Tech, Socorro, NM 87801, U.S.A.

More information

Fixed-Order H Controller Design via HIFOO, a Specialized Nonsmooth Optimization Package

Fixed-Order H Controller Design via HIFOO, a Specialized Nonsmooth Optimization Package Fixed-Order H Controller Design via HIFOO, a Specialized Nonsmooth Optimization Package Suat Gumussoy Michael L. Overton Abstract We report on our experience with fixed-order H controller design using

More information

Fast Linear Iterations for Distributed Averaging 1

Fast Linear Iterations for Distributed Averaging 1 Fast Linear Iterations for Distributed Averaging 1 Lin Xiao Stephen Boyd Information Systems Laboratory, Stanford University Stanford, CA 943-91 lxiao@stanford.edu, boyd@stanford.edu Abstract We consider

More information

Global optimization on Stiefel manifolds some particular problem instances

Global optimization on Stiefel manifolds some particular problem instances 6 th International Conference on Applied Informatics Eger, Hungary, January 27 31, 2004. Global optimization on Stiefel manifolds some particular problem instances János Balogh Department of Computer Science,

More information

Robust Multi-Objective Control for Linear Systems

Robust Multi-Objective Control for Linear Systems Robust Multi-Objective Control for Linear Systems Elements of theory and ROMULOC toolbox Dimitri PEAUCELLE & Denis ARZELIER LAAS-CNRS, Toulouse, FRANCE Part of the OLOCEP project (includes GloptiPoly)

More information

CONTROL SYSTEMS, ROBOTICS AND AUTOMATION - Vol. VII - System Characteristics: Stability, Controllability, Observability - Jerzy Klamka

CONTROL SYSTEMS, ROBOTICS AND AUTOMATION - Vol. VII - System Characteristics: Stability, Controllability, Observability - Jerzy Klamka SYSTEM CHARACTERISTICS: STABILITY, CONTROLLABILITY, OBSERVABILITY Jerzy Klamka Institute of Automatic Control, Technical University, Gliwice, Poland Keywords: stability, controllability, observability,

More information

Verified Branch and Bound for Singular Linear and Nonlinear Programs An Epsilon-Inflation Process

Verified Branch and Bound for Singular Linear and Nonlinear Programs An Epsilon-Inflation Process Verified Branch and Bound for Singular Linear and Nonlinear Programs An Epsilon-Inflation Process Ralph Baker Kearfott and Julie Roy Received: date / Accepted: date Abstract Linear and nonlinear programs

More information

GLOBAL OPTIMIZATION WITH GAMS/BARON

GLOBAL OPTIMIZATION WITH GAMS/BARON GLOBAL OPTIMIZATION WITH GAMS/BARON Nick Sahinidis Chemical and Biomolecular Engineering University of Illinois at Urbana Mohit Tawarmalani Krannert School of Management Purdue University MIXED-INTEGER

More information

EXISTENCE VERIFICATION FOR SINGULAR ZEROS OF REAL NONLINEAR SYSTEMS

EXISTENCE VERIFICATION FOR SINGULAR ZEROS OF REAL NONLINEAR SYSTEMS EXISTENCE VERIFICATION FOR SINGULAR ZEROS OF REAL NONLINEAR SYSTEMS JIANWEI DIAN AND R BAKER KEARFOTT Abstract Traditional computational fixed point theorems, such as the Kantorovich theorem (made rigorous

More information

Linear Systems with Saturating Controls: An LMI Approach. subject to control saturation. No assumption is made concerning open-loop stability and no

Linear Systems with Saturating Controls: An LMI Approach. subject to control saturation. No assumption is made concerning open-loop stability and no Output Feedback Robust Stabilization of Uncertain Linear Systems with Saturating Controls: An LMI Approach Didier Henrion 1 Sophie Tarbouriech 1; Germain Garcia 1; Abstract : The problem of robust controller

More information

IN THIS PAPER, we consider a class of continuous-time recurrent

IN THIS PAPER, we consider a class of continuous-time recurrent IEEE TRANSACTIONS ON CIRCUITS AND SYSTEMS II: EXPRESS BRIEFS, VOL. 51, NO. 4, APRIL 2004 161 Global Output Convergence of a Class of Continuous-Time Recurrent Neural Networks With Time-Varying Thresholds

More information

Linear Matrix Inequalities in Robust Control. Venkataramanan (Ragu) Balakrishnan School of ECE, Purdue University MTNS 2002

Linear Matrix Inequalities in Robust Control. Venkataramanan (Ragu) Balakrishnan School of ECE, Purdue University MTNS 2002 Linear Matrix Inequalities in Robust Control Venkataramanan (Ragu) Balakrishnan School of ECE, Purdue University MTNS 2002 Objective A brief introduction to LMI techniques for Robust Control Emphasis on

More information

Auxiliary signal design for failure detection in uncertain systems

Auxiliary signal design for failure detection in uncertain systems Auxiliary signal design for failure detection in uncertain systems R. Nikoukhah, S. L. Campbell and F. Delebecque Abstract An auxiliary signal is an input signal that enhances the identifiability of a

More information

On a Polynomial Fractional Formulation for Independence Number of a Graph

On a Polynomial Fractional Formulation for Independence Number of a Graph On a Polynomial Fractional Formulation for Independence Number of a Graph Balabhaskar Balasundaram and Sergiy Butenko Department of Industrial Engineering, Texas A&M University, College Station, Texas

More information

Convex Optimization Approach to Dynamic Output Feedback Control for Delay Differential Systems of Neutral Type 1,2

Convex Optimization Approach to Dynamic Output Feedback Control for Delay Differential Systems of Neutral Type 1,2 journal of optimization theory and applications: Vol. 127 No. 2 pp. 411 423 November 2005 ( 2005) DOI: 10.1007/s10957-005-6552-7 Convex Optimization Approach to Dynamic Output Feedback Control for Delay

More information

LMI based Stability criteria for 2-D PSV system described by FM-2 Model

LMI based Stability criteria for 2-D PSV system described by FM-2 Model Vol-4 Issue-018 LMI based Stability criteria for -D PSV system described by FM- Model Prashant K Shah Department of Electronics Engineering SVNIT, pks@eced.svnit.ac.in Abstract Stability analysis is the

More information

Nonlinear Coordinate Transformations for Unconstrained Optimization I. Basic Transformations

Nonlinear Coordinate Transformations for Unconstrained Optimization I. Basic Transformations Nonlinear Coordinate Transformations for Unconstrained Optimization I. Basic Transformations TIBOR CSENDES Kalmár Laboratory, József Attila University, Szeged, Hungary and TAMÁS RAPCSÁK Computer and Automation

More information

Towards Global Design of Orthogonal Filter Banks and Wavelets

Towards Global Design of Orthogonal Filter Banks and Wavelets Towards Global Design of Orthogonal Filter Banks and Wavelets Jie Yan and Wu-Sheng Lu Department of Electrical and Computer Engineering University of Victoria Victoria, BC, Canada V8W 3P6 jyan@ece.uvic.ca,

More information

The model reduction algorithm proposed is based on an iterative two-step LMI scheme. The convergence of the algorithm is not analyzed but examples sho

The model reduction algorithm proposed is based on an iterative two-step LMI scheme. The convergence of the algorithm is not analyzed but examples sho Model Reduction from an H 1 /LMI perspective A. Helmersson Department of Electrical Engineering Linkoping University S-581 8 Linkoping, Sweden tel: +6 1 816 fax: +6 1 86 email: andersh@isy.liu.se September

More information

Variable-gain output feedback control

Variable-gain output feedback control 7. Variable-gain output feedback control 7.1. Introduction PUC-Rio - Certificação Digital Nº 611865/CA In designing control laws, the usual first step is to describe the plant at a given operating point

More information

Linear Matrix Inequalities in Control

Linear Matrix Inequalities in Control Linear Matrix Inequalities in Control Delft Center for Systems and Control (DCSC) Delft University of Technology The Netherlands Department of Electrical Engineering Eindhoven University of Technology

More information

Digital Control Engineering Analysis and Design

Digital Control Engineering Analysis and Design Digital Control Engineering Analysis and Design M. Sami Fadali Antonio Visioli AMSTERDAM BOSTON HEIDELBERG LONDON NEW YORK OXFORD PARIS SAN DIEGO SAN FRANCISCO SINGAPORE SYDNEY TOKYO Academic Press is

More information

WE CONSIDER linear systems subject to input saturation

WE CONSIDER linear systems subject to input saturation 440 IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL 48, NO 3, MARCH 2003 Composite Quadratic Lyapunov Functions for Constrained Control Systems Tingshu Hu, Senior Member, IEEE, Zongli Lin, Senior Member, IEEE

More information

Detecting global optimality and extracting solutions in GloptiPoly

Detecting global optimality and extracting solutions in GloptiPoly Detecting global optimality and extracting solutions in GloptiPoly Didier Henrion 1, Jean-Bernard Lasserre 1 September 5, 5 Abstract GloptiPoly is a Matlab/SeDuMi add-on to build and solve convex linear

More information

L 2 -induced Gains of Switched Systems and Classes of Switching Signals

L 2 -induced Gains of Switched Systems and Classes of Switching Signals L 2 -induced Gains of Switched Systems and Classes of Switching Signals Kenji Hirata and João P. Hespanha Abstract This paper addresses the L 2-induced gain analysis for switched linear systems. We exploit

More information

THIS paper deals with robust control in the setup associated

THIS paper deals with robust control in the setup associated IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL 50, NO 10, OCTOBER 2005 1501 Control-Oriented Model Validation and Errors Quantification in the `1 Setup V F Sokolov Abstract A priori information required for

More information

Numerical Methods I Solving Nonlinear Equations

Numerical Methods I Solving Nonlinear Equations Numerical Methods I Solving Nonlinear Equations Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 16th, 2014 A. Donev (Courant Institute)

More information

Polynomial Stabilization with Bounds on the Controller Coefficients

Polynomial Stabilization with Bounds on the Controller Coefficients Proceedings of the 8th IFAC Symposium on Robust Control Design, Bratislava, Slovak Republic, July 8-, 25 Polynomial Stabilization with Bounds on the Controller Coefficients Julia Eaton Sara Grundel Mert

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

Convex relaxations of chance constrained optimization problems

Convex relaxations of chance constrained optimization problems Convex relaxations of chance constrained optimization problems Shabbir Ahmed School of Industrial & Systems Engineering, Georgia Institute of Technology, 765 Ferst Drive, Atlanta, GA 30332. May 12, 2011

More information

Semidefinite representation of convex hulls of rational varieties

Semidefinite representation of convex hulls of rational varieties Semidefinite representation of convex hulls of rational varieties Didier Henrion 1,2 June 1, 2011 Abstract Using elementary duality properties of positive semidefinite moment matrices and polynomial sum-of-squares

More information

Linear-Quadratic Optimal Control: Full-State Feedback

Linear-Quadratic Optimal Control: Full-State Feedback Chapter 4 Linear-Quadratic Optimal Control: Full-State Feedback 1 Linear quadratic optimization is a basic method for designing controllers for linear (and often nonlinear) dynamical systems and is actually

More information

ROBUST ANALYSIS WITH LINEAR MATRIX INEQUALITIES AND POLYNOMIAL MATRICES. Didier HENRION henrion

ROBUST ANALYSIS WITH LINEAR MATRIX INEQUALITIES AND POLYNOMIAL MATRICES. Didier HENRION  henrion GRADUATE COURSE ON POLYNOMIAL METHODS FOR ROBUST CONTROL PART IV.1 ROBUST ANALYSIS WITH LINEAR MATRIX INEQUALITIES AND POLYNOMIAL MATRICES Didier HENRION www.laas.fr/ henrion henrion@laas.fr Airbus assembly

More information

Lecture 1: Introduction

Lecture 1: Introduction EE 227A: Convex Optimization and Applications January 17 Lecture 1: Introduction Lecturer: Anh Pham Reading assignment: Chapter 1 of BV 1. Course outline and organization Course web page: http://www.eecs.berkeley.edu/~elghaoui/teaching/ee227a/

More information

Control for stability and Positivity of 2-D linear discrete-time systems

Control for stability and Positivity of 2-D linear discrete-time systems Manuscript received Nov. 2, 27; revised Dec. 2, 27 Control for stability and Positivity of 2-D linear discrete-time systems MOHAMMED ALFIDI and ABDELAZIZ HMAMED LESSI, Département de Physique Faculté des

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

Learning Computer-Assisted Map Analysis

Learning Computer-Assisted Map Analysis Learning Computer-Assisted Map Analysis by Joseph K. Berry* Old-fashioned math and statistics can go a long way toward helping us understand GIS Note: This paper was first published as part of a three-part

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

1 Number Systems and Errors 1

1 Number Systems and Errors 1 Contents 1 Number Systems and Errors 1 1.1 Introduction................................ 1 1.2 Number Representation and Base of Numbers............. 1 1.2.1 Normalized Floating-point Representation...........

More information

IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 53, NO. 9, OCTOBER

IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL. 53, NO. 9, OCTOBER IEEE TRANSACTIONS ON AUTOMATIC CONTROL, VOL 53, NO 9, OCTOBER 2008 2033 Mixed Deterministic/Randomized Methods for Fixed Order Controller Design Yasumasa Fujisaki, Member, IEEE, Yasuaki Oishi, Member,

More information

CONTROL SYSTEMS, ROBOTICS AND AUTOMATION Vol. VIII Controller Design Using Polynomial Matrix Description - Didier Henrion, Michael Šebek

CONTROL SYSTEMS, ROBOTICS AND AUTOMATION Vol. VIII Controller Design Using Polynomial Matrix Description - Didier Henrion, Michael Šebek CONTROLLER DESIGN USING POLYNOMIAL MATRIX DESCRIPTION Didier Henrion Laboratoire d Analyse et d Architecture des Systèmes, Centre National de la Recherche Scientifique, Toulouse, France. Michael Šebe Center

More information

min f(x). (2.1) Objectives consisting of a smooth convex term plus a nonconvex regularization term;

min f(x). (2.1) Objectives consisting of a smooth convex term plus a nonconvex regularization term; Chapter 2 Gradient Methods The gradient method forms the foundation of all of the schemes studied in this book. We will provide several complementary perspectives on this algorithm that highlight the many

More information

OQNLP: a Scatter Search Multistart Approach for Solving Constrained Non- Linear Global Optimization Problems

OQNLP: a Scatter Search Multistart Approach for Solving Constrained Non- Linear Global Optimization Problems OQNLP: a Scatter Search Multistart Approach for Solving Constrained Non- Linear Global Optimization Problems Zsolt Ugray, The University of California at Riverside, MIS Dept. Leon Lasdon, The University

More information

State estimation of uncertain multiple model with unknown inputs

State estimation of uncertain multiple model with unknown inputs State estimation of uncertain multiple model with unknown inputs Abdelkader Akhenak, Mohammed Chadli, Didier Maquin and José Ragot Centre de Recherche en Automatique de Nancy, CNRS UMR 79 Institut National

More information

Reduced-order output feedback control design with specsdp, a code for linear / nonlinear SDP problems

Reduced-order output feedback control design with specsdp, a code for linear / nonlinear SDP problems Reduced-order output feedback control design with specsdp, a code for linear / nonlinear SDP problems J.B. Thevenet and P. Apkarian and D. Noll ONERA-CERT, Control System department, 2 Av. Edouard Belin,

More information

[k,g,gfin] = hinfsyn(p,nmeas,ncon,gmin,gmax,tol)

[k,g,gfin] = hinfsyn(p,nmeas,ncon,gmin,gmax,tol) 8 H Controller Synthesis: hinfsyn The command syntax is k,g,gfin = hinfsyn(p,nmeas,ncon,gmin,gmax,tol) associated with the general feedback diagram below. e y P d u e G = F L (P, K) d K hinfsyn calculates

More information

ESC794: Special Topics: Model Predictive Control

ESC794: Special Topics: Model Predictive Control ESC794: Special Topics: Model Predictive Control Discrete-Time Systems Hanz Richter, Professor Mechanical Engineering Department Cleveland State University Discrete-Time vs. Sampled-Data Systems A continuous-time

More information

Switched systems: stability

Switched systems: stability Switched systems: stability OUTLINE Switched Systems Stability of Switched Systems OUTLINE Switched Systems Stability of Switched Systems a family of systems SWITCHED SYSTEMS SWITCHED SYSTEMS a family

More information

While using the input and output data fu(t)g and fy(t)g, by the methods in system identification, we can get a black-box model like (In the case where

While using the input and output data fu(t)g and fy(t)g, by the methods in system identification, we can get a black-box model like (In the case where ESTIMATE PHYSICAL PARAMETERS BY BLACK-BOX MODELING Liang-Liang Xie Λ;1 and Lennart Ljung ΛΛ Λ Institute of Systems Science, Chinese Academy of Sciences, 100080, Beijing, China ΛΛ Department of Electrical

More information