SLICOT Working Note

Size: px
Start display at page:

Download "SLICOT Working Note"

Transcription

1 SLICOT Working Note 3-3 MB4BV A FORTRAN 77 Subroutine to Compute the Eigenvectors Associated to the Purely Imaginary Eigenvalues of Skew-Hamiltonian/Hamiltonian Matrix Pencils Peihong Jiang Matthias Voigt 3 September 3 This document presents research results obtained during the development of the SLICOT Subroutine Library in Systems and Control Theory) software. The SLICOT Library and the related CACSD tools based on SLICOT were partially developed within the Numerics in Control Network NICONET) funded by the European Community BRITE-EURAM III RTD Thematic Networks Programme contract number BRRT-CT97-54), see SLICOT can be used free of charge by academic users, see for solving analysis and synthesis problems of modern and robust control. This report is available from University of Rochester, New York, USA; pjiang3@u.rochester.edu 3 Max Planck Institute for Dynamics of Complex Technical Systems, 396 Magdeburg, Germany; voigtm@mpi-magdeburg.mpg.de

2 Abstract We implement a structure-preserving numerical algorithm for extracting the eigenvectors associated to the purely imaginary eigenvalues of skew-hamiltonian/hamiltonian matrix pencils. We compare the new algorithm with the QZ algorithm using random examples with dierent diculty. The results show that the new algorithm is signicantly faster, more robust, and more accurate, especially for hard examples. Keywords: Eigenvalues, eigenvectors, skew-hamiltonian/hamiltonian matrix pencil, reliability, structure-preserving algorithm.

3 Introduction Skew-Hamiltonian/Hamiltonian matrix pencils have a wide range of applications in systems and control theory, for instance in linear-quadratic optimal control 7, H optimal control 9, for computing system norms, or analyzing system properties, such as passivity or contractivity 9, 8,, or a counterclockwise input/output dynamics 6, 6. In these applications, dierent spectral information is needed, such as eigenvalues, eigenvectors, and deating subspaces. The results presented in this paper are motivated by the following problem. In electrical engineering it is common to model electrical circuits by dierential-algebraic equations or descriptor systems. Electrical circuits have many important properties, for instance they cannot internally generate energy which is called passivity. This property should also be reected in the equations that model the circuit. However, due to errors introduced in the modeling process, e.g., by linearization, model approximation, or model order reduction, the resulting model is not always passive. In this case we need to perform a post-processing of the equations in order to restore the passivity property which is important to obtain meaningful results when simulating this model. This process is called passivity enforcement and is typically done by perturbing the system or parts of it, 4, 5. Passivity can be characterized by the purely imaginary eigenvalues of an associated skew-hamiltonian/hamiltonian matrix pencil. Passivity is then enforced by perturbing this pencil which results in a movement of the purely imaginary eigenvalues. This process is iteratively repeated until no purely imaginary eigenvalues exist. To compute optimal perturbations not only the eigenvalues have to be computed but also the corresponding eigenvectors, see, e.g.,, 4, 5. This report focuses on the actual computation of these eigenvectors. Standard numerical methods to compute eigenvalues, eigenvectors and deating subspaces rely on the generalized Schur decomposition 7. However, this factorization does not respect the structure of the pencil. Therefore, one is interested in a skew-hamiltonian/hamiltonian Schur-like form. Unfortunately, when purely imaginary eigenvalues exist, diculties arise because of the possible non-existence of such a structured Schur form. To avoid this problem, the pencil is embedded into a skew-hamiltonian/hamiltonian pencil of double size. A structure-preserving algorithm for computing the purely imaginary eigenvalues in a very accurate and reliable manner is presented in. An algorithm for the computation of the corresponding eigenvectors based on the structured canonical forms given in, is stated in 5. This paper describes the FORTRAN 77 routine MB4BV that has been implemented to extract the eigenvectors corresponding to the simple, nite, purely imaginary eigenvalues. We give a brief overview of the theoretical foundations, the algorithm outline, details of the implementation, and present numerical results obtained by MB4BV. Theory In this report we deal with the following matrix structures. Denition. Let J := I n, where In is the n n identity matrix. I n i) A matrix H R n n is Hamiltonian if HJ ) T = HJ. ii) A matrix N R n n is skew-hamiltonian if N J ) T = N J. iii) A real matrix pencil λn H is skew-hamiltonian/hamiltonian if N is skew-hamiltonian and H is Hamiltonian. Skew-Hamiltonian/Hamiltonian pencils satisfy the Hamiltonian spectral symmetry, i.e., eigenvalues occur in pairs {λ, λ} if they are purely real or imaginary, or otherwise in quadruples { λ, λ, λ, λ },

4 Figure : Hamiltonian eigensymmetry see Figure. Numerical algorithms should preserve this structure in order to get meaningful results. To compute the eigenvalues of a skew-hamiltonian/hamiltonian matrix pencil, we use the fact that J -congruence transformations of the form λñ H := J Q T J T λn H)Q with a nonsingular matrix Q preserve the skew-hamiltonian/hamiltonian structure. Therefore, we hope that we can compute an orthogonal matrix Q such that J Q T J T N N λn H)Q = λ H H N T H T is in skew-hamiltonian/hamiltonian Schur form, i.e., the subpencil λn H is in generalized Schur form. Unfortunately, not every skew-hamiltonian/hamiltonian pencil has this form, since pairs of simple purely imaginary eigenvalues cannot be represented in this structure. In this case, we embed the matrix pencil into another double-sized matrix pencil to solve the problem as follows. We introduce the orthogonal matrices Y = In I n, P = I n I n Then we dene the double-sized matrix pencils and λb N B H := λ I n I n I n, I n N H, N H λ B N B H := X T λb N B H ) X. X = YP. The 4n 4n matrix pencil λ B N B H is again real skew-hamiltonian/hamiltonian with the same eigenvalues with double algebraic, geometric, and partial multiplicities) as the original pencil. To compute the eigenvalues one uses the generalized symplectic URV decomposition which is summarized in the following theorem see the real-case versions of the results in ).

5 Theorem. Let λn H be a regular real n n skew-hamiltonian/hamiltonian pencil. Then there exist real orthogonal n n matrices Q, Q such that Q T N J Q J T N N = N T, J Q T J T M M N Q = M T := M, ) Q T H H HQ = H T, where N, M, and H are upper triangular, H is upper quasi-triangular, N and M are skewsymmetric and the generalized matrix product N H M H is in real periodic Schur form 7. Then, by using the matrix decomposition from ) we can compute an orthogonal matrix Q such that λ ˆB N ˆB H : = J Q T J T λ B N B ) H Q N N = λ M M N T M T H H H H H T H T ), with Q = P T J Q J T Q P. Note, that we never explicitly construct the embedded pencils. It is sucient to compute the necessary parts of the matrices in ). The spectrum of λn H is given by ΛN, H) = ±i Λ N H M H ), which can be determined by evaluating the entries on the and diagonal blocks of the matrices only. In particular, the simple, nite, purely imaginary eigenvalues correspond to the diagonal blocks of this matrix product. Provided that the pairwise distance of the simple, nite, purely imaginary eigenvalues is suciently large, they can be computed in a robust way without any error in the real part. However, if a purely imaginary eigenvalue has an algebraic multiplicity larger than one or if two purely imaginary eigenvalues are close, they might still be perturbed o the imaginary axis. This depends on the sign-characteristic of the involved eigenvalues, similarly as in 8. Therefore, for the rest of the paper we assume for simplicity that all nite, purely imaginary eigenvalues are simple. To compute the eigenvectors corresponding to the nite, purely imaginary eigenvalues we will make use of the structure of λ ˆB N ˆB H. As in passivity enforcement we only need the positive imaginary eigenvalues, i.e., those with positive imaginary parts, we restrict ourselves to the computation of the eigenvectors corresponding to these eigenvalues. To derive an algorithm for computing the desired eigenvectors we make use of the following two lemmas. In the following we assume that the matrix pencil λ N M H H is regular which is also equivalent to the regularity of the pencils λ N M H H and λ ˆBN ˆB H in ). Lemma 3. The vector v v is a right eigenvector of the matrix pencil λ N M H H corresponding to the eigenvalue ω if and only if iv v is a right eigenvector of the matrix pencil λ N M H H corresponding to the eigenvalue iω. Proof. Let v v be a right eigenvector of λ N M H H we have ω N v = H v, ω M v = H v. corresponding to the eigenvalue ω. Then 3

6 This is equivalent to iω N iv ) = H v, iω M v = H iv ). In other words, iv v is a right eigenvector of the matrix pencil λ N M H H corresponding to the eigenvalue iω. The converse statement can be proven in a completely analogous manner. Lemma 4. The vector v is a right eigenvector of the matrix pencil λ N M H H to the eigenvalue λ if and only if the vector v is a right eigenvector of the skew-hamiltonian/hamiltonian matrix pencil λ ˆB N ˆB H in ) corresponding to the eigenvalue λ. Proof. Trivial. As an intermediate step, we compute a matrix X whose columns contain the eigenvectors to the positive real eigenvalues of the pencil λ N M H H. This is done by the following basic steps already summarized in 5. Step : Reorder the positive real eigenvalues of the generalized matrix product P := N the top, i.e., compute orthogonal matrices U i = U ) i U ), i =,..., 4, such that i N ) N ) H ) H ) U T N U = U T 4 M U 3 = N ) M ) M ) M ), U T H U 3 =, U T 4 H U = H ) H ) H ) H ), H M H to are still in upper quasi-)triangular form, but the eigenvalues of the generalized matrix product ) ) P ) := N ) ) H M ) ) H are the positive real ones of P 3. N Step : Reorder the eigenvalues λ ) H ) by computing orthogonal matrices V M ) H ) = V ) V ), V = V ) V ) such that ) V T N ) λ H ) M ) R R H ) V = λ S S, R S where ΛR, S ) R + and ΛR, S ) R. Step 3: Compute the eigenvectors of λr S, i.e., compute a matrix W such that S W = R W D, where D is an appropriate diagonal matrix composed of the eigenvalues of λr S. Step 4: Collect the information contained in the relevant columns of the transformation matrices to obtain X ) U ) X := X ) := U ) V ) W. 3 Now, using Lemma 3 it turns out that ix ) X := X ) 4

7 contains the eigenvectors corresponding to the positive imaginary eigenvalues of the pencil λ N M. Then, by employing Lemma 4, the columns of the matrix X contain eigenvectors to the H H positive imaginary eigenvalues of the pencil λ ˆB N ˆB H. Note that all eigenvalues of this pencil have double algebraic, geometric, and partial multiplicities. So the matrix X contains only half of the eigenvectors to each positive imaginary eigenvalue of λ ˆB N ˆB H. However, this is no problem, since by later turning over to the original pencil λn H, we do not need the other half of the eigenvectors. Now, the corresponding eigenvectors to the positive imaginary eigenvalues of the double-sized matrix pencil λb N B H are given by iq ) X ) + Q ) X ) Y X Y := = X Q = iq ) X ) + Q ) X ) Y iq ) X ) + Q ) X ), iq ) X ) + Q ) X ) where Q := Q ) Q ) Q ) Q ) with Q ij) R n n and Q := Q ) Q ) Q ) Q ) with Q ij) R n n. In the equation above, only Y contains the desired eigenvectors of the matrix pencil λn H and Y has not to be computed explicitly. More specically, we can express Y as Y := iq ) X ) + Q ) X ) iq ) X ) + Q ) X ) Within the next sections we will focus on the implementation of the SLICOT routine MB4BV that enables us to compute Y.. 3 Specication SUBROUTINE MB4BV N, N, LDN, M, LDM, H, LDH, H, LDH, $ Q, LDQ, Q, LDQ, NEIG, ALPHAI, BETA, EVEC, $ LDEVEC, DWORK, LDWORK, BWORK, INFO ) C C.. Scalar Arguments.. INTEGER INFO, LDEVEC, LDH, LDH, LDM, LDN, $ LDQ, LDQ, LDWORK, N, NEIG C C.. Array Arguments.. LOGICAL BWORK * ) DOUBLE PRECISION ALPHAI * ), BETA * ), DWORK * ), $ H LDH, * ), H LDH, * ), $ M LDM, * ), N LDN, * ), Q LDQ, * ), $ Q LDQ, * ) COMPLEX*6 EVEC LDEVEC, * ) 4 Argument List 4. Input/Output Parameters N - input) INTEGER 5

8 The order of the matrix pencil. N has to be greater than or equal to. N also must be even. N - input) DOUBLE PRECISION array, dimension LDN, N/) On entry, the leading N/-by-N/ part of this array must contain the upper triangular matrix N in ). LDN - INTEGER The leading dimension of the array N. max {, N/}. The parameter LDN has to be greater or equal than M - input) DOUBLE PRECISION array, dimension LDM, N/) On entry, the leading N/-by-N/ part of this array must contain the upper triangular matrix M in ). LDM - INTEGER The leading dimension of the array M. max {, N/}. The parameter LDM has to be greater or equal than H - input) DOUBLE PRECISION array, dimension LDH, N/) On entry, the leading N/-by-N/ part of this array must contain the upper triangular matrix H in ). LDH - INTEGER The leading dimension of the array H. The parameter LDH has to be greater or equal than max {, N/}. H - input) DOUBLE PRECISION array, dimension LDH, N/) On entry, the leading N/-by-N/ part of this array must contain the upper quasi-triangular matrix H in ). LDH - INTEGER The leading dimension of the array H. The parameter LDH has to be greater or equal than max {, N/}. Q - input) DOUBLE PRECISION array, dimension LDQ, N) On entry, the leading N-by-N part of this array must contain the orthogonal transformation matrix Q in ). LDQ - INTEGER The leading dimension of the array Q. max {, N}. The parameter LDQ has to be greater or equal than Q - input) DOUBLE PRECISION array, dimension LDQ, N) On entry, the leading N-by-N part of this array must contain the orthogonal transformation matrix Q in ). LDQ - INTEGER The leading dimension of the array Q. The parameter LDQ has to be greater or equal than 6

9 max {, N}. NEIG - output) INTEGER The number of simple, nite, positive imaginary eigenvalues. ALPHAI - output) DOUBLE PRECISION array, dimension N/), BETA - output) DOUBLE PRECISION array, dimension N/) On exit, the ratio i ALPHAIj)/BETAj), j =,..., NEIG, represents the simple, nite, positive imaginary eigenvalues of the matrix pencil. EVEC - output) COMPLEX*6 array, dimension LDEVEC, N/) On exit, the leading N-by-NEIG part of this array contains the eigenvectors corresponding to the eigenvalues represented by the arrays ALPHAI and BETA in the same order. LDEVEC - INTEGER The leading dimension of the array EVEC. The parameter LDEVEC has to be greater or equal than max {, N}. 4. Workspace DWORK - DOUBLE PRECISION array, dimension LDWORK) On exit, if INFO =, DWORK) returns the optimal LDWORK. On exit, if INFO =, DWORK) returns the minimum value of LDWORK. LDWORK - INTEGER The dimension of the array DWORK. LDWORK 6N/) + max { 3N + 9N + 6, 7 }. For good performance LDWORK should be generally larger. If LDWORK =, then a workspace query is assumed; the routine only calculates the optimal size of the DWORK array, returns this value as the rst entry of the DWORK array, and no error message related to LDWORK is issued by XERBLA. BWORK - LOGICAL array, dimensionn/) 4.3 Error Indicator INFO - INTEGER INFO = : Successful exit; INFO < : If INFO = i, the i-th argument had an illegal value; INFO = : The eigenvalue reordering in MB3KD failed; INFO = : The triangularization or reordering in DGGES failed; INFO = 3: The eigenvector computation in DGGEV failed. 7

10 5 Numerical Experiments 5. Setup of Test Examples In order to test the performance of MB4BV, we feed it with random examples which have purely imaginary eigenvalues. We randomly generate matrices E, A R n n, B R n m, C R m n, D R m m, and dene the transfer function Gs) = CsE A) B + D. Let λn H = λ E E T A B C D γi m A T C T γi m B T D T. 3) Under some assumptions, the matrix pencil λn H is guaranteed to have purely imaginary eigenvalues if min ω R σ max Giω)) < γ < G L, where σ max ) denotes the largest singular value and L is the L -norm 9. Theoretically, when the distance between γ and G L decreases, the diculty of the example will increase, in the sense that the eigenvalues will be increasingly sensitive to perturbations, as the numerical results will later demonstrate. This is due to the fact, that there are two purely imaginary eigenvalues which almost form a non-trivial Jordan block in the Weierstraÿ canonical form. Then, the transformation matrices will be ill-conditioned, which leads to a higher sensitivity of these eigenvalues. 5. Environment and Conguration The tests have been performed on a generic-pae Ubuntu machine with Intel R Core TM Duo CPU with 3.GHz and 4GB RAM. The algorithms have been implemented and tested in MATLAB Ra). A FORTRAN MEX-le as an interface between MATLAB and MB4BV has also been written for testing purposes and improving the user-friendliness. Using MATLAB, one can easily generate random examples, compute the L -norm of the descriptor system, determine the eigenvalues by the structure-preserving solver MB4BD see 3, 4 for implementation details) and the corresponding MEX-le skewhamileig, and prole the performance. The MATLAB interface for MB4BV is given by alpha, beta, evecs = shh_evecs N, M, H, H, Q, Q ). Here, N, M, H, H, Q, and Q are the matrices N, M, H, H, Q, and Q in ), respectively. The purely imaginary eigenvalues are given by i αi β i, and the corresponding eigenvectors are stored in the columns of evecs in the same order as the eigenvalues. In this section we also compare our structure-preserving approach with the standard one for general eigenvalue problems, namely the QZ algorithm with eigenvalue reordering). In order to have a fair comparison of the performance of both methods, we also implemented a FORTRAN 77 subroutine which combines the QZ algorithm with reordering the purely imaginary eigenvalues to the top by using the LAPACK subroutines DGGES and DGGEV. For testing, a corresponding MEX-le has been written. 5.3 Numerical Results 5.3. Performance Comparison In this paragraph we will discuss the behavior of the new approach compared to the QZ algorithm. We do this by constructing random pencils of the form 3) with n = and m = 5. Table shows the performance results of both algorithms when computing both desired eigenvalues and eigenvectors for 8

11 Table : Performance comparison new algorithm QZ algorithm γ runtime avg. rel. residual runtime avg. rel. residual failure rate G ) L e e-3.% G ) L e e-3.% G ) L e e-.8% G ) L e e- 4.6% G ) L e e- 8.9% G ) L e e- 78.7% dierent values of γ, from the easier examples to the harder ones. Each row contains the results for a thousand test runs. The accuracy of the results is measured by computing the average of the relative residuals given by λ i N H) v i / v i. The runtime is given in seconds, using the tic and toc commands in MATLAB. Furthermore, for the QZ algorithm we have an additional column that indicates the percentage of examples that could not be solved. This is due to the fact that eigenvalues might be perturbed o the imaginary axis and will not be considered as purely imaginary when the distance to the imaginary axis exceeds a certain threshold. For our tests this value is set to e-. First of all, Table shows that the QZ algorithm needs about 5% more time to execute than the new algorithm. However, the most important aspect of the new algorithm is the improved reliability. We can see that the failure rate of the QZ algorithm is dramatically increasing when the examples become more ill-conditioned. By failure we mean that the algorithm extracts a dierent number of eigenvectors, compared to the actual number of purely imaginary eigenvalues. Moreover, even in the cases where the QZ algorithm successfully extracts the eigenvectors, the average relative residual becomes signicantly larger when the condition gets worse. On the other hand, the performance of the new algorithm is far more reliable and accurate. Its runtime and accuracy remain at the same level from the easy examples to the harder ones On the Failure of the QZ Algorithm We now briey describe the nature of QZ algorithm's failure by examining a small example. Consider the randomly generated 6 6 skew-hamiltonian/hamiltonian matrix pencil λn H = λ , with γ = G L 6 ). The spectrum is given by Λ = {97.5i, 97.5i,.6,.6,, }. In the spectrum, only the purely imaginary eigenvalue 97.5i is interesting to us. The new algorithm successfully extracts one eigenvector with relative residual.8594e-5. 9

12 However, the QZ algorithm fails to extract the eigenvector. Since it does not respect the structure of the pencil, all purely imaginary eigenvalues will be perturbed o the imaginary axis. When we are selecting the purely imaginary eigenvalues, we cannot expect that the real part of an eigenvalue is exactly zero, as it is for the structure-preserving algorithm. Alternatively, what we do is to ask if the real part is smaller than some tolerance. This tolerance is empirically set to e-. This is a rather tight bound, but it illustrates the behavior of the QZ algorithm quite well. However the real part of this eigenvalue after perturbation is.479e-. Because the real part is slightly larger than the tolerance, this eigenvalue is not selected and thus no eigenvector is extracted. 6 Conclusions In this report we have presented a FORTRAN 77 implementation of a new algorithm for computing the eigenvectors of a skew-hamiltonian/hamiltonian matrix pencil associated to the purely imaginary eigenvalues. The performed numerical tests clearly indicate that compared to the QZ algorithm the new method. is more robust, especially for ill-conditioned examples;. is comparably accurate for well-conditioned examples, and signicantly more accurate for ill-conditioned examples; 3. needs only about /3 of time to execute. Acknowledgment The main part of this work was done while the rst author visited the second author as an intern in summer. The nancial support from the RISE program of the Deutscher Akademischer Austauschdienst is gratefully acknowledged. References P. Benner, R. Byers, V. Mehrmann, and H. Xu. Numerical computation of deating subspaces of skew-hamiltonian/hamiltonian pencils. SIAM J. Matrix Anal. Appl., 4):659,. P. Benner, V. Sima, and M. Voigt. L -norm computation for continuous-time descriptor systems using structured matrix pencils. IEEE Trans. Automat. Control, 57):3338, January. 3 P. Benner, V. Sima, and M. Voigt. FORTRAN 77 subroutines for the solution of skew- Hamiltonian/Hamiltonian eigenproblems Part I: Algorithms and applications. SLICOT Working Note 3-, August 3. 4 P. Benner, V. Sima, and M. Voigt. FORTRAN 77 subroutines for the solution of skew- Hamiltonian/Hamiltonian eigenproblems Part II: Implementation and numerical results. SLICOT Working Note 3-, August 3. 5 P. Benner and M. Voigt. On the computation of particular eigenvectors of Hamiltonian matrix pencils. Proc. Appl. Math. Mech., ):753754,. 6 P. Benner and M. Voigt. Spectral characterization and enforcement of negative imaginariness for descriptor systems. Linear Algebra Appl., 4394):49, August 3. 7th Conference of the International Linear Algebra Society, Braunschweig, Germany, August.

13 7 A. I. Bojanczyk, G. H. Golub, and P. Van Dooren. The periodic Schur decomposition. Algorithms and applications. In F. T. Luk, editor, Advanced Signal Processing Algorithms, Architectures, and Implementations III, volume 77 of Proc. SPIE, pages 34, T. Brüll. Checking dissipativity of linear behaviour systems in kernel representation. Math. Control Signals Systems, 3:5975,. 9 T. Brüll. Dissipativity of linear quadratic systems. PhD thesis, Institut für Mathematik, TU Berlin, March. T. Brüll and C. Schröder. Dissipativity enforcement via perturbation of para-hermitian pencils. IEEE Trans. Circuits Syst. I. Regul. Pap., 6), January 3. L. Dai. Singular Control Systems, volume 8 of Lecture Notes in Control and Inform. Sci. Springer- Verlag, Berlin/Heidelberg, 989. G. H. Golub and C. F. Van Loan. Matrix Computations. Johns Hopkins University Press, Baltimore, third edition, R. Granat, B. Kågström, and D. Kressner. Computing periodic deating subspaces associated with a specied set of eigenvalues. BIT, 43):8, 3. 4 S. Grivet-Talocia. Passivity enforcement via perturbation of Hamiltonian matrices. IEEE Trans. Circuits Syst. I. Regul. Pap., 59):755769, September 4. 5 S. Grivet-Talocia and A. Ubolli. On the generation of large passive macromodels for complex interconnect structures. IEEE Trans. Adv. Packaging, 9):3954, February 6. 6 M. Mabrok, A. G. Kallapur, I. R. Petersen, and A. Lanzon. Spectral conditions for the negative imaginary property of transfer function matrices. In Proceedings of the 8th IFAC World Congress, pages 336, Milan, Italy, September. 7 V. Mehrmann. The Autonomous Linear Quadratic Control Problem, Theory and Numerical Solution, volume 63 of Lecture Notes in Control and Inform. Sci. Springer-Verlag, Heidelberg, July V. Mehrmann and H. Xu. Perturbation of purely imaginary eigenvalues of Hamiltonian matrices under structured perturbations. Electron. J. Linear Algebra, 7:34 57, 8. 9 K. Zhou and J. D. Doyle. Essentials of Robust Control. Prentice Hall, Upper Saddle River, NJ, st edition, 998.

FORTRAN 77 Subroutines for the Solution of Skew-Hamiltonian/Hamiltonian Eigenproblems Part I: Algorithms and Applications 1

FORTRAN 77 Subroutines for the Solution of Skew-Hamiltonian/Hamiltonian Eigenproblems Part I: Algorithms and Applications 1 SLICOT Working Note 2013-1 FORTRAN 77 Subroutines for the Solution of Skew-Hamiltonian/Hamiltonian Eigenproblems Part I: Algorithms and Applications 1 Peter Benner 2 Vasile Sima 3 Matthias Voigt 4 August

More information

SHHEIG Users Guide. Peter Benner, Vasile Sima, and Matthias Voigt June 10, 2015

SHHEIG Users Guide. Peter Benner, Vasile Sima, and Matthias Voigt June 10, 2015 SHHEIG Users Guide Peter Benner, Vasile Sima, and Matthias Voigt June 10, 2015 Abstract SHHEIG is a software package for solving of skew-hamiltonian/hamiltonian eigenproblems using structure-preserving

More information

MATLAB TOOLS FOR SOLVING PERIODIC EIGENVALUE PROBLEMS 1

MATLAB TOOLS FOR SOLVING PERIODIC EIGENVALUE PROBLEMS 1 MATLAB TOOLS FOR SOLVING PERIODIC EIGENVALUE PROBLEMS 1 Robert Granat Bo Kågström Daniel Kressner,2 Department of Computing Science and HPC2N, Umeå University, SE-90187 Umeå, Sweden. {granat,bokg,kressner}@cs.umu.se

More information

STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS

STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS Electronic Transactions on Numerical Analysis Volume 44 pp 1 24 215 Copyright c 215 ISSN 168 9613 ETNA STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS VOLKER MEHRMANN AND HONGGUO

More information

The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation

The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation Zheng-jian Bai Abstract In this paper, we first consider the inverse

More information

L -Norm Computation for Large-Scale Descriptor Systems Using Structured Iterative Eigensolvers

L -Norm Computation for Large-Scale Descriptor Systems Using Structured Iterative Eigensolvers L -Norm Computation for Large-Scale Descriptor Systems Using Structured Iterative Eigensolvers Peter Benner Ryan Lowe Matthias Voigt July 5, 2016 Abstract In this article, we discuss a method for computing

More information

NEW RESULTS FOR SOLVING ALGEBRAIC RICCATI EQUATIONS BY HAMILTONIAN SOLVERS

NEW RESULTS FOR SOLVING ALGEBRAIC RICCATI EQUATIONS BY HAMILTONIAN SOLVERS NEW RESULTS FOR SOLVING ALGEBRAIC RICCATI EQUATIONS BY HAMILTONIAN SOLVERS Vasile Sima National Institute for Research & Development in Informatics, vsima@ici.ro ABSTRACT: Solving standard continuous-time

More information

Contents 1 Introduction and Preliminaries 1 Embedding of Extended Matrix Pencils 3 Hamiltonian Triangular Forms 1 4 Skew-Hamiltonian/Hamiltonian Matri

Contents 1 Introduction and Preliminaries 1 Embedding of Extended Matrix Pencils 3 Hamiltonian Triangular Forms 1 4 Skew-Hamiltonian/Hamiltonian Matri Technische Universitat Chemnitz Sonderforschungsbereich 393 Numerische Simulation auf massiv parallelen Rechnern Peter Benner Ralph Byers Volker Mehrmann Hongguo Xu Numerical Computation of Deating Subspaces

More information

Passivation of LTI systems

Passivation of LTI systems Passivation of LTI systems Christian Schröder Tatjana Stykel Abstract In this paper we consider a passivation procedure for linear time-invariant systems. This procedure is based on the spectral properties

More information

SOLVING DISCRETE-TIME ALGEBRAIC RICCATI EQUATIONS USING MODIFIED NEWTON S METHOD

SOLVING DISCRETE-TIME ALGEBRAIC RICCATI EQUATIONS USING MODIFIED NEWTON S METHOD PHYSCON 2013, San Luis Potosí, México, 26 29th August, 2013 SOLVING DISCRETE-TIME ALGEBRAIC RICCATI EQUATIONS USING MODIFIED NEWTON S METHOD Vasile Sima Advanced Research National Institute for Research

More information

An SVD-Like Matrix Decomposition and Its Applications

An SVD-Like Matrix Decomposition and Its Applications An SVD-Like Matrix Decomposition and Its Applications Hongguo Xu Abstract [ A matrix S C m m is symplectic if SJS = J, where J = I m I m. Symplectic matrices play an important role in the analysis and

More information

Theorem Let X be a symmetric solution of DR(X) = 0. Let X b be a symmetric approximation to Xand set V := X? X. b If R b = R + B T XB b and I + V B R

Theorem Let X be a symmetric solution of DR(X) = 0. Let X b be a symmetric approximation to Xand set V := X? X. b If R b = R + B T XB b and I + V B R Initializing Newton's method for discrete-time algebraic Riccati equations using the buttery SZ algorithm Heike Fabender Zentrum fur Technomathematik Fachbereich - Mathematik und Informatik Universitat

More information

Computation of a canonical form for linear differential-algebraic equations

Computation of a canonical form for linear differential-algebraic equations Computation of a canonical form for linear differential-algebraic equations Markus Gerdin Division of Automatic Control Department of Electrical Engineering Linköpings universitet, SE-581 83 Linköping,

More information

Factorized Solution of Sylvester Equations with Applications in Control

Factorized Solution of Sylvester Equations with Applications in Control Factorized Solution of Sylvester Equations with Applications in Control Peter Benner Abstract Sylvester equations play a central role in many areas of applied mathematics and in particular in systems and

More information

NAG Library Routine Document F08QUF (ZTRSEN)

NAG Library Routine Document F08QUF (ZTRSEN) F08 Least-squares and Eigenvalue Problems (LAPACK) F08QUF NAG Library Routine Document F08QUF (ZTRSEN) Note: before using this routine, please read the Users Note for your implementation to check the interpretation

More information

Outline Introduction: Problem Description Diculties Algebraic Structure: Algebraic Varieties Rank Decient Toeplitz Matrices Constructing Lower Rank St

Outline Introduction: Problem Description Diculties Algebraic Structure: Algebraic Varieties Rank Decient Toeplitz Matrices Constructing Lower Rank St Structured Lower Rank Approximation by Moody T. Chu (NCSU) joint with Robert E. Funderlic (NCSU) and Robert J. Plemmons (Wake Forest) March 5, 1998 Outline Introduction: Problem Description Diculties Algebraic

More information

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact Computational Linear Algebra Course: (MATH: 6800, CSCI: 6800) Semester: Fall 1998 Instructors: { Joseph E. Flaherty, aherje@cs.rpi.edu { Franklin T. Luk, luk@cs.rpi.edu { Wesley Turner, turnerw@cs.rpi.edu

More information

Exponentials of Symmetric Matrices through Tridiagonal Reductions

Exponentials of Symmetric Matrices through Tridiagonal Reductions Exponentials of Symmetric Matrices through Tridiagonal Reductions Ya Yan Lu Department of Mathematics City University of Hong Kong Kowloon, Hong Kong Abstract A simple and efficient numerical algorithm

More information

Finite dimensional indefinite inner product spaces and applications in Numerical Analysis

Finite dimensional indefinite inner product spaces and applications in Numerical Analysis Finite dimensional indefinite inner product spaces and applications in Numerical Analysis Christian Mehl Technische Universität Berlin, Institut für Mathematik, MA 4-5, 10623 Berlin, Germany, Email: mehl@math.tu-berlin.de

More information

Solving projected generalized Lyapunov equations using SLICOT

Solving projected generalized Lyapunov equations using SLICOT Solving projected generalized Lyapunov equations using SLICOT Tatjana Styel Abstract We discuss the numerical solution of projected generalized Lyapunov equations. Such equations arise in many control

More information

A Backward Stable Hyperbolic QR Factorization Method for Solving Indefinite Least Squares Problem

A Backward Stable Hyperbolic QR Factorization Method for Solving Indefinite Least Squares Problem A Backward Stable Hyperbolic QR Factorization Method for Solving Indefinite Least Suares Problem Hongguo Xu Dedicated to Professor Erxiong Jiang on the occasion of his 7th birthday. Abstract We present

More information

NAG Library Routine Document F08PNF (ZGEES)

NAG Library Routine Document F08PNF (ZGEES) F08 Least-squares and Eigenvalue Problems (LAPACK) F08PNF NAG Library Routine Document F08PNF (ZGEES) Note: before using this routine, please read the Users Note for your implementation to check the interpretation

More information

Numerical Computation of Structured Complex Stability Radii of Large-Scale Matrices and Pencils

Numerical Computation of Structured Complex Stability Radii of Large-Scale Matrices and Pencils 51st IEEE onference on Decision and ontrol December 10-13, 01. Maui, Hawaii, USA Numerical omputation of Structured omplex Stability Radii of Large-Scale Matrices and Pencils Peter Benner and Matthias

More information

2 Computing complex square roots of a real matrix

2 Computing complex square roots of a real matrix On computing complex square roots of real matrices Zhongyun Liu a,, Yulin Zhang b, Jorge Santos c and Rui Ralha b a School of Math., Changsha University of Science & Technology, Hunan, 410076, China b

More information

Nonlinear palindromic eigenvalue problems and their numerical solution

Nonlinear palindromic eigenvalue problems and their numerical solution Nonlinear palindromic eigenvalue problems and their numerical solution TU Berlin DFG Research Center Institut für Mathematik MATHEON IN MEMORIAM RALPH BYERS Polynomial eigenvalue problems k P(λ) x = (

More information

NAG Library Routine Document F08UBF (DSBGVX)

NAG Library Routine Document F08UBF (DSBGVX) NAG Library Routine Document (DSBGVX) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

An exploration of matrix equilibration

An exploration of matrix equilibration An exploration of matrix equilibration Paul Liu Abstract We review three algorithms that scale the innity-norm of each row and column in a matrix to. The rst algorithm applies to unsymmetric matrices,

More information

Solving Algebraic Riccati Equations with SLICOT

Solving Algebraic Riccati Equations with SLICOT Solving Algebraic Riccati Equations with SLICOT Peter Benner Institut für Mathematik, MA 4-5 Technische Universität Berlin Straße des 17. Juni 136 D-163 Berlin, Germany email: benner@math.tu-berlin.de

More information

Opportunities for ELPA to Accelerate the Solution of the Bethe-Salpeter Eigenvalue Problem

Opportunities for ELPA to Accelerate the Solution of the Bethe-Salpeter Eigenvalue Problem Opportunities for ELPA to Accelerate the Solution of the Bethe-Salpeter Eigenvalue Problem Peter Benner, Andreas Marek, Carolin Penke August 16, 2018 ELSI Workshop 2018 Partners: The Problem The Bethe-Salpeter

More information

ON THE REDUCTION OF A HAMILTONIAN MATRIX TO HAMILTONIAN SCHUR FORM

ON THE REDUCTION OF A HAMILTONIAN MATRIX TO HAMILTONIAN SCHUR FORM ON THE REDUCTION OF A HAMILTONIAN MATRIX TO HAMILTONIAN SCHUR FORM DAVID S WATKINS Abstract Recently Chu Liu and Mehrmann developed an O(n 3 ) structure preserving method for computing the Hamiltonian

More information

N.G.Bean, D.A.Green and P.G.Taylor. University of Adelaide. Adelaide. Abstract. process of an MMPP/M/1 queue is not a MAP unless the queue is a

N.G.Bean, D.A.Green and P.G.Taylor. University of Adelaide. Adelaide. Abstract. process of an MMPP/M/1 queue is not a MAP unless the queue is a WHEN IS A MAP POISSON N.G.Bean, D.A.Green and P.G.Taylor Department of Applied Mathematics University of Adelaide Adelaide 55 Abstract In a recent paper, Olivier and Walrand (994) claimed that the departure

More information

Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control

Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control Electronic Journal of Linear Algebra Volume 34 Volume 34 08) Article 39 08 Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control Christian Mehl Technische Universitaet

More information

The Kalman-Yakubovich-Popov Lemma for Differential-Algebraic Equations with Applications

The Kalman-Yakubovich-Popov Lemma for Differential-Algebraic Equations with Applications MAX PLANCK INSTITUTE Elgersburg Workshop Elgersburg February 11-14, 2013 The Kalman-Yakubovich-Popov Lemma for Differential-Algebraic Equations with Applications Timo Reis 1 Matthias Voigt 2 1 Department

More information

only nite eigenvalues. This is an extension of earlier results from [2]. Then we concentrate on the Riccati equation appearing in H 2 and linear quadr

only nite eigenvalues. This is an extension of earlier results from [2]. Then we concentrate on the Riccati equation appearing in H 2 and linear quadr The discrete algebraic Riccati equation and linear matrix inequality nton. Stoorvogel y Department of Mathematics and Computing Science Eindhoven Univ. of Technology P.O. ox 53, 56 M Eindhoven The Netherlands

More information

Two Results About The Matrix Exponential

Two Results About The Matrix Exponential Two Results About The Matrix Exponential Hongguo Xu Abstract Two results about the matrix exponential are given. One is to characterize the matrices A which satisfy e A e AH = e AH e A, another is about

More information

p q m p q p q m p q p Σ q 0 I p Σ 0 0, n 2p q

p q m p q p q m p q p Σ q 0 I p Σ 0 0, n 2p q A NUMERICAL METHOD FOR COMPUTING AN SVD-LIKE DECOMPOSITION HONGGUO XU Abstract We present a numerical method to compute the SVD-like decomposition B = QDS 1 where Q is orthogonal S is symplectic and D

More information

ANONSINGULAR tridiagonal linear system of the form

ANONSINGULAR tridiagonal linear system of the form Generalized Diagonal Pivoting Methods for Tridiagonal Systems without Interchanges Jennifer B. Erway, Roummel F. Marcia, and Joseph A. Tyson Abstract It has been shown that a nonsingular symmetric tridiagonal

More information

Positive Denite Matrix. Ya Yan Lu 1. Department of Mathematics. City University of Hong Kong. Kowloon, Hong Kong. Abstract

Positive Denite Matrix. Ya Yan Lu 1. Department of Mathematics. City University of Hong Kong. Kowloon, Hong Kong. Abstract Computing the Logarithm of a Symmetric Positive Denite Matrix Ya Yan Lu Department of Mathematics City University of Hong Kong Kowloon, Hong Kong Abstract A numerical method for computing the logarithm

More information

Parallel Computation of the Eigenstructure of Toeplitz-plus-Hankel matrices on Multicomputers

Parallel Computation of the Eigenstructure of Toeplitz-plus-Hankel matrices on Multicomputers Parallel Computation of the Eigenstructure of Toeplitz-plus-Hankel matrices on Multicomputers José M. Badía * and Antonio M. Vidal * Departamento de Sistemas Informáticos y Computación Universidad Politécnica

More information

NAG Library Routine Document F08VAF (DGGSVD)

NAG Library Routine Document F08VAF (DGGSVD) NAG Library Routine Document (DGGSVD) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

Module 6.6: nag nsym gen eig Nonsymmetric Generalized Eigenvalue Problems. Contents

Module 6.6: nag nsym gen eig Nonsymmetric Generalized Eigenvalue Problems. Contents Eigenvalue and Least-squares Problems Module Contents Module 6.6: nag nsym gen eig Nonsymmetric Generalized Eigenvalue Problems nag nsym gen eig provides procedures for solving nonsymmetric generalized

More information

Sensitivity analysis of the differential matrix Riccati equation based on the associated linear differential system

Sensitivity analysis of the differential matrix Riccati equation based on the associated linear differential system Advances in Computational Mathematics 7 (1997) 295 31 295 Sensitivity analysis of the differential matrix Riccati equation based on the associated linear differential system Mihail Konstantinov a and Vera

More information

632 CHAP. 11 EIGENVALUES AND EIGENVECTORS. QR Method

632 CHAP. 11 EIGENVALUES AND EIGENVECTORS. QR Method 632 CHAP 11 EIGENVALUES AND EIGENVECTORS QR Method Suppose that A is a real symmetric matrix In the preceding section we saw how Householder s method is used to construct a similar tridiagonal matrix The

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT -09 Computational and Sensitivity Aspects of Eigenvalue-Based Methods for the Large-Scale Trust-Region Subproblem Marielba Rojas, Bjørn H. Fotland, and Trond Steihaug

More information

Section 4.5 Eigenvalues of Symmetric Tridiagonal Matrices

Section 4.5 Eigenvalues of Symmetric Tridiagonal Matrices Section 4.5 Eigenvalues of Symmetric Tridiagonal Matrices Key Terms Symmetric matrix Tridiagonal matrix Orthogonal matrix QR-factorization Rotation matrices (plane rotations) Eigenvalues We will now complete

More information

AN INVERSE EIGENVALUE PROBLEM AND AN ASSOCIATED APPROXIMATION PROBLEM FOR GENERALIZED K-CENTROHERMITIAN MATRICES

AN INVERSE EIGENVALUE PROBLEM AND AN ASSOCIATED APPROXIMATION PROBLEM FOR GENERALIZED K-CENTROHERMITIAN MATRICES AN INVERSE EIGENVALUE PROBLEM AND AN ASSOCIATED APPROXIMATION PROBLEM FOR GENERALIZED K-CENTROHERMITIAN MATRICES ZHONGYUN LIU AND HEIKE FAßBENDER Abstract: A partially described inverse eigenvalue problem

More information

NAG Library Routine Document F02HDF.1

NAG Library Routine Document F02HDF.1 F02 Eigenvalues and Eigenvectors NAG Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and

More information

On the Iwasawa decomposition of a symplectic matrix

On the Iwasawa decomposition of a symplectic matrix Applied Mathematics Letters 20 (2007) 260 265 www.elsevier.com/locate/aml On the Iwasawa decomposition of a symplectic matrix Michele Benzi, Nader Razouk Department of Mathematics and Computer Science,

More information

THE RELATION BETWEEN THE QR AND LR ALGORITHMS

THE RELATION BETWEEN THE QR AND LR ALGORITHMS SIAM J. MATRIX ANAL. APPL. c 1998 Society for Industrial and Applied Mathematics Vol. 19, No. 2, pp. 551 555, April 1998 017 THE RELATION BETWEEN THE QR AND LR ALGORITHMS HONGGUO XU Abstract. For an Hermitian

More information

NAG Library Routine Document F08FAF (DSYEV)

NAG Library Routine Document F08FAF (DSYEV) NAG Library Routine Document (DSYEV) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

1. Introduction. Applying the QR algorithm to a real square matrix A yields a decomposition of the form

1. Introduction. Applying the QR algorithm to a real square matrix A yields a decomposition of the form BLOCK ALGORITHMS FOR REORDERING STANDARD AND GENERALIZED SCHUR FORMS LAPACK WORKING NOTE 171 DANIEL KRESSNER Abstract. Block algorithms for reordering a selected set of eigenvalues in a standard or generalized

More information

A robust numerical method for the γ-iteration in H control

A robust numerical method for the γ-iteration in H control A robust numerical method for the γ-iteration in H control Peter Benner Ralph Byers Volker Mehrmann Hongguo Xu December 6, 26 Abstract We present a numerical method for the solution of the optimal H control

More information

NAG Library Routine Document F08YUF (ZTGSEN).1

NAG Library Routine Document F08YUF (ZTGSEN).1 F08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

More information

On the application of different numerical methods to obtain null-spaces of polynomial matrices. Part 1: block Toeplitz algorithms.

On the application of different numerical methods to obtain null-spaces of polynomial matrices. Part 1: block Toeplitz algorithms. On the application of different numerical methods to obtain null-spaces of polynomial matrices. Part 1: block Toeplitz algorithms. J.C. Zúñiga and D. Henrion Abstract Four different algorithms are designed

More information

Computing generalized inverse systems using matrix pencil methods

Computing generalized inverse systems using matrix pencil methods Computing generalized inverse systems using matrix pencil methods A. Varga German Aerospace Center DLR - Oberpfaffenhofen Institute of Robotics and Mechatronics D-82234 Wessling, Germany. Andras.Varga@dlr.de

More information

Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries

Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries Fakultät für Mathematik TU Chemnitz, Germany Peter Benner benner@mathematik.tu-chemnitz.de joint work with Heike Faßbender

More information

NAG Library Routine Document F08FNF (ZHEEV).1

NAG Library Routine Document F08FNF (ZHEEV).1 NAG Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

NAG Library Routine Document F08FPF (ZHEEVX)

NAG Library Routine Document F08FPF (ZHEEVX) NAG Library Routine Document (ZHEEVX) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

NAG Toolbox for Matlab nag_lapack_dggev (f08wa)

NAG Toolbox for Matlab nag_lapack_dggev (f08wa) NAG Toolbox for Matlab nag_lapack_dggev () 1 Purpose nag_lapack_dggev () computes for a pair of n by n real nonsymmetric matrices ða; BÞ the generalized eigenvalues and, optionally, the left and/or right

More information

NAG Library Routine Document F08JDF (DSTEVR)

NAG Library Routine Document F08JDF (DSTEVR) F08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Routine Document (DSTEVR) Note: before using this routine, please read the Users Note for your implementation to check the interpretation

More information

Package geigen. August 22, 2017

Package geigen. August 22, 2017 Version 2.1 Package geigen ugust 22, 2017 Title Calculate Generalized Eigenvalues, the Generalized Schur Decomposition and the Generalized Singular Value Decomposition of a Matrix Pair with Lapack Date

More information

A Note on Eigenvalues of Perturbed Hermitian Matrices

A Note on Eigenvalues of Perturbed Hermitian Matrices A Note on Eigenvalues of Perturbed Hermitian Matrices Chi-Kwong Li Ren-Cang Li July 2004 Let ( H1 E A = E H 2 Abstract and à = ( H1 H 2 be Hermitian matrices with eigenvalues λ 1 λ k and λ 1 λ k, respectively.

More information

Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics

Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics Lihong Feng and Peter Benner Abstract We consider model order reduction of a system described

More information

QUASI-UNIFORMLY POSITIVE OPERATORS IN KREIN SPACE. Denitizable operators in Krein spaces have spectral properties similar to those

QUASI-UNIFORMLY POSITIVE OPERATORS IN KREIN SPACE. Denitizable operators in Krein spaces have spectral properties similar to those QUASI-UNIFORMLY POSITIVE OPERATORS IN KREIN SPACE BRANKO CURGUS and BRANKO NAJMAN Denitizable operators in Krein spaces have spectral properties similar to those of selfadjoint operators in Hilbert spaces.

More information

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM Proceedings of ALGORITMY 25 pp. 22 211 PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM GABRIEL OKŠA AND MARIÁN VAJTERŠIC Abstract. One way, how to speed up the computation of the singular value

More information

Generalized Shifted Inverse Iterations on Grassmann Manifolds 1

Generalized Shifted Inverse Iterations on Grassmann Manifolds 1 Proceedings of the Sixteenth International Symposium on Mathematical Networks and Systems (MTNS 2004), Leuven, Belgium Generalized Shifted Inverse Iterations on Grassmann Manifolds 1 J. Jordan α, P.-A.

More information

arxiv: v1 [cs.sy] 29 Dec 2018

arxiv: v1 [cs.sy] 29 Dec 2018 ON CHECKING NULL RANK CONDITIONS OF RATIONAL MATRICES ANDREAS VARGA Abstract. In this paper we discuss possible numerical approaches to reliably check the rank condition rankg(λ) = 0 for a given rational

More information

PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS

PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS Abstract. We present elementary proofs of the Cauchy-Binet Theorem on determinants and of the fact that the eigenvalues of a matrix

More information

Randomized algorithms for the low-rank approximation of matrices

Randomized algorithms for the low-rank approximation of matrices Randomized algorithms for the low-rank approximation of matrices Yale Dept. of Computer Science Technical Report 1388 Edo Liberty, Franco Woolfe, Per-Gunnar Martinsson, Vladimir Rokhlin, and Mark Tygert

More information

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable International Journal of Wavelets, Multiresolution and Information Processing c World Scientic Publishing Company Polynomial functions are renable Henning Thielemann Institut für Informatik Martin-Luther-Universität

More information

Algebraic Equations. 2.0 Introduction. Nonsingular versus Singular Sets of Equations. A set of linear algebraic equations looks like this:

Algebraic Equations. 2.0 Introduction. Nonsingular versus Singular Sets of Equations. A set of linear algebraic equations looks like this: Chapter 2. 2.0 Introduction Solution of Linear Algebraic Equations A set of linear algebraic equations looks like this: a 11 x 1 + a 12 x 2 + a 13 x 3 + +a 1N x N =b 1 a 21 x 1 + a 22 x 2 + a 23 x 3 +

More information

1 Vectors. Notes for Bindel, Spring 2017 Numerical Analysis (CS 4220)

1 Vectors. Notes for Bindel, Spring 2017 Numerical Analysis (CS 4220) Notes for 2017-01-30 Most of mathematics is best learned by doing. Linear algebra is no exception. You have had a previous class in which you learned the basics of linear algebra, and you will have plenty

More information

A fast randomized algorithm for overdetermined linear least-squares regression

A fast randomized algorithm for overdetermined linear least-squares regression A fast randomized algorithm for overdetermined linear least-squares regression Vladimir Rokhlin and Mark Tygert Technical Report YALEU/DCS/TR-1403 April 28, 2008 Abstract We introduce a randomized algorithm

More information

Computing least squares condition numbers on hybrid multicore/gpu systems

Computing least squares condition numbers on hybrid multicore/gpu systems Computing least squares condition numbers on hybrid multicore/gpu systems M. Baboulin and J. Dongarra and R. Lacroix Abstract This paper presents an efficient computation for least squares conditioning

More information

NP-hardness of the stable matrix in unit interval family problem in discrete time

NP-hardness of the stable matrix in unit interval family problem in discrete time Systems & Control Letters 42 21 261 265 www.elsevier.com/locate/sysconle NP-hardness of the stable matrix in unit interval family problem in discrete time Alejandra Mercado, K.J. Ray Liu Electrical and

More information

THE solution of the absolute value equation (AVE) of

THE solution of the absolute value equation (AVE) of The nonlinear HSS-like iterative method for absolute value equations Mu-Zheng Zhu Member, IAENG, and Ya-E Qi arxiv:1403.7013v4 [math.na] 2 Jan 2018 Abstract Salkuyeh proposed the Picard-HSS iteration method

More information

Krylov Techniques for Model Reduction of Second-Order Systems

Krylov Techniques for Model Reduction of Second-Order Systems Krylov Techniques for Model Reduction of Second-Order Systems A Vandendorpe and P Van Dooren February 4, 2004 Abstract The purpose of this paper is to present a Krylov technique for model reduction of

More information

Calculating the H -norm using the implicit determinant method.

Calculating the H -norm using the implicit determinant method. Calculating the H -norm using the implicit determinant method. Melina Freitag Department of Mathematical Sciences University of Bath 18th ILAS Conference Providence, Rhode Island 4th June 2013 joint work

More information

A note on the product of two skew-hamiltonian matrices

A note on the product of two skew-hamiltonian matrices A note on the product of two skew-hamiltonian matrices H. Faßbender and Kh. D. Ikramov October 13, 2007 Abstract: We show that the product C of two skew-hamiltonian matrices obeys the Stenzel conditions.

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

On Linear-Quadratic Control Theory of Implicit Difference Equations

On Linear-Quadratic Control Theory of Implicit Difference Equations On Linear-Quadratic Control Theory of Implicit Difference Equations Daniel Bankmann Technische Universität Berlin 10. Elgersburg Workshop 2016 February 9, 2016 D. Bankmann (TU Berlin) Control of IDEs February

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

Model reduction via tangential interpolation

Model reduction via tangential interpolation Model reduction via tangential interpolation K. Gallivan, A. Vandendorpe and P. Van Dooren May 14, 2002 1 Introduction Although most of the theory presented in this paper holds for both continuous-time

More information

arxiv: v1 [math.na] 1 Sep 2018

arxiv: v1 [math.na] 1 Sep 2018 On the perturbation of an L -orthogonal projection Xuefeng Xu arxiv:18090000v1 [mathna] 1 Sep 018 September 5 018 Abstract The L -orthogonal projection is an important mathematical tool in scientific computing

More information

The skew-symmetric orthogonal solutions of the matrix equation AX = B

The skew-symmetric orthogonal solutions of the matrix equation AX = B Linear Algebra and its Applications 402 (2005) 303 318 www.elsevier.com/locate/laa The skew-symmetric orthogonal solutions of the matrix equation AX = B Chunjun Meng, Xiyan Hu, Lei Zhang College of Mathematics

More information

On Solving Large Algebraic. Riccati Matrix Equations

On Solving Large Algebraic. Riccati Matrix Equations International Mathematical Forum, 5, 2010, no. 33, 1637-1644 On Solving Large Algebraic Riccati Matrix Equations Amer Kaabi Department of Basic Science Khoramshahr Marine Science and Technology University

More information

The value of a problem is not so much coming up with the answer as in the ideas and attempted ideas it forces on the would be solver I.N.

The value of a problem is not so much coming up with the answer as in the ideas and attempted ideas it forces on the would be solver I.N. Math 410 Homework Problems In the following pages you will find all of the homework problems for the semester. Homework should be written out neatly and stapled and turned in at the beginning of class

More information

UMIACS-TR July CS-TR 2494 Revised January An Updating Algorithm for. Subspace Tracking. G. W. Stewart. abstract

UMIACS-TR July CS-TR 2494 Revised January An Updating Algorithm for. Subspace Tracking. G. W. Stewart. abstract UMIACS-TR-9-86 July 199 CS-TR 2494 Revised January 1991 An Updating Algorithm for Subspace Tracking G. W. Stewart abstract In certain signal processing applications it is required to compute the null space

More information

Numerical Methods I Eigenvalue Problems

Numerical Methods I Eigenvalue Problems Numerical Methods I Eigenvalue Problems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 2nd, 2014 A. Donev (Courant Institute) Lecture

More information

The antitriangular factorisation of saddle point matrices

The antitriangular factorisation of saddle point matrices The antitriangular factorisation of saddle point matrices J. Pestana and A. J. Wathen August 29, 2013 Abstract Mastronardi and Van Dooren [this journal, 34 (2013) pp. 173 196] recently introduced the block

More information

EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems

EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems EIGIFP: A MATLAB Program for Solving Large Symmetric Generalized Eigenvalue Problems JAMES H. MONEY and QIANG YE UNIVERSITY OF KENTUCKY eigifp is a MATLAB program for computing a few extreme eigenvalues

More information

J-SPECTRAL FACTORIZATION

J-SPECTRAL FACTORIZATION J-SPECTRAL FACTORIZATION of Regular Para-Hermitian Transfer Matrices Qing-Chang Zhong zhongqc@ieee.org School of Electronics University of Glamorgan United Kingdom Outline Notations and definitions Regular

More information

UMIACS-TR July CS-TR 2721 Revised March Perturbation Theory for. Rectangular Matrix Pencils. G. W. Stewart.

UMIACS-TR July CS-TR 2721 Revised March Perturbation Theory for. Rectangular Matrix Pencils. G. W. Stewart. UMIAS-TR-9-5 July 99 S-TR 272 Revised March 993 Perturbation Theory for Rectangular Matrix Pencils G. W. Stewart abstract The theory of eigenvalues and eigenvectors of rectangular matrix pencils is complicated

More information

Preconditioned Parallel Block Jacobi SVD Algorithm

Preconditioned Parallel Block Jacobi SVD Algorithm Parallel Numerics 5, 15-24 M. Vajteršic, R. Trobec, P. Zinterhof, A. Uhl (Eds.) Chapter 2: Matrix Algebra ISBN 961-633-67-8 Preconditioned Parallel Block Jacobi SVD Algorithm Gabriel Okša 1, Marián Vajteršic

More information

MTH 464: Computational Linear Algebra

MTH 464: Computational Linear Algebra MTH 464: Computational Linear Algebra Lecture Outlines Exam 2 Material Prof. M. Beauregard Department of Mathematics & Statistics Stephen F. Austin State University February 6, 2018 Linear Algebra (MTH

More information

Accelerating computation of eigenvectors in the nonsymmetric eigenvalue problem

Accelerating computation of eigenvectors in the nonsymmetric eigenvalue problem Accelerating computation of eigenvectors in the nonsymmetric eigenvalue problem Mark Gates 1, Azzam Haidar 1, and Jack Dongarra 1,2,3 1 University of Tennessee, Knoxville, TN, USA 2 Oak Ridge National

More information

On GPU Acceleration of Common Solvers for (Quasi-) Triangular Generalized Lyapunov Equations

On GPU Acceleration of Common Solvers for (Quasi-) Triangular Generalized Lyapunov Equations Max Planck Institute Magdeburg Preprints Martin Köhler Jens Saak On GPU Acceleration of Common Solvers for (Quasi-) Triangular Generalized Lyapunov Equations MAX PLANCK INSTITUT FÜR DYNAMIK KOMPLEXER TECHNISCHER

More information

RITZ VALUE BOUNDS THAT EXPLOIT QUASI-SPARSITY

RITZ VALUE BOUNDS THAT EXPLOIT QUASI-SPARSITY RITZ VALUE BOUNDS THAT EXPLOIT QUASI-SPARSITY ILSE C.F. IPSEN Abstract. Absolute and relative perturbation bounds for Ritz values of complex square matrices are presented. The bounds exploit quasi-sparsity

More information

STABILITY OF INVARIANT SUBSPACES OF COMMUTING MATRICES We obtain some further results for pairs of commuting matrices. We show that a pair of commutin

STABILITY OF INVARIANT SUBSPACES OF COMMUTING MATRICES We obtain some further results for pairs of commuting matrices. We show that a pair of commutin On the stability of invariant subspaces of commuting matrices Tomaz Kosir and Bor Plestenjak September 18, 001 Abstract We study the stability of (joint) invariant subspaces of a nite set of commuting

More information

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

More information