Analysis of a Fast Hankel Eigenvalue Algorithm

Total Page:16

File Type:pdf, Size:1020Kb

Analysis of a Fast Hankel Eigenvalue Algorithm Analysis of a Fast Hankel Eigenvalue Algorithm a b Franklin T Luk and Sanzheng Qiao a Department of Computer Science Rensselaer Polytechnic Institute Troy New York USA b Department of Computing and Software McMaster University Hamilton Ontario LS L Canada ABSTRACT This pap er analyzes the imp ortant steps of an O n log n algorithm for nding the eigenvalues of a complex Hankel matrix The three key steps are a Lanczostype tridiagonalization algorithm a fast FFTbased Hankel matrixvector pro duct pro cedure and a QR eigenvalue metho d based on complexorthogonal transformations In this pap er we present an error analysis of the three steps as well as results from numerical exp eriments Keywords Hankel matrix eigenvalue decomp osition Lanczos tridiagonalization Hankel matrixvector multipli cation complexorthogonal transformations error analysis INTRODUCTION The eigenvalue decomp osition of a structured matrix has imp ortant applications in signal pro cessing In this pap er nn we consider a complex Hankel matrix H C h h h h n n h h h h B C n n B C B C H B C A h h h h n n n n h h h h n n n n The authors prop osed a fast algorithm for nding the eigenvalues of H The key step is a fast Lanczos tridiago nalization algorithm which employs a fast Hankel matrixvector multiplication based on the Fast Fourier transform FFT Then the algorithm p erforms a QRlike pro cedure using the complexorthogonal transformations in the di agonalization to nd the eigenvalues In this pap er we present an error analysis and discuss the stability prop erties of the key steps of the algorithm This pap er is organized as follows In Section we discuss eigenvalue computation using complexorthogonal transformations and describ e the overall eigenvalue pro cedure and three key steps In Section we introduce notations and error analysis of some basic complex arithmetic op erations We analyze the orthogonality of the Lanczos vectors in Section and the accuracy of the Hankel matrixvector multiplication in Section In Section we derive the condition number of a complexorthogonal plane rotation and we provide a backward error analysis of the application of this transformation to a vector Numerical results are given in Section Supp orted by the Natural Sciences and Engineering Research Council of Canada under grant OGP COMPLEXORTHOGONAL TRANSFORMATIONS An eigenvalue decomp osition of a nondefective matrix H is given by H XDX T T We will pick the matrix X to b e complexorthogonal that is XX I So H XDX We apply a sp ecial Lanczos tridiagonalization to the Hankel matrix assuming that the Lanczos pro cess do es not prematurely terminate T H QJ Q where Q is complexorthogonal and J is complexsymmetric tridiagonal B C B C B C J B C B C A n n n T Let Q q q q Since Q Q I we see that n T q q j ij i We call the prop erty dened by as complexorthogonality corthogonality for short The dominant cost of the Lanczos metho d is matrixvector multiplication We prop ose an O n log n FFTbased n multiplication scheme so that we can tridiagonalize a Hankel matrix in O n log n op erations Given w C we n b want to compute the pro duct p H w Dene c C by T b c h h h h h h n n n n T n b Let w w w w Dene w C by n T b w w w w n n Let tv denote onedimensional FFT of a vector v itv onedimensional inverse FFT of v and comp onent b b wise multiplication of two vectors The desired pro duct is given by the rst n elements of the vector it t c t w The authors showed that Algorithm requires n logn O n ops real oatingp oint op erations To maintain symmetry and tridiagonality of J we apply complexorthogonal rotations in the QR iterations T J WDW where W is complexorthogonal and D is diagonal Thus we get with X QW The workhorse of our QRlike nn iteration is a complexorthogonal planerotation P C That is P is an identity matrix except for four strategic p ositions formed by the intersection of the ith and j th rows and columns c s p p ii ij G s c p p j i j j T where c s The matrix G is constructed to annihilate the second comp onent of a vector x x x We present our computational schemes in the following Overall Procedure Hankel Eigenvalue Computation Given H compute al l its eigenvalues Apply a Lanczos pro cedure Algorithm to reduce H to a tridiagonal form J Use Algorithm to compute the Hankel matrixvector pro ducts Apply a QRtype pro cedure Algorithm to nd the eigenvalues of J Algorithm Lanczos Tridiagonalization Given H this algorithm computes a tridiagonal matrix J T Initialize q such that q q v H q for j n T q v j j j r v q j j j j if j n q T r r j j j if break end j q r j j j v H q q j j j j end end n Algorithm Fast Hankel MatrixVector Multiplication Given w C compute p H w n b b Construct the vectors c and w as in and Calculate y C by b b y it t c t w T n The desired p C is given by the rst n elements of y p y y y y n n mm Algorithm ComplexSymmetric QR Step Given J C this algorithm implements one step of the QR method with the Wilkinson shift Initialize Q I Find the eigenvalue of J that is closer to J mmmm mm Set x J x J for k m T Find a complexorthogonal matrix P to annihilate x using x k T J P JP k k Q QP k if k m x J x J k k k k end if end for ERROR ANALYSIS FUNDAMENTALS Let u denote the unit roundo Since the ob jective of this pap er is to analyze the stability of our algorithm and not to derive precise error b ounds we carry out rstorder error analysis Sometimes we ignore mo derate constant co ecients The following results for the basic complex arithmetic op erations are from Higham f l x y x y j j u p f l xy xy j j p f l xy xy j j Using and similar to the real case rep eatedly applying we can show that for two nvectors x and y T T T f l x y x y y x x y where n u jy j jy j jxj jxj n n n n u We assume that nu So we can think of as approximately nu n LANCZOS TRIDIAGONALIZATION Analogous to the analysis of the conventional Lanczos tridiagonalization we shall show that column vectors q can j lose corthogonality Let T T b b b b b f l q v q v v j j j j j b for some v It follows immediately from that kv k kv k Thus n j T b b b b b q v jj kq k kv k j j n j j j and b b jb j kq k kv k j n j j If b b b b b q v v b q q r f l v b j j j j j j j for some v and q then and show that p b b b q k kq k kv k ukv b kqk j j j j b Denoting r v b q as the rst order error in r and using we get j j p p b b b b b q k jb j krk ukv b kq k u ukq k kv k j j j j j j j Now from we have p b b b b b b q f l r r r krk kr k j j j j j j that is p b b b b q r r krk kr k j j j j T b To check corthogonality we multiply q on the b oth sides of the ab ove equation j T T T T T b b b b b b b b b b q r r q q q r r q q q v b j j j j j j j j j j j T b b b v b from we get Since q is normalized and q j j j j T T b b b b q q q r r j j j j Next we derive the b ound for krk by using and p p b b b b q k kv b kq k kv k krk j j j j j It follows from and that kr r k krk krk p p b b b b ukq k u kv k kq k kv k j j j j p p p b b ukq k u kv k j j Finally and imply that T b b b b q q j jj kr r k kq k j j j j j p p p b b b kv k kq k u ukq k j j j n Using the approximation nu when nu and ignoring the mo derate constant co ecients we obtain n b b b n kq k kq k kv k j j j T b b u jq q j j j b j j j b b b b The ab ove inequality says that q can lose corthogonality when either j j is small or kq k is large recall that q j j j j b and denote computed results Hence the loss is due to either the cancellation in computing or the growth j j b b in kq k and not the accumulation of roundo errors In the real case kq k and is consistent with the j j b results in Paige whereas in the complex case the norm kq k can b e arbitrarily large This is an additional factor j that causes the loss of corthogonality HANKEL MATRIXVECTOR MULTIPLICATION The only computation in the fast Hankel matrixvector multiplication is b b y it t c t w Denoting the computed y as b b b y f l itt c t w j b we consider the computation of tw Assume that the weights in the FFT are precalculated and that the k j computed weights b satisfy k j j b k j k k where j j k j for all j and k Dep ending on the metho d that computes the weights we can pick cu cu log j or cuj where c denotes a constant dep endent on the metho d Following Higham we let b b b x tw and x f l tw We have p log n b n kxk kx xk log n where Approximately p n log n b kxk kx xk log n Similarly let b b b v tc and v f l tc Then p n log n b kv k kv v k log n b b Next we consider the comp onentwise multiplication z v x Denoting the computed z as b b b z f l v x we have approximately b kz z k u kzk Finally we consider b b b y itz and y f l itz Since F is the FFT matrix we have n F n F n n Thus similar to and we get p n n log b ky k ky y k log n As n F is unitary it follows that n p p b b b b zk n kzk ky k kitz k kF n kzk n n Consequently using and we get log n log n b b ky y k
Recommended publications
  • Polynomials and Hankel Matrices
    View metadata, citation and similar papers at core.ac.uk brought to you by CORE provided by Elsevier - Publisher Connector Polynomials and Hankel Matrices Miroslav Fiedler Czechoslovak Academy of Sciences Institute of Mathematics iitnci 25 115 67 Praha 1, Czechoslovakia Submitted by V. Ptak ABSTRACT Compatibility of a Hankel n X n matrix W and a polynomial f of degree m, m < n, is defined. If m = n, compatibility means that HC’ = CfH where Cf is the companion matrix of f With a suitable generalization of Cr, this theorem is gener- alized to the case that m < n. INTRODUCTION By a Hankel matrix [S] we shall mean a square complex matrix which has, if of order n, the form ( ai +k), i, k = 0,. , n - 1. If H = (~y~+~) is a singular n X n Hankel matrix, the H-polynomial (Pi of H was defined 131 as the greatest common divisor of the determinants of all (r + 1) x (r + 1) submatrices~of the matrix where r is the rank of H. In other words, (Pi is that polynomial for which the nX(n+l)matrix I, 0 0 0 %fb) 0 i 0 0 0 1 LINEAR ALGEBRA AND ITS APPLICATIONS 66:235-248(1985) 235 ‘F’Elsevier Science Publishing Co., Inc., 1985 52 Vanderbilt Ave., New York, NY 10017 0024.3795/85/$3.30 236 MIROSLAV FIEDLER is the Smith normal form [6] of H,. It has also been shown [3] that qN is a (nonzero) polynomial of degree at most T. It is known [4] that to a nonsingular n X n Hankel matrix H = ((Y~+~)a linear pencil of polynomials of degree at most n can be assigned as follows: f(x) = fo + f,x + .
    [Show full text]
  • Inverse Problems for Hankel and Toeplitz Matrices
    View metadata, citation and similar papers at core.ac.uk brought to you by CORE provided by Elsevier - Publisher Connector Inverse Problems for Hankel and Toeplitz Matrices Georg Heinig Vniversitiit Leipzig Sektion Mathematik Leipzig 7010, Germany Submitted by Peter Lancaster ABSTRACT The problem is considered how to construct a Toeplitz or Hankel matrix A from one or two equations of the form Au = g. The general solution is described explicitly. Special cases are inverse spectral problems for Hankel and Toeplitz matrices and problems from the theory of orthogonal polynomials. INTRODUCTION When we speak of inverse problems we have in mind the following type of problems: Given vectors uj E C”, gj E C”’ (j = l,.. .,T), we ask for an m x n matrix A of a certain matrix class such that Auj = gj (j=l,...,?-). (0.1) In the present paper we deal with inverse problems with the additional condition that A is a Hankel matrix [ si +j] or a Toeplitz matrix [ ci _j]. Inverse problems for Hankel and Toeplitz matices occur, for example, in the theory of orthogonal polynomials when a measure p on the real line or the unit circle is wanted such that given polynomials are orthogonal with respect to this measure. The moment matrix of p is just the solution of a certain inverse problem and is Hankel (in the real line case) or Toeplitz (in the unit circle case); here the gj are unit vectors. LINEAR ALGEBRA AND ITS APPLICATIONS 165:1-23 (1992) 1 0 Elsevier Science Publishing Co., Inc., 1992 655 Avenue of tbe Americas, New York, NY 10010 0024-3795/92/$5.00 2 GEORG HEINIG Inverse problems for Toeplitz matrices were considered for the first time in the paper [lo]of M.
    [Show full text]
  • Deflation by Restriction for the Inverse-Free Preconditioned Krylov Subspace Method
    NUMERICAL ALGEBRA, doi:10.3934/naco.2016.6.55 CONTROL AND OPTIMIZATION Volume 6, Number 1, March 2016 pp. 55{71 DEFLATION BY RESTRICTION FOR THE INVERSE-FREE PRECONDITIONED KRYLOV SUBSPACE METHOD Qiao Liang Department of Mathematics University of Kentucky Lexington, KY 40506-0027, USA Qiang Ye∗ Department of Mathematics University of Kentucky Lexington, KY 40506-0027, USA (Communicated by Xiaoqing Jin) Abstract. A deflation by restriction scheme is developed for the inverse-free preconditioned Krylov subspace method for computing a few extreme eigen- values of the definite symmetric generalized eigenvalue problem Ax = λBx. The convergence theory for the inverse-free preconditioned Krylov subspace method is generalized to include this deflation scheme and numerical examples are presented to demonstrate the convergence properties of the algorithm with the deflation scheme. 1. Introduction. The definite symmetric generalized eigenvalue problem for (A; B) is to find λ 2 R and x 2 Rn with x 6= 0 such that Ax = λBx (1) where A; B are n × n symmetric matrices and B is positive definite. The eigen- value problem (1), also referred to as a pencil eigenvalue problem (A; B), arises in many scientific and engineering applications, such as structural dynamics, quantum mechanics, and machine learning. The matrices involved in these applications are usually large and sparse and only a few of the eigenvalues are desired. Iterative methods such as the Lanczos algorithm and the Arnoldi algorithm are some of the most efficient numerical methods developed in the past few decades for computing a few eigenvalues of a large scale eigenvalue problem, see [1, 11, 19].
    [Show full text]
  • Hankel Matrix Rank Minimization with Applications to System Identification and Realization ∗
    HANKEL MATRIX RANK MINIMIZATION WITH APPLICATIONS TO SYSTEM IDENTIFICATION AND REALIZATION ∗ y z x { MARYAM FAZEL , TING KEI PONG , DEFENG SUN , AND PAUL TSENG In honor of Professor Paul Tseng, who went missing while on a kayak trip on the Jinsha river, China, on August 13, 2009, for his contributions to the theory and algorithms for large-scale optimization. Abstract. In this paper, we introduce a flexible optimization framework for nuclear norm minimization of matrices with linear structure, including Hankel, Toeplitz and moment structures, and catalog applications from diverse fields under this framework. We discuss various first-order methods for solving the resulting optimization problem, including alternating direction methods, proximal point algorithm and gradient projection methods. We perform computational experiments to compare these methods on system identification problem and system realization problem. For the system identification problem, the gradient projection method (accelerated by Nesterov's extrapola- tion techniques) and the proximal point algorithm usually outperform other first-order methods in terms of CPU time on both real and simulated data, for small and large regularization parameters respectively; while for the system realization problem, the alternating direction method, as applied to a certain primal reformulation, usually outperforms other first-order methods in terms of CPU time. Key words. Rank minimization, nuclear norm, Hankel matrix, first-order method, system identification, system realization 1. Introduction. The matrix rank minimization problem, or minimizing the rank of a matrix subject to convex constraints, has recently attracted much renewed interest. This problem arises in many engineering and statistical modeling application- s, where notions of order, dimensionality, or complexity of a model can be expressed by the rank of an appropriate matrix.
    [Show full text]
  • Exponential Decomposition and Hankel Matrix
    Exponential Decomposition and Hankel Matrix Franklin T. Luk Department of Computer Science and Engineering, Chinese University of Hong Kong, Shatin, NT, Hong Kong. [email protected] Sanzheng Qiao Department of Computing and Software, McMaster University, Hamilton, Ontario L8S 4L7 Canada. [email protected] David Vandevoorde Edison Design Group, Belmont, CA 94002-3112 USA. [email protected] 1 Introduction We consider an important problem in mathematical modeling: Exponential Decomposition. Given a finite sequence of signal values {s1,s2,...,sn}, determine a minimal positive integer r, complex coefficients {c1,c2,...,cr}, and distinct complex knots {z1,z2,...,zr}, so that the following exponential decomposition signal model is satisfied: r − s = c zk 1, for k =1,...,n. (1.1) k X i i i=1 We usually solve the above problem in three steps. First, determine the rank r of the signal sequence. Second, find the knots zi. Third, calculate the coefficients {ci} by solving an r × r Vandermonde system: W (r)c = s(r), (1.2) where 1 1 · · · 1 c1 s1 z1 z2 · · · zr c2 s2 (r) (r) W = . , c = . and s = . . . .. . . r−1 r−1 r−1 z1 z2 · · · zr cr sr A square Vandermonde system (1.2) can be solved efficiently and stably (see [1]). 275 276 Exponential Decomposition and Hankel Matrix There are two well known methods for solving our problem, namely, Prony [8] and Kung [6]. Vandevoorde [9] presented a single matrix pencil based framework that includes [8] and [6] as special cases. By adapting an implicit Lanczos pro- cess in our matrix pencil framework, we present an exponential decomposition algorithm which requires only O(n2) operations and O(n) storage, compared to O(n3) operations and O(n2) storage required by previous methods.
    [Show full text]
  • A Generalized Eigenvalue Algorithm for Tridiagonal Matrix Pencils Based on a Nonautonomous Discrete Integrable System
    A generalized eigenvalue algorithm for tridiagonal matrix pencils based on a nonautonomous discrete integrable system Kazuki Maedaa, , Satoshi Tsujimotoa ∗ aDepartment of Applied Mathematics and Physics, Graduate School of Informatics, Kyoto University, Kyoto 606-8501, Japan Abstract A generalized eigenvalue algorithm for tridiagonal matrix pencils is presented. The algorithm appears as the time evolution equation of a nonautonomous discrete integrable system associated with a polynomial sequence which has some orthogonality on the support set of the zeros of the characteristic polynomial for a tridiagonal matrix pencil. The convergence of the algorithm is discussed by using the solution to the initial value problem for the corresponding discrete integrable system. Keywords: generalized eigenvalue problem, nonautonomous discrete integrable system, RII chain, dqds algorithm, orthogonal polynomials 2010 MSC: 37K10, 37K40, 42C05, 65F15 1. Introduction Applications of discrete integrable systems to numerical algorithms are important and fascinating top- ics. Since the end of the twentieth century, a number of relationships between classical numerical algorithms and integrable systems have been studied (see the review papers [1–3]). On this basis, new algorithms based on discrete integrable systems have been developed: (i) singular value algorithms for bidiagonal matrices based on the discrete Lotka–Volterra equation [4, 5], (ii) Pade´ approximation algorithms based on the dis- crete relativistic Toda lattice [6] and the discrete Schur flow [7], (iii) eigenvalue algorithms for band matrices based on the discrete hungry Lotka–Volterra equation [8] and the nonautonomous discrete hungry Toda lattice [9], and (iv) algorithms for computing D-optimal designs based on the nonautonomous discrete Toda (nd-Toda) lattice [10] and the discrete modified KdV equation [11].
    [Show full text]
  • Paperfolding and Catalan Numbers Roland Bacher
    Paperfolding and Catalan numbers Roland Bacher To cite this version: Roland Bacher. Paperfolding and Catalan numbers. 2004. hal-00002104 HAL Id: hal-00002104 https://hal.archives-ouvertes.fr/hal-00002104 Preprint submitted on 17 Jun 2004 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. Paperfolding and Catalan numbers Roland Bacher June 17, 2004 Abstract1: This paper reproves a few results concerning paperfolding sequences using properties of Catalan numbers modulo 2. The guiding prin- ciple can be described by: Paperfolding = Catalan modulo 2 + signs given by 2−automatic sequences. 1 Main results In this paper, a continued fraction is a formal expression a b + 1 = b + a b + a b + . 0 b + a2 0 1 1 2 2 1 b2+... with b0, b1,...,a1, a2,... ∈ C[x] two sequences of complex rational functions. We denote such a continued fraction by a1| a2| ak| b0 + + + . + + . |b1 |b2 |bk and call it convergent if the coefficients of the (formal) Laurent-series ex- pansions of its partial convergents P0 b0 P1 b0b1 + a1 Pk a1| a2| ak| = , = ,..., = b0 + + + . + ,... Q0 1 Q1 b1 Qk |b1 |b2 |bk k C 1 are ultimately constant.
    [Show full text]
  • Introduction to Mathematical Programming
    Introduction to Mathematical Programming Ming Zhong Lecture 24 October 29, 2018 Ming Zhong (JHU) AMS Fall 2018 1 / 18 Singular Value Decomposition (SVD) Table of Contents 1 Singular Value Decomposition (SVD) Ming Zhong (JHU) AMS Fall 2018 2 / 18 Singular Value Decomposition (SVD) Matrix Decomposition n×n We have discussed several decomposition techniques (for A 2 R ), A = LU when A is non-singular (Gaussian elimination). A = LL> when A is symmetric positive definite (Cholesky). A = QR for any real square matrix (unique when A is non-singular). A = PDP−1 if A has n linearly independent eigen-vectors). A = PJP−1 for any real square matrix. We are now ready to discuss the Singular Value Decomposition (SVD), A = UΣV∗; m×n m×m n×n m×n for any A 2 C , U 2 C , V 2 C , and Σ 2 R . Ming Zhong (JHU) AMS Fall 2018 3 / 18 Singular Value Decomposition (SVD) Some Brief History Going back in time, It was originally developed by differential geometers, equivalence of bi-linear forms by independent orthogonal transformation. Eugenio Beltrami in 1873, independently Camille Jordan in 1874, for bi-linear forms. James Joseph Sylvester in 1889 did SVD for real square matrices, independently; singular values = canonical multipliers of the matrix. Autonne in 1915 did SVD via polar decomposition. Carl Eckart and Gale Young in 1936 did the proof of SVD of rectangular and complex matrices, as a generalization of the principal axis transformaton of the Hermitian matrices. Erhard Schmidt in 1907 defined SVD for integral operators. Emile´ Picard in 1910 is the first to call the numbers singular values.
    [Show full text]
  • Inexact and Nonlinear Extensions of the FEAST Eigenvalue Algorithm
    University of Massachusetts Amherst ScholarWorks@UMass Amherst Doctoral Dissertations Dissertations and Theses October 2018 Inexact and Nonlinear Extensions of the FEAST Eigenvalue Algorithm Brendan E. Gavin University of Massachusetts Amherst Follow this and additional works at: https://scholarworks.umass.edu/dissertations_2 Part of the Numerical Analysis and Computation Commons, and the Numerical Analysis and Scientific Computing Commons Recommended Citation Gavin, Brendan E., "Inexact and Nonlinear Extensions of the FEAST Eigenvalue Algorithm" (2018). Doctoral Dissertations. 1341. https://doi.org/10.7275/12360224 https://scholarworks.umass.edu/dissertations_2/1341 This Open Access Dissertation is brought to you for free and open access by the Dissertations and Theses at ScholarWorks@UMass Amherst. It has been accepted for inclusion in Doctoral Dissertations by an authorized administrator of ScholarWorks@UMass Amherst. For more information, please contact [email protected]. INEXACT AND NONLINEAR EXTENSIONS OF THE FEAST EIGENVALUE ALGORITHM A Dissertation Presented by BRENDAN GAVIN Submitted to the Graduate School of the University of Massachusetts Amherst in partial fulfillment of the requirements for the degree of DOCTOR OF PHILOSOPHY September 2018 Electrical and Computer Engineering c Copyright by Brendan Gavin 2018 All Rights Reserved INEXACT AND NONLINEAR EXTENSIONS OF THE FEAST EIGENVALUE ALGORITHM A Dissertation Presented by BRENDAN GAVIN Approved as to style and content by: Eric Polizzi, Chair Zlatan Aksamija, Member
    [Show full text]
  • Matrix Theory
    Matrix Theory Xingzhi Zhan +VEHYEXI7XYHMIW MR1EXLIQEXMGW :SPYQI %QIVMGER1EXLIQEXMGEP7SGMIX] Matrix Theory https://doi.org/10.1090//gsm/147 Matrix Theory Xingzhi Zhan Graduate Studies in Mathematics Volume 147 American Mathematical Society Providence, Rhode Island EDITORIAL COMMITTEE David Cox (Chair) Daniel S. Freed Rafe Mazzeo Gigliola Staffilani 2010 Mathematics Subject Classification. Primary 15-01, 15A18, 15A21, 15A60, 15A83, 15A99, 15B35, 05B20, 47A63. For additional information and updates on this book, visit www.ams.org/bookpages/gsm-147 Library of Congress Cataloging-in-Publication Data Zhan, Xingzhi, 1965– Matrix theory / Xingzhi Zhan. pages cm — (Graduate studies in mathematics ; volume 147) Includes bibliographical references and index. ISBN 978-0-8218-9491-0 (alk. paper) 1. Matrices. 2. Algebras, Linear. I. Title. QA188.Z43 2013 512.9434—dc23 2013001353 Copying and reprinting. Individual readers of this publication, and nonprofit libraries acting for them, are permitted to make fair use of the material, such as to copy a chapter for use in teaching or research. Permission is granted to quote brief passages from this publication in reviews, provided the customary acknowledgment of the source is given. Republication, systematic copying, or multiple reproduction of any material in this publication is permitted only under license from the American Mathematical Society. Requests for such permission should be addressed to the Acquisitions Department, American Mathematical Society, 201 Charles Street, Providence, Rhode Island 02904-2294 USA. Requests can also be made by e-mail to [email protected]. c 2013 by the American Mathematical Society. All rights reserved. The American Mathematical Society retains all rights except those granted to the United States Government.
    [Show full text]
  • Forward-Backward Hankel Matrix Fitting for Spectral Super-Resolution
    Forward-Backward Hankel Matrix Fitting for Spectral Super-Resolution Zai Yang and Xunmeng Wu School of Mathematics and Statistics, Xi’an Jiaotong University, Xi’an 710049, China [email protected] Abstract—Hankel-based approaches form an important class which eventually results in simple algorithm design [6]–[8]. of methods for line spectral estimation within the recent spec- However, this causes a fundamental limitation of Hankel- tral super-resolution framework. However, they suffer from the based methods, to be specific, the estimated poles do not fundamental limitation that their estimated signal poles do not lie on the unit circle in general, causing difficulties of physical lie on the unit circle in general, resulting in difficulties of interpretation and performance loss. In this paper, we present physical interpretation and potential performance loss (see the a modified Hankel approach called forward-backward Hankel main context). This paper aims at resolving this fundamental matrix fitting (FB-Hankel) that can be implemented by simply problem. modifying the existing algorithms. We show analytically that In this paper, by using the classic forward-backward tech- the new approach has great potential to restrict the estimated poles on the unit circle. Numerical results are provided that nique [9], we propose a modified Hankel-based approach for corroborate our analysis and demonstrate the advantage of FB- line spectral estimation, named as forward-backward Hankel Hankel in improving the estimation accuracy. 1 matrix fitting (FB-Hankel). The core of FB-Hankel is introduc- Index Terms—Forward-backward Hankel matrix fitting, line ing a (conjugated) backward Hankel matrix which is composed spectral estimation, spectral super-resolution, Vandermonde de- of the same spectral modes as and processed jointly with composition, Kronecker’s theorem.
    [Show full text]
  • A Panorama of Positivity
    A PANORAMA OF POSITIVITY ALEXANDER BELTON, DOMINIQUE GUILLOT, APOORVA KHARE, AND MIHAI PUTINAR Abstract. This survey contains a selection of topics unified by the concept of positive semi-definiteness (of matrices or kernels), reflecting natural constraints imposed on discrete data (graphs or networks) or continuous objects (probability or mass distributions). We put empha- sis on entrywise operations which preserve positivity, in a variety of guises. Techniques from harmonic analysis, function theory, operator theory, statistics, combinatorics, and group representations are invoked. Some partially forgotten classical roots in metric geometry and distance transforms are presented with comments and full bibliographical refer- ences. Modern applications to high-dimensional covariance estimation and regularization are included. Contents 1. Introduction 2 2. From metric geometry to matrix positivity 4 2.1. Distance geometry 4 2.2. Spherical distance geometry 6 2.3. Distance transforms 6 2.4. Altering Euclidean distance 8 2.5. Positive definite functions on homogeneous spaces 11 2.6. Connections to harmonic analysis 15 3. Entrywise functions preserving positivity in all dimensions 18 Date: November 13, 2019. 2010 Mathematics Subject Classification. 15-02, 26-02, 15B48, 51F99, 15B05, 05E05, arXiv:1812.05482v3 [math.CA] 12 Nov 2019 44A60, 15A24, 15A15, 15A45, 15A83, 47B35, 05C50, 30E05, 62J10. Key words and phrases. metric geometry, positive semidefinite matrix, Toeplitz ma- trix, Hankel matrix, positive definite function, completely monotone functions, absolutely monotonic functions, entrywise calculus, generalized Vandermonde matrix, Schur polyno- mials, symmetric function identities, totally positive matrices, totally non-negative matri- ces, totally positive completion problem, sample covariance, covariance estimation, hard / soft thresholding, sparsity pattern, critical exponent of a graph, chordal graph, Loewner monotonicity, convexity, and super-additivity.
    [Show full text]