Lecture 5: Ecological Distance Metrics; Principal Coordinates Analysis

Total Page:16

File Type:pdf, Size:1020Kb

Lecture 5: Ecological Distance Metrics; Principal Coordinates Analysis Lecture 5: Ecological distance metrics; Principal Coordinates Analysis Univariate testing vs. community analysis • Univariate testing deals with hypotheses concerning individual taxa – Is this taxon differentially present/abundant in different samples? – Is this taxon correlated with a given continuous variable? • What if we would like to draw conclusions about the community as a whole? 2 Useful ideas from modern statistics • Distances between anything (abundances, presence-absence, graphs, trees) • Direct hypotheses based on distances. • Decompositions through iterative structuration. • Projections. • Randomization tests, probabilistic simulations. 3 Data à Distances à Statistics S-1 S-2 … S-16 0.54 0.54 0.34 OTU-1 0.60 0.17 0.10 0.01 0.75 0.17 0.72 OTU-2 0.24 0.34 0.74 0.89 0.58 0.08 0.43 0.82 0.91 0.69 0.64 OTU-3 0.57 0.06 0.59 0.03 0.69 0.89 0.07 OTU-4 0.88 0.68 0.59 0.49 0.19 0.64 0.54 0.26 0.24 0.71 0.58 0.52 0.93 0.94 0.46 0.70 0.30 OTU-5 0.92 0.46 0.17 0.21 0.17 0.02 0.81 0.22 0.45 0.59 0.51 0.23 0.74 0.36 0.15 1.00 0.95 0.71 0.88 0.94 0.65 …. 0.29 0.30 0.75 0.28 0.04 0.45 0.15 0.44 0.59 0.89 0.07 0.19 0.57 0.63 0.27 0.72 0.34 0.70 0.19 0.17 0.85 0.07 0.97 0.24 0.45 OTU-10,000 0.95 0.53 0.86 0.01 0.10 0.63 0.40 0.10 0.51 1.00 0.20 0.41 0.11 0.14 0.83 0.43 0.12 0.39 0.43 0.87 0.42 0.17 0.62 0.57 0.03 0.58 0.54 0.48 0.83 Visualization (Principal coordinates analysis) Statistical hypothesis testing (PERMANOVA) 4 What is a distance metric? • Scalar function d(.,.) of two arguments • d(x, y) >= 0, always nonnegative; • d(x, x) = 0, distance to self is 0; • d(x, y) = d(y, x), distance is symmetric; • d(x, y) < d(x, z) + d(z, y), triangle inequality. 5 Using distances to capture multidimensional heterogeneous information • A “good” distance will enable us to analyze any type of data usefully • We can build specialized distances that incorporate different types of information (abundance, trees, geographical locations, etc.) • We can visualize complex data as long as we know the distances between objects (observations, variables) • We can compute distances (correlations) between distances to compare them • We can decompose the sources of variability contributing to distances in ANOVA-like fashion 6 Distance and similarity • Sometimes it is conceptually easier to talk about similarities rather than distances – E.g. sequence similarity • Any similarity measure can be converted into a distance metric, e.g. – S – If S is (0, 1), D=1-S – If S>0, D = 1/S or D = exp(-S) 7 A few useful distances and similarity indices • Distances: 2 – Euclidean: (remember Pythagoras theorem) Σ(xi-yi) 2 2 – Weighted Euclidean: χ = Σ(ei - oi) /ei – Hamming/L1, Bray Curtis = Σ 1{xi=yi} – Unifrac (later) – Jensen-Shannon: (D(X|M) + D(Y|M))/2, where • M = (X + Y)/2 • Kullback-Leibler divergence: D(X|Y) = Σ ln[xi/yi]xi x\y 1 0 • Similarity: 1 f11 f10 – Correlation coefficient 0 f01 f00 – Matching coefficient: (f11+f00)/(f11 + f10 + f01 + f00) – JaccardSimilarity Index: f11/(f11 + f10 + f01) 8 Unifracdistance (Lozupone and Knight, 2005) • Is a distance between groups of organisms related by a tree • Definition: Ratio of the sum of the length of the branches leading to sample X or Y, but not both, to the sum of all branch lengths of the tree. matrix data.frame matrix Sample Variables sampleData Phylogenetic Tree OTU Abundance slots: .Data, Taxonomy Table class: phylo class: otuTable names, taxonomyTable slots: see ape slots: .Data, row.names, slots: .Data speciesAreRows .S3Class package Component data objects: phyloseq slots: otuTable Experiment-level data object: sampleData taxTab tre 9 Weighted Unifrac(Lozupone et al., 2007) × | − | !=1 = 10 A note of warning! • “Garbage in, garbage out” • Wrong normalization => wrong distance => wrong answer • However, given the many choices there isn’t much beyond prior knowledge, experience and intuition to guide in selection of the distance. 11 Distance matrix • It is convenient to organize distances as a matrix, A=(aij) • Distance matrices are: – Symmetric: aij = aji – Diagonals are 0: aii = 0. • A distance matrix is Euclidean if it is possible to generate these distances from a set of n points in Euclidean space. • Distance matrix is commonly represented by just lower (or upper) diagonal entries. 12 Some uses of distances • Suppose D is a distance matrix for n objects. The objects are of several kinds indicated by a factor variable F; • Intra-group distances are the distances between objects of the same kind; • Inter-group distances are the distances between objects of different kinds; • Mean distance between an object and a group of other objects is equal to the distance between the object and the center of the group. 13 PRINCIPAL COORDINATE ANALYSIS 14 Vector A vector, v, of dimension n is an n × 1 rectangular array of elements ! v $ # 1 & # v2 & v = # & # ! & v "# n %& vectors will be column vectors. They may also be row vectors, when transposed T v =[v1, v2, … , vn]. 15 A vector, v, of dimension n ! v $ # 1 & # v2 & v = # & # ! & v "# n %& can be thought a point in n dimensional space 16 Every multivariate sample can be represented as a vector in some vector space v3 ⎡⎤v1 v ⎢⎥v = ⎢⎥2 ⎣⎦⎢⎥v3 v2 v 1 17 Vector Basis • A basis is a set of linearly independent (dot product is zero) vectors that span the vector space. • Spanning the vector space: Any vector in this vector space may be represented as a linear combination of the basis vectors. • The vectors forming a basis are orthogonal to each other. If all the vectors are of length 1, then the basis is called orthonormal. 18 Matrix An n × m matrix, A, is a rectangular array of elements ! a a ! a $ # 11 12 1m & # a21 a22 ! a2m & A = (aij ) = # & # " " # " & a a a "# n1 n2 … nm %& n = # of rows m = # of columns dimensions = n × m 19 Note: Let A and B be two matrices whose inverse exists. Let C = AB. Then the inverse of the matrix C exists and C-1 = B-1A-1. Proof C[B-1A-1] = [AB][B-1A-1] = A[B B-1]A-1 = A[I]A-1 = AA-1=I 20 Diagonalization Thereom If the matrix A is symmetric with distinct eigenvalues, , … , , with λ1 λ!n ! corresponding eigenvectors x ,…,x ! ! 1 n Assume x!x =1 i !i ! ! ! then A = λ1x1x1! +…+ λn xn x!n ! $! ! $ λ1 " 0 x1' ! ! # &# & = x ,…, x # # $ # &# &= PDPʹ [ 1 n ] ! # 0 " λ &# x' & "# n %&"# n %& 21 Basic idea for analysis of multidimensional data • Compute distances • Reduce dimensions • Embed in Euclidean space • The general framework behind this process is called Duality diagram: (Xnxp, Qpxp, Dnxn) – Xnxp (centered) data matrix – Qpxp column weights (weights on variables) – Dnxn row weights (weights on observations) 22 S. Holmes/The French way. 2 which were translated into English. My PhD advisor, Yves Escoufier [8][10] pub- licized the method to biologists and ecologists presenting a formulation based on his RV-coefficient, that I will develop below. The first software implementation of duality based methods described here were done in LEAS (1984) a Pascal program written for Apple II computers. The most recent implementation is the R pack- age ade-4 (see A for a review of various implementations of the methods described here). 2.1. Notation The data are p variables measures on n observations. They are recorded in a matrix X with n rows (the observations) and p columns (the variables). Dn is an nxn matrix of weights on the ”observations”, most often diagonal. We will also use a ”neighborhood” relation (thought of as a metric on the observations) defined by taking a symmetric definite positive matrix Q. For example, to standardize the variables Q can be chosen as 1 2 000... σ1 1 0 2 00... σ2 Q = 0 1 1 . 00 2 0 ... σ3 B 1 C B ... ... ... 0 2 C B σp C @ A These three matrices form the essential ”triplet” (X, Q, D) defining a multivariate data analysis. As the approach here is geometrical, it is important to see that Q and D define geometries or inner products in Rp and Rn respectively through t p x Qy =<x,y>Q x, y R t 2 n x Dy =<x,y>D x, y R 2 From these definitions we see there is a close relation between this approach and kernel based methods, for more details see [24]. Q can be seen as a linear function p p p p from R to R ⇤ = (R ),Duality diagram defines the geometry the space of scalar linear functions on R . D can be seen L n n n as a linear function from R to R ⇤ = (R ). Escoufier[8] proposed to associate to Lof multivariate analysis a data set an operator from the space of observations Rp into the dual of the space T n • V = X DX of variables R ⇤. This is summarized in the following diagram [1] which is made T commutative by defining V and W as XtDX and XQXt respectively.• W = XQX p n • Duality: R ⇤ R −−!X – The eigen Q VDW decomposition of VQ x ? ? x leads to eigen- ? p? ? n? ? R ? ?R ⇤? decomposition of WD ? y Xt y ? • Inertiais equal to trace This is known as the duality diagram because knowledge of the eigendecompo- sition of XtDXQ = VQ leads to that of the dual operator XQX(sum tD.
Recommended publications
  • Eigenvalues of Euclidean Distance Matrices and Rs-Majorization on R2
    Archive of SID 46th Annual Iranian Mathematics Conference 25-28 August 2015 Yazd University 2 Talk Eigenvalues of Euclidean distance matrices and rs-majorization on R pp.: 1{4 Eigenvalues of Euclidean Distance Matrices and rs-majorization on R2 Asma Ilkhanizadeh Manesh∗ Department of Pure Mathematics, Vali-e-Asr University of Rafsanjan Alemeh Sheikh Hoseini Department of Pure Mathematics, Shahid Bahonar University of Kerman Abstract Let D1 and D2 be two Euclidean distance matrices (EDMs) with correspond- ing positive semidefinite matrices B1 and B2 respectively. Suppose that λ(A) = ((λ(A)) )n is the vector of eigenvalues of a matrix A such that (λ(A)) ... i i=1 1 ≥ ≥ (λ(A))n. In this paper, the relation between the eigenvalues of EDMs and those of the 2 corresponding positive semidefinite matrices respect to rs, on R will be investigated. ≺ Keywords: Euclidean distance matrices, Rs-majorization. Mathematics Subject Classification [2010]: 34B15, 76A10 1 Introduction An n n nonnegative and symmetric matrix D = (d2 ) with zero diagonal elements is × ij called a predistance matrix. A predistance matrix D is called Euclidean or a Euclidean distance matrix (EDM) if there exist a positive integer r and a set of n points p1, . , pn r 2 2 { } such that p1, . , pn R and d = pi pj (i, j = 1, . , n), where . denotes the ∈ ij k − k k k usual Euclidean norm. The smallest value of r that satisfies the above condition is called the embedding dimension. As is well known, a predistance matrix D is Euclidean if and 1 1 t only if the matrix B = − P DP with P = I ee , where I is the n n identity matrix, 2 n − n n × and e is the vector of all ones, is positive semidefinite matrix.
    [Show full text]
  • Polynomial Approximation Algorithms for Belief Matrix Maintenance in Identity Management
    Polynomial Approximation Algorithms for Belief Matrix Maintenance in Identity Management Hamsa Balakrishnan, Inseok Hwang, Claire J. Tomlin Dept. of Aeronautics and Astronautics, Stanford University, CA 94305 hamsa,ishwang,[email protected] Abstract— Updating probabilistic belief matrices as new might be constrained to some prespecified (but not doubly- observations arrive, in the presence of noise, is a critical part stochastic) row and column sums. This paper addresses the of many algorithms for target tracking in sensor networks. problem of updating belief matrices by scaling in the face These updates have to be carried out while preserving sum constraints, arising for example, from probabilities. This paper of uncertainty in the system and the observations. addresses the problem of updating belief matrices to satisfy For example, consider the case of the belief matrix for a sum constraints using scaling algorithms. We show that the system with three objects (labelled 1, 2 and 3). Suppose convergence behavior of the Sinkhorn scaling process, used that, at some instant, we are unsure about their identities for scaling belief matrices, can vary dramatically depending (tagged X, Y and Z) completely, and our belief matrix is on whether the prior unscaled matrix is exactly scalable or only almost scalable. We give an efficient polynomial-time algo- a 3 × 3 matrix with every element equal to 1/3. Let us rithm based on the maximum-flow algorithm that determines suppose the we receive additional information that object whether a given matrix is exactly scalable, thus determining 3 is definitely Z. Then our prior, but constraint violating the convergence properties of the Sinkhorn scaling process.
    [Show full text]
  • On the Eigenvalues of Euclidean Distance Matrices
    “main” — 2008/10/13 — 23:12 — page 237 — #1 Volume 27, N. 3, pp. 237–250, 2008 Copyright © 2008 SBMAC ISSN 0101-8205 www.scielo.br/cam On the eigenvalues of Euclidean distance matrices A.Y. ALFAKIH∗ Department of Mathematics and Statistics University of Windsor, Windsor, Ontario N9B 3P4, Canada E-mail: [email protected] Abstract. In this paper, the notion of equitable partitions (EP) is used to study the eigenvalues of Euclidean distance matrices (EDMs). In particular, EP is used to obtain the characteristic poly- nomials of regular EDMs and non-spherical centrally symmetric EDMs. The paper also presents methods for constructing cospectral EDMs and EDMs with exactly three distinct eigenvalues. Mathematical subject classification: 51K05, 15A18, 05C50. Key words: Euclidean distance matrices, eigenvalues, equitable partitions, characteristic poly- nomial. 1 Introduction ( ) An n ×n nonzero matrix D = di j is called a Euclidean distance matrix (EDM) 1, 2,..., n r if there exist points p p p in some Euclidean space < such that i j 2 , ,..., , di j = ||p − p || for all i j = 1 n where || || denotes the Euclidean norm. i , ,..., Let p , i ∈ N = {1 2 n}, be the set of points that generate an EDM π π ( , ,..., ) D. An m-partition of D is an ordered sequence = N1 N2 Nm of ,..., nonempty disjoint subsets of N whose union is N. The subsets N1 Nm are called the cells of the partition. The n-partition of D where each cell consists #760/08. Received: 07/IV/08. Accepted: 17/VI/08. ∗Research supported by the Natural Sciences and Engineering Research Council of Canada and MITACS.
    [Show full text]
  • Smith Normal Formal of Distance Matrix of Block Graphs∗†
    Ann. of Appl. Math. 32:1(2016); 20-29 SMITH NORMAL FORMAL OF DISTANCE MATRIX OF BLOCK GRAPHS∗y Jing Chen1;2,z Yaoping Hou2 (1. The Center of Discrete Math., Fuzhou University, Fujian 350003, PR China; 2. School of Math., Hunan First Normal University, Hunan 410205, PR China) Abstract A connected graph, whose blocks are all cliques (of possibly varying sizes), is called a block graph. Let D(G) be its distance matrix. In this note, we prove that the Smith normal form of D(G) is independent of the interconnection way of blocks and give an explicit expression for the Smith normal form in the case that all cliques have the same size, which generalize the results on determinants. Keywords block graph; distance matrix; Smith normal form 2000 Mathematics Subject Classification 05C50 1 Introduction Let G be a connected graph (or strong connected digraph) with vertex set f1; 2; ··· ; ng. The distance matrix D(G) is an n × n matrix in which di;j = d(i; j) denotes the distance from vertex i to vertex j: Like the adjacency matrix and Lapla- cian matrix of a graph, D(G) is also an integer matrix and there are many results on distance matrices and their applications. For distance matrices, Graham and Pollack [10] proved a remarkable result that gives a formula of the determinant of the distance matrix of a tree depend- ing only on the number n of vertices of the tree. The determinant is given by det D = (−1)n−1(n − 1)2n−2: This result has attracted much interest in algebraic graph theory.
    [Show full text]
  • Arxiv:1803.06211V1 [Math.NA] 16 Mar 2018
    A NUMERICAL MODEL FOR THE CONSTRUCTION OF FINITE BLASCHKE PRODUCTS WITH PREASSIGNED DISTINCT CRITICAL POINTS CHRISTER GLADER AND RAY PORN¨ Abstract. We present a numerical model for determining a finite Blaschke product of degree n + 1 having n preassigned distinct critical points z1; : : : ; zn in the complex (open) unit disk D. The Blaschke product is uniquely determined up to postcomposition with conformal automor- phisms of D. The proposed method is based on the construction of a sparse nonlinear system where the data dependency is isolated to two vectors and on a certain transformation of the critical points. The effi- ciency and accuracy of the method is illustrated in several examples. 1. Introduction A finite Blaschke product of degree n is a rational function of the form n Y z − αj (1.1) B(z) = c ; c; α 2 ; jcj = 1; jα j < 1 ; 1 − α z j C j j=1 j which thereby has all its zeros in the open unit disc D, all poles outside the closed unit disc D and constant modulus jB(z)j = 1 on the unit circle T. The overbar in (1.1) and in the sequel stands for complex conjugation. The finite Blaschke products of degree n form a subset of the rational functions of degree n which are unimodular on T. These functions are given by all fractions n ~ a0 + a1 z + ::: + an z (1.2) B(z) = n ; a0; :::; an 2 C : an + an−1 z + ::: + a0 z An irreducible rational function of form (1.2) is a finite Blaschke product when all its zeros are in D.
    [Show full text]
  • Distance Matrix and Laplacian of a Tree with Attached Graphs R.B
    Linear Algebra and its Applications 411 (2005) 295–308 www.elsevier.com/locate/laa Distance matrix and Laplacian of a tree with attached graphs R.B. Bapat ∗ Indian Statistical Institute, Delhi Centre, 7 S.J.S.S. Marg, New Delhi 110 016, India Received 5 November 2003; accepted 22 June 2004 Available online 7 August 2004 Submitted by S. Hedayat Abstract A tree with attached graphs is a tree, together with graphs defined on its partite sets. We introduce the notion of incidence matrix, Laplacian and distance matrix for a tree with attached graphs. Formulas are obtained for the minors of the incidence matrix and the Laplacian, and for the inverse and the determinant of the distance matrix. The case when the attached graphs themselves are trees is studied more closely. Several known results, including the Matrix Tree theorem, are special cases when the tree is a star. The case when the attached graphs are paths is also of interest since it is related to the transportation problem. © 2004 Elsevier Inc. All rights reserved. AMS classification: 15A09; 15A15 Keywords: Tree; Distance matrix; Resistance distance; Laplacian matrix; Determinant; Transportation problem 1. Introduction Minors of matrices associated with a graph has been an area of considerable inter- est, starting with the celebrated Matrix Tree theorem of Kirchhoff which asserts that any cofactor of the Laplacian matrix equals the number of spanning trees in the ∗ Fax: +91 11 26856779. E-mail address: [email protected] 0024-3795/$ - see front matter 2004 Elsevier Inc. All rights reserved. doi:10.1016/j.laa.2004.06.017 296 R.B.
    [Show full text]
  • Hypercubes Are Determined by Their Distance Spectra 3
    HYPERCUBES ARE DETERMINED BY THEIR DISTANCE SPECTRA JACK H. KOOLEN♦, SAKANDER HAYAT♠, AND QUAID IQBAL♣ Abstract. We show that the d-cube is determined by the spectrum of its distance matrix. 1. Introduction For undefined terms, see next section. For integers n 2 and d 2, the Ham- ming graph H(d, n) has as vertex set, the d-tuples with elements≥ from≥0, 1, 2,...,n 1 , with two d-tuples are adjacent if and only if they differ only in one{ coordinate.− For} a positive integer d, the d-cube is the graph H(d, 2). In this paper, we show that the d-cube is determined by its distance spectrum, see Theorem 5.4. Observe that the d-cube has exactly three distinct distance eigenvalues. Note that the d-cube is not determined by its adjacency spectrum as the Hoffman graph [11] has the same adjacency spectrum as the 4-cube and hence the cartesian product of (d 4)-cube and the Hoffman graph has the same adjacency spectrum − as the d-cube (for d 4, where the 0-cube is just K1). This also implies that the complement of the d-cube≥ is not determined by its distance spectrum, if d 4. ≥ There are quite a few papers on matrices of graphs with a few distinct eigenvalues. An important case is, when the Seidel matrix of a graph has exactly two distinct eigenvalues is very much studied, see, for example [18]. Van Dam and Haemers [20] characterized the graphs whose Laplacian matrix has two distinct nonzero eigenval- ues.
    [Show full text]
  • Distance Matrix of a Class of Completely Positive Graphs
    Spec. Matrices 2020; 8:160–171 Research Article Open Access Joyentanuj Das, Sachindranath Jayaraman, and Sumit Mohanty* Distance Matrix of a Class of Completely Positive Graphs: Determinant and Inverse https://doi.org/10.1515/spma-2020-0109 Received February 6, 2020; accepted May 14, 2020 Abstract: A real symmetric matrix A is said to be completely positive if it can be written as BBt for some (not necessarily square) nonnegative matrix B. A simple graph G is called a completely positive graph if every matrix realization of G that is both nonnegative and positive semidenite is a completely positive matrix. Our aim in this manuscript is to compute the determinant and inverse (when it exists) of the distance matrix of a class of completely positive graphs. We compute a matrix R such that the inverse of the distance matrix of a class of completely positive graphs is expressed a linear combination of the Laplacian matrix, a rank one matrix of all ones and R. This expression is similar to the existing result for trees. We also bring out interesting spectral properties of some of the principal submatrices of R. Keywords: Completely positive graphs, Schur complement, Laplacian matrix, Distance matrix MSC: 05C12, 05C50 1 Introduction and Preliminaries Let G = (V, E) be a nite, connected, simple and undirected graph with V as the set of vertices and E ⊂ V × V as the set of edges. We write i ∼ j to indicate that the vertices i, j are adjacent in G. The degree of the vertex i is denoted by δi. A graph with n vertices is called complete, if each vertex of the graph is adjacent to every other vertex and is denoted by Kn.
    [Show full text]
  • "Distance Measures for Graph Theory"
    Distance measures for graph theory : Comparisons and analyzes of different methods Dissertation presented by Maxime DUYCK for obtaining the Master’s degree in Mathematical Engineering Supervisor(s) Marco SAERENS Reader(s) Guillaume GUEX, Bertrand LEBICHOT Academic year 2016-2017 Acknowledgments First, I would like to thank my supervisor Pr. Marco Saerens for his presence, his advice and his precious help throughout the realization of this thesis. Second, I would also like to thank Bertrand Lebichot and Guillaume Guex for agreeing to read this work. Next, I would like to thank my parents, all my family and my friends to have accompanied and encouraged me during all my studies. Finally, I would thank Malian De Ron for creating this template [65] and making it available to me. This helped me a lot during “le jour et la nuit”. Contents 1. Introduction 1 1.1. Context presentation .................................. 1 1.2. Contents .......................................... 2 2. Theoretical part 3 2.1. Preliminaries ....................................... 4 2.1.1. Networks and graphs .............................. 4 2.1.2. Useful matrices and tools ........................... 4 2.2. Distances and kernels on a graph ........................... 7 2.2.1. Notion of (dis)similarity measures ...................... 7 2.2.2. Kernel on a graph ................................ 8 2.2.3. The shortest-path distance .......................... 9 2.3. Kernels from distances ................................. 9 2.3.1. Multidimensional scaling ............................ 9 2.3.2. Gaussian mapping ............................... 9 2.4. Similarity measures between nodes .......................... 9 2.4.1. Katz index and its Leicht’s extension .................... 10 2.4.2. Commute-time distance and Euclidean commute-time distance .... 10 2.4.3. SimRank similarity measure .........................
    [Show full text]
  • 9780521880688 Index.Pdf
    Cambridge University Press 978-0-521-88068-8 - Numerical Recipes: The Art of Scientific Computing, Third Edition William H. Press, Saul A. Teukolsky, William T. Vetterling and Brian P. Flannery Index More information Index Abstract Base Class (ABC) 24, 33, 34, 87, 114, Alternative extended Simpson’s rule 160 703, 874 AMD (approximate minimum degree) 544, 548 Accelerated convergence of series 177, 211–218 Amoeba 503 Accuracy 8–12 see also Simplex, method of Nelder and Mead achievable in minimization 493, 497, 503 Amplification factor 1033, 1035, 1038, 1045, achievable in root finding 448 1046 contrasted with fidelity 1037, 1046 Amplitude error 1036 CPU different from memory 230 Analog-to-digital converter 1018, 1166 vs. stability 907, 931, 932, 1035, 1050 Analyticity 246 Adams-Bashford-Moulton method 943 Analyze/factorize/operate package 76, 1030 Adams’ stopping criterion 467 Anderson-Darling statistic 739 Adaptive integration 901, 910–921, 928, 930, Andrew’s sine 821 935, 946, 995 Angle Monte Carlo 410–418 between vectors 1120, 1121 PI stepsize control 915 coordinates on n-sphere 1128 predictive stepsize control 939 exterior, of polygons 1122 see also Adaptive quadrature Annealing, method of simulated 487, 488, Adaptive quadrature 155, 167, 194–196 549–555 and singularities 195 assessment 554, 555 termination criterion 194 for continuous variables 550, 552–554 Addition schedule 551, 552 multiple precision 1186 thermodynamic analogy 550 theorem, elliptic integrals 310 traveling salesman problem 551, 552 ADI (alternating direction implicit)
    [Show full text]
  • Constructions of Trace Zero Symmetric Stochastic Matrices for the Inverse Eigenvalue Problem∗
    The Electronic Journal of Linear Algebra ISSN 1081-3810 A publication of the International Linear Algebra Society Volume 9, pp. 270-275, September 2002 ELA http://math.technion.ac.il/iic/ela CONSTRUCTIONS OF TRACE ZERO SYMMETRIC STOCHASTIC MATRICES FOR THE INVERSE EIGENVALUE PROBLEM∗ ROBERT REAMS† Abstract. In the special case of where the spectrum σ = {λ1,λ2,λ3, 0, 0,...,0} has at most three nonzero eigenvalues λ1,λ2,λ3 with λ1 ≥ 0 ≥ λ2 ≥ λ3,andλ1 + λ2 + λ3 =0,theinverse eigenvalue problem for symmetric stochastic n × n matrices is solved. Constructions are provided for the appropriate matrices where they are readily available. It is shown that when n is odd it is not possible to realize the spectrum σ with an n × n symmetric stochastic matrix when λ3 =0and 3 λ > 2 ≥ 0, andit is shown that this boundis best possible. 2n−3 λ3 Key words. Inverse eigenvalue problem, Symmetric stochastic matrix, Symmetric nonnegative matrix, Distance matrix. AMS subject classifications. 15A18, 15A48, 15A51, 15A57 n 1. Introduction. Let e1,...,en denote the standard basis in R ,soei denotes the vector with a 1 in the ith position and zeroes elsewhere. We will denote by e the vector of all ones, i.e. e =[1, 1,...,1]T ∈ Rn.AmatrixA ∈ Rn×n is said to be stochastic when all of its entries are nonnegative and all its row sums are equal to 1, i.e. A has right eigenvector e corresponding to the eigenvalue 1. We will be concerned with symmetric stochastic matrices, so that these matrices are in fact doubly stochastic.
    [Show full text]
  • The Distance Matrix and Its Variants for Graphs and Digraphs by Carolyn
    The distance matrix and its variants for graphs and digraphs by Carolyn Reinhart A dissertation submitted to the graduate faculty in partial fulfillment of the requirements for the degree of DOCTOR OF PHILOSOPHY Major: Mathematics Program of Study Committee: Leslie Hogben, Major Professor Steve Butler Jonas Hartwig Sung-Yell Song Michael Young The student author, whose presentation of the scholarship herein was approved by the program of study committee, is solely responsible for the content of this dissertation. The Graduate College will ensure this dissertation is globally accessible and will not permit alterations after a degree is conferred. Iowa State University Ames, Iowa 2021 Copyright © Carolyn Reinhart, 2021. All rights reserved. ii TABLE OF CONTENTS Page ACKNOWLEDGMENTS . iii ABSTRACT . iv CHAPTER 1. GENERAL INTRODUCTION . .1 1.1 Definitions for graphs . .3 1.2 Digraphs . .4 1.3 References . .5 CHAPTER 2. THE NORMALIZED DISTANCE LAPLACIAN . .7 2.1 Introduction . .7 2.2 The normalized distance Laplacian . 11 2.3 Using twin vertices to determine eigenvalues . 18 2.4 Characteristic polynomials . 21 2.5 Cospectral graphs . 25 2.5.1 Cospectral pairs on 10 or fewer vertices . 26 2.5.2 The number of graphs with a cospectral mate . 32 2.6 Concluding remarks . 33 2.7 References . 34 CHAPTER 3. A NOTE ON THE PRESERVATION OF GRAPH PARAMETERS BY COSPECTRALITY FOR THE DISTANCE MATRIX AND ITS VARIANTS . 37 3.1 Introduction . 37 3.2 Preservation of parameters . 39 3.3 Concluding remarks . 44 3.4 References . 44 CHAPTER 4. DISTANCE COSPECTRALITY IN DIGRAPHS . 46 4.1 Introduction . 46 4.2 The number of digraphs with distance cospectral mates .
    [Show full text]