Balancing Skew-Hamiltonian/Hamiltonian Pencils with Applications in Control Engineering

Total Page:16

File Type:pdf, Size:1020Kb

Balancing Skew-Hamiltonian/Hamiltonian Pencils with Applications in Control Engineering Balancing Skew-Hamiltonian/Hamiltonian Pencils With Applications in Control Engineering Vasile Sima National Institute for Research & Development in Informatics, 8–10 Bd. Mares¸al Averescu, Bucharest, Romania Keywords: Deflating Subspaces, Generalized Eigenvalues, Numerical Methods, Skew-Hamiltonian/Hamiltonian Matrix Pencil, Software, Structure-preservation. Abstract: Badly-scaled matrix pencils could reduce the reliability and accuracy of computed results for many numeri- cal problems, including computation of eigenvalues and deflating subspaces, which are needed in many key procedures for optimal and H∞ control, model reduction, spectral factorization, and so on. Standard balancing techniques can improve the results in many cases, but there are situations when the solution of the scaled problem is much worse than that for the unscaled problem. This paper presents a new structure-preserving balancing technique for skew-Hamiltonian/Hamiltonian matrix pencils, and illustrates its good performance in solving eigenvalue problems and algebraic Riccati equations for large sets of examples from well-known benchmark collections with difficult examples. 1 INTRODUCTION Jiang and Voigt, 2013), and the references therein. Quite often, the pencil matrices have large norms Computing eigenvalues and bases of certain associ- and elements with highly different magnitude. Such ated invariant or deflating subspaces of matrices or pencils imply potential numerical difficulties for matrix pencils is central to various numerical tech- software implementations of eigensolvers, with niques in control engineering and other domains. negative consequences on the reliability and accuracy When the corresponding eigenproblems have special of the results, see, e.g., (Sima and Benner, 2015a). structure, implying structural properties of their spec- Balancing procedures can be used to improve the tra, it is important to use structure-preserving and/or numerical behavior. Ward (1981) proposed a bal- structure-exploiting algorithms. General numerical ancing technique for general matrix pencils, which algorithms cannot ensure that the theoretical prop- has been incorporated in state-of-the-art software erties are preserved during computations (Paige and packages, such as LAPACK (Anderson et al., 1999). Van Loan, 1981; Van Loan, 1984; Kressner, 2005). (This will be referred below as standard balancing.) Common special structures are Hamiltonian and sym- The data matrices are preprocessed by equivalence plectic matrices or matrix pencils, which are encoun- transformations, in two optional stages: the first tered in optimal or H∞ control (e.g., solution of alge- stage uses permutations to find isolated eigenvalues braic Riccati equations, or evaluation of the H∞- and (which are available by inspection, with no rounding L∞-norms of linear dynamic systems), spectral factor- errors), and the second stage uses diagonal scaling ization, model reduction, etc., see, for instance, (Bru- transformations to make the row and corresponding insma and Steinbuch, 1990; Laub, 1979; Mehrmann, column 1-norms as close as possible. Balancing 1991; Sima, 1996). While structured matrices are en- may reduce the 1-norm of the scaled matrices, but countered for standard linear dynamic systems, gen- there is no guarantee in general. This is the reason eralized and descriptor systems may involve struc- why full balancing is either avoided or provided as tured matrix pencils. Often such pencils can be re- an option in the LAPACK subroutines; some expert cast as skew-Hamiltonian/Hamiltonian pencils, for driver routines, such as DGEES, DGEESX, DGGES, which dedicated algorithms have been developed, see DGGESX, and DGGEV use permutations only, while e.g., (Benner et al., 2007; Benner et al., 2002; Ben- other drivers, e.g., DGEEVX and DGGEVX, have an ner et al., 2005; Benner et al., 2012a; Benner et al., input argument allowing either permutations, scaling, 2012b; Benner et al., 2013a; Benner et al., 2013b; both permutations and scaling, or no balancing at all. 177 Sima, V. Balancing Skew-Hamiltonian/Hamiltonian Pencils - With Applications in Control Engineering. DOI: 10.5220/0005981201770184 In Proceedings of the 13th International Conference on Informatics in Control, Automation and Robotics (ICINCO 2016) - Volume 1, pages 177-184 ISBN: 978-989-758-198-4 Copyright c 2016 by SCITEPRESS – Science and Technology Publications, Lda. All rights reserved ICINCO 2016 - 13th International Conference on Informatics in Control, Automation and Robotics Note that U is related to a basis, U, of the stable right zero imaginary parts, but possibly nonzero real parts. deflating subspace of the original pencil, αS βH ,by The implementation takes care of the compact storage 1 1 − T T the transformatione U = bl diag(R− ,L− )U, hence scheme when computing P DP,..., P WP. T T T U1 U2 := U = bl diag(R,L)U. Therefore, Consider a structured pencil, (S,H ), and assume the stabilizing solutione of the original ARE can be that S = I2n. The order of magnitude of the dif- computed as follows e ferences in size of the nonzero elements in the H 1 1 1 matrix can be huge. For instance, for the CM6 X = U2U − = LU2U − R− . (13) 1 1 and CM6 IS examples from the COMPleib collec- Formula (13) allows to represent and use the solution tion (Leibfritz and Lipinski, 2003), the maximum X in a factored form, whiche maye be useful for nu- and minimum absolute values of the nonzero en- 5 324 merical reasons. If balancing also involves symplec- tries are about 2.53 10 and 4.9407 10− , hence tic permutations of the form (5) only, then the right their ratio is not representable· in the· usual double 1 1 T precision representation, and it is evaluated as Inf hand side in (13) becomes PLU2U1− R− P , where P denotes here the product of the ℓ 1 permutations (∞). The standard balancing algorithm implemented − performed. Such factorization, is,e however,e not possi- in the LAPACK Library subroutine DGGBAL (for ma- ble if J -permutations are also needed, in which case trix pencils) returns scaling factors covering a very it is necessary to apply the balancing transformations large range of magnitudes, namely with maximum 159 47 before solving the set of linear systems giving X. and minimum values 10 and 10− , respectively, If S is a general matrix, the order of S and H is for both left and right scaling factors. No eigenvalue 2(n+ p), where n is the dimension of the state vector, can be isolated. The scaling transformation matrices, e 206 and p may be chosen as p = m/2 (i.e., p = m/2, if L and R , have condition numbers with values 10 . m is even, and p = (m + 1)/2,⌈ otherwise),⌉ with m the The 1-norms of scaled matrices, H and S, are about number of system inputs. In this case, the computa- 10228 and 10184, respectively, while the 1-norms of tions are similar, but U and U , i = 1,2, refer to the the original H and S are 6.9123e105 ande 1. Com- i i · lines 1 : n and n + p + 1:2n + p of the matrix bases puting the eigenvalues or deflating subspaces using U and U, respectively.e the balanced matrices would return results very far from the true ones. CM6 and CM6 IS are not the only e examples in the COMPleib collection which produce numerical troubles for eigenproblem-related compu- 3 IMPLEMENTATION ISSUES tations. The CM5 and CM5 IS examples have also a huge ratio, 10279, between the magnitudes of their The developed balancing algorithm operates only on elements. Other very large ratios are 10141, for CM4 the matrices A, D, E, C, V, and W, and preserves and CM4 IS, 1072, for CM3 and CM3 IS, or 1037, for the pencil structure. Moreover, the pairs of skew- CM2 and CM2 IS. Hermitian matrices, D and E, and Hermitian matri- ces, V and W , are stored compactly in two n (n+1) The proposed algorithm uses an adaptation of arrays, DE and VW. Specifically, the lower triangle× of the basic LAPACK procedure for finding the scaling E and the upper triangle of D are concatenated along factors, but optionally limits the range of their their main diagonals, and similarly for W and V : variation, possibly via an outer loop. Specifically, the user can set a threshold value, τ; if τ 0, DEi j = ei j, j = 1 : n, i j, ≥ ≥ the entries whose absolute values are smaller than DEi, j+1 = di j, j = 1 : n, i j, τM0, where M0 = max( H (s,s) 1, S(s,s) 1), with ≤ s := ℓ : n n + ℓ : 2n,k are consideredk k negligible,k VWi j = wi j, j = 1 : n, i j, ≥ and do not∪ count for computing the scaling factors. VWi, j+1 = vi j, j = 1 : n, i j. (14) ≤ (For the CM6 and CM6 IS examples, ℓ = 1, and 20 This way, the storage requirements are reduced by setting τ = 10− , all entries with magnitude less 2 15 4n 2n memory locations, in comparison with the than about 7 10− will be taken as zero by the general− algorithm in (Anderson et al., 1999), which procedure.) If·τ < 0 on entry, an outer loop over a set 2 needs 8n storage space for S and H . Note that in of values τi > 0 will enable to select a set of scaling the real case, the diagonal elements of D and E, dii factors which, if possible, ensure the reduction of a and eii, i = 1 : n, which should be zero, by definition, desired norm-related measure for the scaled matri- are not stored and not used. However, in the complex ces. For τ = 1, this measure is the minimum of − case, dii and eii, i = 1 : n, should have zero real parts, maxi( Hi(s,s) 1/ Si(s,s) 1, Si(s,s) 1/ Hi(s,s) 1) k k k k k k k k while the imaginary parts might be nonzero; more- where Hi(s,s) and Si(s,s) are the scaled submatrices over, the diagonal elements of V and W should have corresponding to the threshold τi.
Recommended publications
  • 1 Introduction
    Real and Complex Hamiltonian Square Ro ots of SkewHamiltonian Matrices y z HeikeFab ender D Steven Mackey Niloufer Mackey x Hongguo Xu January DedicatedtoProfessor Ludwig Elsner on the occasion of his th birthday Abstract We present a constructive existence pro of that every real skewHamiltonian matrix W has a real Hamiltonian square ro ot The key step in this construction shows how one may bring anysuch W into a real quasiJordan canonical form via symplectic similarityWe show further that every W has innitely many real Hamiltonian square ro ots and givealower b ound on the dimension of the set of all such square ro ots Extensions to complex matrices are also presented This report is an updated version of the paper Hamiltonian squareroots of skew Hamiltonian matrices that appearedinLinear Algebra its Applicationsv pp AMS sub ject classication A A A F B Intro duction Any matrix X suchthatX A is said to b e a square ro ot of the matrix AF or general nn complex matrices A C there exists a welldevelop ed although somewhat complicated theory of matrix square ro ots and a numb er of algorithms for their eective computation Similarly for the theory and computation of real square ro ots for real matrices By contrast structured squareroot problems where b oth the matrix A Fachb ereich Mathematik und Informatik Zentrum fur Technomathematik Universitat Bremen D Bremen FRG email heikemathunibremende y Department of Mathematics Computer Science Kalamazo o College Academy Street Kalamazo o MI USA z Department of Mathematics
    [Show full text]
  • Eigenvalue Perturbation Theory of Structured Real Matrices and Their Sign Characteristics Under Generic Structured Rank-One Perturbations∗
    Eigenvalue perturbation theory of structured real matrices and their sign characteristics under generic structured rank-one perturbations∗ Christian Mehlx Volker Mehrmannx Andr´eC. M. Ran{ Leiba Rodmank July 9, 2014 Abstract An eigenvalue perturbation theory under rank-one perturbations is developed for classes of real matrices that are symmetric with respect to a non-degenerate bilinear form, or Hamiltonian with respect to a non-degenerate skew-symmetric form. In contrast to the case of complex matrices, the sign characteristic is a cru- cial feature of matrices in these classes. The behavior of the sign characteristic under generic rank-one perturbations is analyzed in each of these two classes of matrices. Partial results are presented, but some questions remain open. Appli- cations include boundedness and robust boundedness for solutions of structured systems of linear differential equations with respect to general perturbations as well as with respect to structured rank perturbations of the coefficients. Key Words: real J-Hamiltonian matrices, real H-symmetric matrices, indefinite inner product, perturbation analysis, generic perturbation, rank-one perturbation, T - even matrix polynomial, symmetric matrix polynomial, bounded solution of differential equations, robustly bounded solution of differential equations, invariant Lagrangian subspaces. Mathematics Subject Classification: 15A63, 15A21, 15A54, 15B57. xInstitut f¨urMathematik, TU Berlin, Straße des 17. Juni 136, D-10623 Berlin, Germany. Email: fmehl,[email protected]. {Afdeling Wiskunde, Faculteit der Exacte Wetenschappen, Vrije Universiteit Amsterdam, De Boele- laan 1081a, 1081 HV Amsterdam, The Netherlands and Unit for BMI, North West University, Potchef- stroom, South Africa. E-mail: [email protected] kCollege of William and Mary, Department of Mathematics, P.O.Box 8795, Williamsburg, VA 23187-8795, USA.
    [Show full text]
  • Hamiltonian Matrix Representations for the Determination of Approximate Wave Functions for Molecular Resonances
    Journal of Applied and Fundamental Sciences HAMILTONIAN MATRIX REPRESENTATIONS FOR THE DETERMINATION OF APPROXIMATE WAVE FUNCTIONS FOR MOLECULAR RESONANCES Robert J. Buenker Fachbereich C-Mathematik und Naturwissenschaften, Bergische Universität Wuppertal, Gaussstr. 20, D-42097 Wuppertal, Germany *For correspondence. ([email protected]) Abstract: Wave functions obtained using a standard complex Hamiltonian matrix diagonalization procedure are square integrable and therefore constitute only approximations to the corresponding resonance solutions of the Schrödinger equation. The nature of this approximation is investigated by means of explicit calculations using the above method which employ accurate diabatic potentials of the B 1Σ+ - D’ 1Σ+ vibronic resonance states of the CO molecule. It is shown that expanding the basis of complex harmonic oscillator functions gradually improves the description of the exact resonance wave functions out to ever larger internuclear distances before they take on their unwanted bound-state characteristics. The justification of the above matrix method has been based on a theorem that states that the eigenvalues of a complex-scaled Hamiltonian H (ReiΘ) are associated with the energy position and linewidth of resonance states (R is an internuclear coordinate and Θ is a real number). It is well known, however, that the results of the approximate method can be obtained directly using the unscaled Hamiltonian H (R) in real coordinates provided a particular rule is followed for the evaluation of the corresponding matrix elements. It is shown that the latter rule can itself be justified by carrying out the complex diagonalization of the Hamiltonian in real space via a product of two transformation matrices, one of which is unitary and the other is complex orthogonal, in which case only the symmetric scalar product is actually used in the evaluation of all matrix elements.
    [Show full text]
  • Hamiltonian Matrices and the Algebraic Riccati Equation Seminar Presentation
    Hamiltonian Matrices and the Algebraic Riccati Equation Seminar presentation by Piyapong Yuantong 7th December 2009 Technische Universit¨atChemnitz Piyapong Yuantong Hamiltonian Matrices and the Algebraic Riccati Equation 1 Hamiltonian matrices We start by introducing the square matrix J 2 R 2n×2n defined by " # O I J = n n ; (1) −In On where n×n On 2 R − zero matrix n×n In 2 R − identity matrix: Remark It is not very complicated to prove the following properties of the matrix J: i. J T = −J ii. J −1 = J T T iii. J J = I2n T T iv. J J = −I2n 2 v. J = −I2n vi. det J = 1 Definition 1 A matrix A 2 R 2n×2n is called Hamiltonian if JA is symmetric, so JA = (JA) T ) A T J + JA = 0 where J 2 R 2n×2n is from (1). We will denote { } Hn = A 2 R 2n×2n j A T J + JA = 0 the set of 2n × 2n Hamiltonian matrices. 1 Piyapong Yuantong Hamiltonian Matrices and the Algebraic Riccati Equation Proposition 1.1 The following are equivalent: a) A is a Hamiltionian matrix b) A = JS, where S = S T c) (JA) T = JA Proof a ! b A = JJ −1 A ! A = J(−J)A 2Hn A ! (J(−JA)) T J + JA = 0 ! (−JA) T J T J = −JA T J J=!I2n (−JA) T = −JA ! J(−JA) T = A If − JA = S ! A = J(−JA) = J(−JA) T ! A = JS = JS T =) S = S T a ! c A T J + JA = 0 ! A T J = −JA ()T ! (A T J) T = (−JA) T ! J T A = −(JA) T ! −JA = −(JA) T ! (JA) T = JA 2 Piyapong Yuantong Hamiltonian Matrices and the Algebraic Riccati Equation Proposition 1.2 Let A; B 2 Hn.
    [Show full text]
  • Mathematical Physics-14-Eigenvalue Problems.Nb
    Eigenvalue problems Main idea and formulation in the linear algebra The word "eigenvalue" stems from the German word "Eigenwert" that can be translated into English as "Its own value" or "Inherent value". This is a value of a parameter in the equation or system of equations for which this equation has a nontriv- ial (nonzero) solution. Mathematically, the simplest formulation of the eigenvalue problem is in the linear algebra. For a given square matrix A one has to find such values of l, for which the equation (actually the system of linear equations) A.X λX (1) has a nontrivial solution for a vector (column) X. Moving the right part to the left, one obtains the equation A − λI .X 0, H L where I is the identity matrix having all diagonal elements one and nondiagonal elements zero. This matrix equation has nontrivial solutions only if its determinant is zero, Det A − λI 0. @ D This is equivalent to a Nth order algebraic equation for l, where N is the rank of the mathrix A. Thus there are N different eigenvalues ln (that can be complex), for which one can find the corresponding eigenvectors Xn. Eigenvectors are defined up to an arbitrary numerical factor, so that usually they are normalized by requiring T∗ Xn .Xn 1, where X T* is the row transposed and complex conjugate to the column X. It can be proven that eigenvectors that belong to different eigenvalues are orthogonal, so that, more generally than above, one has T∗ Xm .Xn δmn . Here dmn is the Kronecker symbol, 1, m n δ = mn µ 0, m ≠ n.
    [Show full text]
  • MAT TRIAD 2019 Book of Abstracts
    MAT TRIAD 2019 International Conference on Matrix Analysis and its Applications Book of Abstracts September 8 13, 2019 Liblice, Czech Republic MAT TRIAD 2019 is organized and supported by MAT TRIAD 2019 Edited by Jan Bok, Computer Science Institute of Charles University, Prague David Hartman, Institute of Computer Science, Czech Academy of Sciences, Prague Milan Hladík, Department of Applied Mathematics, Charles University, Prague Miroslav Rozloºník, Institute of Mathematics, Czech Academy of Sciences, Prague Published as IUUK-ITI Series 2019-676ø by Institute for Theoretical Computer Science, Faculty of Mathematics and Physics, Charles University Malostranské nám. 25, 118 00 Prague 1, Czech Republic Published by MATFYZPRESS, Publishing House of the Faculty of Mathematics and Physics, Charles University in Prague Sokolovská 83, 186 75 Prague 8, Czech Republic Cover art c J. Na£eradský, J. Ne²et°il c Jan Bok, David Hartman, Milan Hladík, Miroslav Rozloºník (eds.) c MATFYZPRESS, Publishing House of the Faculty of Mathematics and Physics, Charles University, Prague, Czech Republic, 2019 i Preface This volume contains the Book of abstracts of the 8th International Conference on Matrix Anal- ysis and its Applications, MAT TRIAD 2019. The MATTRIAD conferences represent a platform for researchers in a variety of aspects of matrix analysis and its interdisciplinary applications to meet and share interests and ideas. The conference topics include matrix and operator theory and computation, spectral problems, applications of linear algebra in statistics, statistical models, matrices and graphs as well as combinatorial matrix theory and others. The goal of this event is to encourage further growth of matrix analysis research including its possible extension to other elds and domains.
    [Show full text]
  • Matrix G-Strands
    Technological University Dublin ARROW@TU Dublin Articles School of Mathematics 2014 Matrix G-strands Darryl Holm Imperial College London Rossen Ivanov Technological University Dublin, [email protected] Follow this and additional works at: https://arrow.tudublin.ie/scschmatart Part of the Mathematics Commons, Non-linear Dynamics Commons, and the Partial Differential Equations Commons Recommended Citation Holm, D. and Ivanov, R. Matrix G-Strands, Nonlinearity 27 (2014) 1445–1469; doi:10.1088/0951-7715/27/ 6/1445 This Article is brought to you for free and open access by the School of Mathematics at ARROW@TU Dublin. It has been accepted for inclusion in Articles by an authorized administrator of ARROW@TU Dublin. For more information, please contact [email protected], [email protected]. This work is licensed under a Creative Commons Attribution-Noncommercial-Share Alike 4.0 License Funder: ERC Matrix G-Strands Darryl D. Holm1 and Rossen I. Ivanov2 9 Feb 2014, clean copy Abstract We discuss three examples in which one may extend integrable Euler–Poincar´e ODEs to integrable Euler–Poincar´ePDEs in the matrix G-Strand context. After de- scribing matrix G-Strand examples for SO(3) and SO(4) we turn our attention to SE(3) where the matrix G-Strand equations recover the exact rod theory in the con- vective representation. We then find a zero curvature representation (ZCR) of these equations and establish the conditions under which they are completely integrable. Thus, the G-Strand equations turn out to be a rich source of integrable systems. The treatment is meant to be expository and most concepts are explained in examples in the language of vectors in R3.
    [Show full text]
  • A Unified Approach to Linear and Nonlinear Normal Forms For
    View metadata, citation and similar papers at core.ac.uk brought to you by CORE provided by Elsevier - Publisher Connector J. Symbolic Computation (1999) 27, 49–131 Article No. jsco.1998.0244 Available online at http://www.idealibrary.com on A Unied Approach to Linear and Nonlinear Normal Forms for Hamiltonian Systems† R. C. CHURCHILL‡‡§AND MARTIN KUMMER§ ‡Department of Mathematics, Hunter College and Graduate Center, CUNY, 695 Park Avenue, NY 10021, U.S.A. § Department of Mathematics, University of Toldeo, Toledo, OH 43606, U.S.A. We prove that in all but one case the normal form of a real or complex Hamiltonian matrix which is irreducible and appropriately normalized can be computed by Lie series methods in formally the same manner as one computes the normal form of a nonlinear Hamiltonian function. Calculations are emphasized; the methods are illustrated with detailed examples, and for the sake of completeness the exceptional case is also reviewed and illustrated. Alternate methods are also discussed, along with detailed examples. c 1999 Academic Press 1. Introduction A linear operator T : V → V on a real nite-dimensional symplectic space V =(V,ω)is Hamiltonian,orinnitesimally symplectic,if ω(Tu,v)+ω(u, T v)=0,u,v∈ V. (1.1) The linear Hamiltonian normal form problem is that of nding simple matrix represen- tations for such operators relative to symplectic bases of V . The theoretical solution was provided by Williamson (1936) (also see Wall (1963)), but calculation of normal forms following his ideas proves dicult in practice. Simplications have since appeared, but the methods are still quite involved, (see, e.g.
    [Show full text]
  • Matrix Nearness Problems and Applications∗
    Matrix Nearness Problems and Applications∗ Nicholas J. Higham† Abstract A matrix nearness problem consists of finding, for an arbitrary matrix A, a nearest member of some given class of matrices, where distance is measured in a matrix norm. A survey of nearness problems is given, with particular emphasis on the fundamental properties of symmetry, positive definiteness, orthogonality, normality, rank-deficiency and instability. Theoretical results and computational methods are described. Applications of nearness problems in areas including control theory, numerical analysis and statistics are outlined. Key words. matrix nearness problem, matrix approximation, symmetry, positive definiteness, orthogonality, normality, rank-deficiency, instability. AMS subject classifications. Primary 65F30, 15A57. 1 Introduction Consider the distance function (1.1) d(A) = min E : A + E S has property P ,A S, k k ∈ ∈ where S denotes Cm×n or Rm×n, is a matrix norm on S, and P is a matrix property k · k which defines a subspace or compact subset of S (so that d(A) is well-defined). Associated with (1.1) are the following tasks, which we describe collectively as a matrix nearness problem: Determine an explicit formula for d(A), or a useful characterisation. • ∗This is a reprint of the paper: N. J. Higham. Matrix nearness problems and applications. In M. J. C. Gover and S. Barnett, editors, Applications of Matrix Theory, pages 1–27. Oxford University Press, 1989. †Department of Mathematics, University of Manchester, Manchester, M13 9PL, England ([email protected]). 1 Determine X = A + E , where E is a matrix for which the minimum in (1.1) • min min is attained.
    [Show full text]
  • H = Hamiltonian Matrix S = Overlap Matrix
    chmy564-19 Lec 8 3. Linear Variation Method Boot Camp Mon 28jan19 Hij = Hamiltonian matrix Sij = Overlap matrix Linear Variation with 2 orthonormal, real, basis functions Ψ = c1 Φ1 + c2 Φ2 (H11 − E) c1 + H12 c2 = 0 H21c2 + (H22 − E) c2 = 0 where H12 = <Φ1|H|Φ2>, the "interaction" of the two basis functions, H11 = <Φ1|H|Φ1>, the "energy" of Φ1, H22 = <Φ2|H|Φ2>, the "energy" of Φ2, and E = <Ψ|H|Ψ>. the expectation value of the energy using the trial function. For a non-trivial solution (c1 and c2 not both zero), the determinant of the matrix of numbers multiplying the coefficients c1 and c2 must vanish, i.e., (H11 −E) (H22 − E) − H21 H12 = 0 quadratic equation; Solve for E 2 E – E(H11 + H22) +(H11H22 − H21 H12)= 0 quadratic 2 2 −±b b −4 ac ()()4(HH11+± 22 HH11 +− 22 HHHH11 22 − 21 12 E± = = 22a 2 H11+H22 H11−H22 2 E± = ± +H Because H12 is real 2 2 12 H H α1 β H= 11 12 = β α H21 H22 2 2 (αα+− )( αα ) 2 E =±+12 12 β 22 Solving for Ψ = c1 Φ1 + c2 Φ2 means solving for c1 and c2 (H11 – E)c1 + (H12)c2 = 0 (α1 – E)c1 + βc2 = 0 (H21)c1 + (H22 – E)c2 = 0 = βc1 + (α2 – E)c2 = 0 The determinant from the N simultaneous homogeneous equations = 0 is a constraint that means that you can only solve for the ratio of the coefficients. 5 (α1 – E)c1 + βc2 = 0 The determinant from the N simultaneous homogeneous equations = 0 is a constraint that βc1 + (α2 – E)c2 = 0 means that you can only solve for the ratio of the coefficients.
    [Show full text]
  • Arxiv:2011.08087V2 [Math-Ph] 30 Mar 2021 [36, 6] of a Haar Measure Unitary
    THE GENERALIZED CARTAN DECOMPOSITION FOR CLASSICAL RANDOM MATRIX ENSEMBLES ALAN EDELMAN AND SUNGWOO JEONG Abstract. We present a completed classification of the classical random ma- trix ensembles: Hermite (Gaussian), Laguerre (Wishart), Jacobi (MANOVA) and Circular by introducing the concept of the generalized Cartan decompo- sition and the double coset space. Previous authors [8, 40] associate a symmetric space G=K with a random matrix density on the double coset structure KnG=K. However this is incom- plete. Complete coverage requires the double coset structure A = K1nG=K2, where G=K1 and G=K2 are two symmetric spaces. Furthermore, we show how the matrix factorization obtained by the generalized Cartan decomposition G = K1AK2 plays a crucial role in sampling algorithms and the derivation of the joint probability density of A. 1. Introduction In pioneering work by Zirnbauer [40] and Due~nez[8] connections are made be- tween random matrix ensembles and the symmetric spaces [19, 21] studied in dif- ferential geometry, representation theory, and harmonic analysis. Unfortunately, symmetric spaces alone do not account for a rich enough set of Jacobi ensemble densities (See Figure 1). This work fills this significant gap. Noting that more general tools are needed, we not only take a closer look at the KAK decomposition from the theory of symmetric spaces, but we propose the incorporation of the more recent generalized Cartan decomposition (or the K1AK2 decomposition) [15, 24, 14, 30] especially for complete coverage of the Jacobi ensembles. We show that double coset spaces are rich enough to cover these important matrix ensembles. Furthermore, the key object is not the joint density, per se, but the matrix factorization.
    [Show full text]
  • Technische Universit at Chemnitz
    Technische Universitat Chemnitz Sonderforschungsbereich Numerische Simulation auf massiv parallelen Rechnern Peter Benner Ralph Byers Volker Mehrmann Hongguo Xu Numerical Computation of Deating Subspaces of Embedded Hamiltonian Pencils Preprint SFB PreprintReihe des Chemnitzer SFB SFB June Contents Introduction and Preliminaries Embedding of Extended Matrix Pencils Hamiltonian Triangular Forms SkewHamiltonianHamiltonian Matrix Pencils Algorithms Error and Perturbation Analysis Conclusion A Algorithmic Details A Schur Forms for SkewHamiltonianHamiltonian Matrix Pencils and SkewHa miltonianskewHamiltonian Matrix Pencils A Subroutines Required by Algorithm Authors Peter Benner Ralph Byers Zentrum f ur Technomathematik Department of Mathematics Fachbereich Mathematik und Informatik University of Kansas Universitat Bremen Lawrence KS D Bremen FRG USA bennermathunibremende byersmathukansedu Volker Mehrmann Hongguo Xu Deparment of Mathematics Fakultat f ur Mathematik Case Western University Technische Universitat Chemnitz Cleveland OH D Chemnitz FRG USA mehrmannmathematiktuchemnitzde hxxpocwruedu Numerical Computation of Deating Subspaces of Embedded Hamiltonian Pencils 2 3 Peter Benner Ralph Byers Volker Mehrmann Hongguo Xu Abstract We discuss the numerical solution of structured generalized eigenvalue problems that arise from linearquadratic optimal control problems H optimization multibo dy sys 1 tems and many other areas of applied mathematics physics and chemistry The classical
    [Show full text]