arxiv: v1 [math.na] 3 Oct 2007

Size: px
Start display at page:

Download "arxiv: v1 [math.na] 3 Oct 2007"

Transcription

1 COMPUING HE CONDIIONING OF HE COMPONENS OF A LINEAR LEAS SQUARES SOLUION MARC BABOULIN, JACK DONGARRA, SERGE GRAON, AND JULIEN LANGOU arxiv:070089v [mathna] 3 Oct 007 Abstract In this paper, we address the accuracy of the results for the overdetermined full rank linear least squares problem We recall theoretical results obtained in [] on conditioning of the least squares solution and the components of the solution when the matrix perturbations are measured in Frobenius or spectral norms hen we define computable estimates for these condition numbers and we interpret them in terms of statistical quantities In particular, we show that, in the classical linear statistical model, the ratio of the variance of one component of the solution by the variance of the right-hand side is exactly the condition number of this solution component when perturbations on the right-hand side are considered We also provide fragment codes using LAPACK [] routines to compute the variance-covariance matrix and the least squares conditioning and we give the corresponding computational cost Finally we present a small historical numerical example that was used by Laplace [9] for computing the mass of Jupiter and experiments from the space industry with real physical data Keywords: Linear least squares, statistical linear least squares, parameter estimation, condition number, variance-covariance matrix, LAPACK, ScaLAPACK Introduction We consider the linear least squares problem (LLSP) min x R n Ax b, where b R m and A R m n is a matrix of full column rank n Our concern comes from the following observation: in many parameter estimation problems, there may be random errors in the observation vector b due to instrumental measurements as well as roundoff errors in the algorithms he matrix A may be subject to errors in its computation (approximation and/or roundoff errors) In such cases, while the condition number of the matrix A provides some information about the sensitivity of the LLSP to perturbations, a single global conditioning quantity is often not relevant enough since we may have significant disparity between the errors in the solution components We refer to the last section of the manuscript for illustrative examples here are several results for analyzing the accuracy of the LLSP by components For linear systems Ax = b and for LLSP, [7] defines so called componentwise condition numbers that correspond to amplification factors of the relative errors in solution components due to perturbations in data A or b and explains how to estimate them For LLSP, [7] proposes to estimate componentwise condition numbers by a statistical method More recently, [] developed theoretical results on conditioning of linear functionals of LLSP solutions he main objective of our paper is to provide computable quantities of these theoretical values in order to assess the accuracy of an LLSP solution or some of its components o achieve this goal, traditional tools for the numerical linear algebra practitioner are condition numbers or backward errors whereas the statistician usually refers to variance or covariance Our purpose here is to show that these mathematical quantities coming either from numerical analysis or statistics are closely related In particular, we will show in Equation (33) that, in the classical linear statistical model, the ratio of the variance of one component of the solution by the variance of the right-hand side is exactly the condition number of this component when perturbations on the right-hand side are considered In that sense, we attempt to clarify, similarly to [5], the analogy between quantities handled by the linear algebra and the statistical approaches in linear least squares hen we define computable estimates for these quantities and explain how they can be computed using the standard libraries LAPACK or ScaLAPACK CERFACS, and University of ennessee, baboulin@eecsutkedu University of ennessee, Oak Ridge National Laboratory, and University of Manchester, dongarra@eecsutkedu Centre National d Etudes Spatiales and CERFACS, gratton@cnesfr University of Colorado at Denver and Health Sciences Center, julienlangou@cudenveredu

2 his paper is organized as follows In Section, we recall and exploit some results of practical interest coming from [] We also define the condition numbers of an LLSP solution or one component of it In Section 3, we recall some definitions and results related to the linear statistical model for LLSP, and we interpret the condition numbers in terms of statistical quantities In Section 4 we provide practical formulas and FORRAN code fragments for computing the variance-covariance matrix and LLSP condition numbers using LAPACK In Section 5, we propose two numerical examples that show the relevance of the proposed quantities and their practical computation he first test case is a historical example from Laplace and the second example is related to gravity field computations Finally some concluding remarks are given in Section 6 hroughout this paper we will use the following notations We use the Frobenius norm F and the spectral norm on matrices and the usual Euclidean norm on vectors A denotes the Moore-Penrose pseudo inverse of A, the matrix I is the identity matrix and e i is the i-th canonical vector heoretical background for linear least squares conditioning Following the notations in [], we consider the function g : R m n R m A,b g(a,b) = L x(a,b) = L (A A) A b, R k () where L is an n k matrix, with k n Since A has full rank n, g is continuously F-differentiable in a neighbourhood of (A,b) and we denote by g its F-derivative Let α and β be two positive real numbers In the present paper we consider the Euclidean norm for the solution space R k For the data space R m n R m, we use the product norms defined by (A,b) F or = α A F or +β b, α,β > 0 Following [0], the absolute condition number of g at the point (A, b) using the product norm defined above is given by: g (A,b)( A, b) κ g,f or (A,b) = max ( A, b) ( A, b) F or he corresponding relative condition number of g at (A, b) is expressed by κ (rel) g,f or (A,b) = κ g,f(a,b) (A,b) F or g(a,b) o address the special cases where only A (resp b) is perturbed, we also define the quantities κ g,f or (A) = max g (A,b) A A A A F or (resp κ g, (b) = max g (A,b) b b b b ) Remark he product norm for the data space is very flexible; the coefficients α and β allow us to monitor the perturbations on A and b For instance, large values of α (resp β ) enable us to obtain condition number problems where mainly b (resp A) are perturbed In particular, we will address the special cases where only b (resp A) is perturbed by choosing the α and β parameters as α = + and β = (resp α = and β = + ) since we have lim α + κ g,f or (A,b) = β κ g,(b) and lim β + κ g,f or (A,b) = α κ g,f or (A)

3 3 his can be justified as follows: κ g,f or (A,b) = max ( A, b) = max ( A, b) g A (A,b) A+ g b (A,b) b α A F or +β b g A (A,b) A α + g b (A,b) b β A F or + b he above expression represents the operator norm of a linear functional depending continuously on α, and then we get g lim κ b (A,b) b β g g,f or (A,b) = max b (A,b) b β = max = α + ( A, b) A F or + b b b β κ g,(b) he proof is the same for the case where β = + he condition numbers related to L x(a,b) are referred to as partial condition numbers (PCN) of the LLSP with respect to the linear operator L in [] We are interested in computing the PCN for two special cases he first case is when L is the identity matrix (conditioning of the solution) and the second case is when L is a canonical vector e i (conditioning of a solution component) We can extract from [] two theorems that can lead to computable quantities in these two special cases heorem In the general case where (L R n k ), the absolute condition numbers of g(a,b) = L x(a,b) in the Frobenius and spectral norms can be respectively bounded as follows 3 f(a,b) κ g,f (A,b) f(a,b) where f(a,b) = 3 f(a,b) κ g, (A,b) f(a,b) ( L (A A) r α + L A ( x α + β ) ) () heorem In the two particular cases: L is a vector (L R n ), or L is the n-by-n identity matrix (L = I) the absolute condition number of g(a,b) = L x(a,b) in the Frobenius norm is given by the formula: κ g,f (A,b) = ( L (A A) r α + L A ( x α + β ) heorem provides the exact value for the condition number in the Frobenius norm for our two cases of interest (L = e i and L = I) From heorem, we observe that 3 κ g,f (A,b) κ g, (A,b) 6κ g,f (A,b) (3) )

4 4 which states that the partial condition number in spectral norm is of the same order of magnitude as the one in Frobenius norm In the remainder of the paper, the focus is given to the partial condition number in Frobenius norm only For the case L = I, the result of heorem is similar to [] and [0, p 9] he upper bound for κ,f (A,b) that can be derived from Equation (3) is also the one obtained by [0] when we consider pertubations in A Let us denote by κ i (A,b) the condition number related to the component x i in Frobenius norm (ie κ i (A,b) = κ g,f (A,b) where g(a,b) = e i x(a,b) = x i(a,b)) hen replacing L by e i in heorem provides us with an exact expression for computing κ i (A,b), this gives κ i (A,b) = ( e i (A A) r α + e i A ( x α + β ) ) (4) κ i (A,b) will be referred to as the condition number of the solution component x i Let us denote by κ LS (A,b) the condition number related to the solution x in Frobenius norm (ie κ LS (A,b) = κ g,f (A,b) where g(a,b) = x(a,b)) hen heorem provides us with an exact expression for computing κ LS (A,b), that is κ LS (A,b) = ( (A A) / (A A) r ) + x α + β (5) where we have used the fact that (A A) = A κ LS (A,b) will be referred to as the condition number of the least squares solution Note that [8] defines condition numbers for both x and r in order to derive error bounds for x and r but uses infinity-norm to measure perturbations In this paper, we will also be interested in the special case where only b is perturbed (α = + and β = ) In this case, we will call κ i (b) the condition number of the solution component x i, and κ LS (b) the condition number of the least squares solution When we restrict the perturbations to be on b, Equation (4) simplifies to and Equation (5) simplifies to his latter formula is standard and is in accordance with [5, p 9] 3 Condition numbers and statistical quantities κ i (b) = e i A, (6) κ LS (b) = A (7) 3 Background for the linear statistical model We consider here the classical linear statistical model b = Ax+ǫ, A R m n, b R m,rank(a) = n, where ǫ is a vector of random errors having expected value E(ǫ) = 0 and variance-covariance V(ǫ) = σb I In statistical language, the matrix A is referred to as the regression matrix and the unknown vector x is called the vector of regression coefficients Following the Gauss-Markov theorem [0], the least squares estimates ˆx is the linear unbiased estimator of x satisfying with minimum variance-covariance equal to Aˆx b = min x R n Ax b, C = σ b(a A) (3)

5 Moreover m n b Aˆx is an unbiased estimate of σ b his quantity is sometimes called the mean squared error (MSE) he diagonal elements c ii of C give the variance of each component ˆx i of the solution he offdiagonal elements c ij, i j give the covariance between ˆx i and ˆx j We define σˆxi as the standard deviation of the solution component ˆx i and we have σˆxi = c ii (3) In the next section, we will prove that the condition numbers κ i (A,b) and κ LS (A,b) can be related to the statistical quantities σˆxi and σ b 3 Perturbation on b only Using Equation (3), the variance c ii of the solution component ˆx i can be expressed as We note that (A A) = A A so that Using Equation (3), we get Finally from Equation (6), we get c ii = e i Ce i = σ b e i (A A) e i c ii = σ be i (A A )e i = σ b σˆxi = c ii = σ b e i A e i A σˆxi = σ b κ i (b) (33) 5 Equation (33) shows that the condition number κ i (b) relates linearly the standard deviation of σ b with the standard deviation of σˆxi Now if we consider the constant vector l of size n, we have (see [0]) Since C is symmetric, we can write Using the fact that C = σ b variance(l ˆx) = l Cl max variance(lˆx) = C l = (A A) = σb A, and Equation (7), we get max variance(lˆx) = σbκ LS (b) l = or, if we call σ(l ˆx) the standard deviation of l ˆx, max σ(lˆx) = σ b κ LS (b) l = Note that σ b = max l =σ(l ǫ) since V(ǫ) = σ b I Remark Matlab proposes a routine LSCOV that computes the quantities c ii in a vector SDX and the mean squared error MSE using the syntax [X,SDX,MSE] = LSCOV(A,B) hen the condition numbers κ i (b) can be computed by the matlab expression SDX/sqrt(MSE)

6 6 33 Perturbation on A and b We now provide the expression of the condition number provided in Equation (4) and in Equation (5) in term of statistical quantities Observing the following relations C i = σ be i (A A) and c ii = σ b e i A, where C i is the i-th column of the variance-covariance matrix, the condition number of x i given in Formula (4) can expressed as κ i (A,b) = σ b ( C i σ b r ) α +c ii ( x α + β ) he quantity σb will often be estimated by m n r in which case the expression can be simplified From Equation (5), we obtain ( κ i (A,b) = C i σ b α (m n) + c ii x α κ LS (A,b) = C / σ b + c ii β ) ) ( C r ) α σb + x α + β (34) he quantity σb will often be estimated by m n r in which case the expression can be simplified κ LS (A,b) = C / σ b ( α C (m n) + x α + β 4 Computation with LAPACK Section provides us with formulas to compute the condition numbers κ i and κ LS As explained in Section 3, those quantities are intimately interrelated with the entries of the variance-covariance matrix he goal of this section is to present practical methods and codes to compute those quantities efficiently with LAPACK he assumption made is that the LLSP has already been solved with either the normal equations method or a QR factorization approach herefore the solution vector ˆx, the norm of the residual ˆr, and the R-factor R of the QR factorization of A are readily available (we recall that the Cholesky factor of the normal equations is the R-factor of the QR factorization up to some signs) In the example codes, we have used the LAPACK routine DGELS that solves the LLSP using QR factorization of A Note that it is possible to have a more accurate solution using extra-precise iterative refinement [8] 4 Variance-covariance computation We will use the fact that m n b Aˆx is an unbiased estimate of σb We wish to compute the following quantities related to the variancecovariance matrix C the i-th column C i = σb e i (A A) the i-th diagonal element c ii = σb e i A the whole matrix C We note that the quantities C i, c ii, and C are of interest for statisticians he NAG routine F04YAF [] is indeed an example of tool to compute these three quantities For the two first quantities of interest, we note that ) e i A = R e i and e i (A A) = R (R e i )

7 4 Computation of the i-th column C i C i can be computed with two n by n triangular solves R y = e i and Rz = y (4) he i-th column of C can be computed by the following code fragment Code : CALL DGELS( N, M, N,, A, LDA, B, LDB, WORK, LWORK, INFO ) RESNORM = DNRM( (M-N), B(N+), ) SIGMA = RESNORM**/DBLE(M-N) E(:N) = 0D0 E(I) = D0 CALL DRSV( U,, N, N-I+, A(I,I), LDA, E(I), ) CALL DRSV( U, N, N, N, A, LDA, E, ) CALL DSCAL( N, SIGMA, E, ) his requires about n flops (in addition to the cost of solving the linear least squares problem using DGELS) c ii can be computed by one n by n triangular solve and taking the square of the norm of the solution which involves about (n i+) flops It is important to note that the larger i, the less expensive to obtain c ii In particular if i = n then only one operation is needed: c nn = Rnn his suggests that a correct ordering of the variables can save some computation 7 4 Computation of the i-th diagonal element c ii From c ii = σb e i R, it comes that each c ii corresponds to the i-th row of R hen the diagonal elements of C can be computed by the following code fragment Code : CALL DGELS( N, M, N,, A, LDA, B, LDB, WORK, LWORK, INFO ) RESNORM = DNRM((M-N), B(N+), ) SIGMA = RESNORM**/DBLE(M-N) CALL DRRI( U, N, N, A, LDA, INFO) DO I=,N CDIAG(I) = DNRM( N-I+, A(I,I), LDA) CDIAG(I) = SIGMA * CDIAG(I)** END DO his requires about n 3 /3 flops (plus the cost of DGELS) 43 Computation of the whole matrix C In order to compute explicity all the coefficients of the matrix C, one can use the routine DPORI which computes the inverse of a matrix from its Cholesky factorization First the routine computes the inverse of R using DRRI and then performs the triangular matrix-matrix multiply R R by DLAUUM his requires about n 3 /3 flops We can also compute the variance-covariance matrix without inverting R using for instance the algorithm given in [5, p 9] but the computational cost remains n 3 /3 (plus the cost of DGELS) We can obtain the upper triangular part of C by the following code fragment

8 8 Code 3: CALL DGELS( N, M, N,, A, LDA, B, LDB, WORK, LWORK, INFO ) RESNORM = DNRM((M-N), B(N+), ) SIGMA = RESNORM**/DBLE(M-N) CALL DPORI( U, N, A, LDA, INFO) CALL DLASCL( U, 0, 0, N, N, D0, SIGMA, N, N, A, LDA, INFO) 4 Condition numbers computation For computing κ i (A,b), we need to compute both the i-th diagonal element and the norm of the i-th column of the variance-covariance matrix and we cannot use direcly Code but the following code fragment Code 4: ALPHA = ALPHA** BEA = BEA** CALL DGELS( N, M, N,, A, LDA, B, LDB, WORK, LWORK, INFO ) XNORM = DNRM(N, B(), ) RESNORM = DNRM((M-N), B(N+), ) CALL DRSV( U,, N, N-I+, A(I,I), LDA, E(I), ) ENORM = DNRM(N, E, ) K = (ENORM**)*(XNORM**/ALPHA+d0/BEA) CALL DRSV( U, N, N, N, A, LDA, E, ) ENORM = DNRM(N, E, ) K = SQR((ENORM*RESNORM)**/ALPHA + K) For computing all the κ i (A,b), we need to compute the columns C i and the diagonal elements c ii using Formula (34) and then we have to compute the whole variance-covariance matrix his can be performed by a slight modification of Code 3 When only b is perturbed, then we have to invert R and we can use a modification of Code (see numerical example in Section 5) For estimating κ LS (A,b), we need to have an estimate of R he computation of R requires to compute the minimum singular value of the matrix A (or R) One way is to compute the full SVD of A (or R) which requires O(n 3 ) flops As an alternative, R can be estimated for instance by considering other matrix norms through the following inequalities n R F R R F, n R R n R, n R R n R R or R can be estimated using Higham modification [4, p 93] of Hager s [3] method as it is implemented in LAPACK [] DRCON routine (see Code 5) he cost is O(n ) Code 5: CALL DRCON( I, U, N, N, A, LDA, RCOND, WORK, IWORK, INFO) RNORM = DLANR( I, U, N, N, N, A, LDA, WORK) RINVNORM = (D0/RNORM)/RCOND

9 9 We can also evaluate R by considering R F since we have R F = R F = tr(r R ) = σb tr(c), where tr(c) denotes the trace of the matrix C, ie n i= c ii Hence the condition number of the least-squares solution can be approximated by κ LS (A,b) ( ( tr(c) tr(c) r )) +σ b x σb σb + α β (4) hen we can estimate κ LS (A,b) by computing and summing the diagonal elements of C using Code When only b is perturbed (α = + and β = ), then we get κ LS (b) tr(c) σ b his result relates to [9, p 67] where tr(c) measures the squared effect on the LLSP solution x to small changes in b We give in able 4 the LAPACK routines used for computing the condition numbers of an LLSP solution or its components and the corresponding number of floating-point operations per second Since the LAPACK routines involved in the covariance and/or LLSP condition numbers have their equivalent in the parallel library ScaLAPACK [6], then this table is also available when using ScaLAPACK his enables us to easily compute these quantities for larger LLSP able 4 Computation of least squares conditioning with (Sca)LAPACK condition number linear algebra operation LAPACK routines flops count κ i (A,b) R y = e i and Rz = y calls to (P)DRSV n all κ i (A,b), i =,n RY = I and compute YY (P)DPORI n 3 /3 all κ i (b), i =,n invert R (P)DRRI n 3 /3 κ LS (A,b) estimate R or (P)DRCON O(n ) compute R F (P)DRRI n 3 /3 Remark 3 he cost for computing all the κ i (A,b) or estimating κ LS (A,b) is always O(n 3 ) his seems affordable when we compare it to the cost of the least squares solution using Householder QR factorization (mn n 3 /3) or the normal equations (mn +n 3 /3) because we have in general m n

10 0 5 Numerical experiments 5 Laplace s computation of the mass of Jupiter and assessment of the validity of its results In [9], Laplace computes the mass of Jupiter, Saturn and Uranus and provides the variances associated with those variables in order to assess the quality of the results he data comes from the French astronomer Bouvart in the form of the normal equations given in Equation (5) z z +6788z 9590z z 4 +60z 5 = z z 53065z 39749z z 4 +57z 5 = z z +7870z 35z z z 5 = z z 35z +579z z 4 +8z 5 = z z +484z +363z z z 5 = z 0 +57z +337z +8z z 4 +9z 5 = (5) For computing the mass of Jupiter, we know that Bouvart performed m = 9 observations and there are n = 6 variables in the system he residual of the solution b Aˆx is also given by Bouvart and is 3096 On the 6 unknowns, Laplace only seeks one, the second variable z he mass of Jupiter in term of the mass of the Sun is given by z and the formula: mass of Jupiter = +z It turns out that the first variable z 0 represents the mass of Uranus through the formula mass of Uranus = +z If we solve the system (5), we obtain the solution vector Solution vector From z, we can compute the mass of Jupiter as a fraction of the mass of the Sun and we obtain 070 his value is indeed accurate since the correct value according to NASA is 048 From z 0, we can compute the mass of Uranus as a fraction of the mass of the Sun and we obtain 798 his value is inaccurate since the correct value according to NASA is 99 Laplace has computed the variance of z 0 and z to assess the fact that z was probably correct and z 0 probably inaccurate o compute those variances, Laplace first performed a Cholesky factorization from right to left of the system (5), then, since the variables were correctly ordered the number of operationsinvolvedin the computation ofthe variancesof z 0 and z were minimized he variance-covariance matrix for Laplace s system is: Our computation gives us that the variance for the mass of Jupiter is For reference, Laplace in 80 computed (We deduce the variance from Laplace s value o get what we now call the variance, one needs to compute the quantity: /( ) m/(m n)) From the variance-covariance matrix, one can assess that the computation of the mass of Jupiter (second variable) is extremely reliable while the computation of the mass of Uranus (first variable) is not For more details, we recommend to read [8]

11 5 Gravity field computation A classical example of parameter estimation problem is the computation of the Earth s gravity field coefficients More specifically, we estimate the parameters of the gravitational potential that can be expressed in spherical coordinates (r, θ, λ) by [4] V(r,θ,λ) = GM R l max l=0 ( ) l+ l R P lm (cosθ) [ C lm cosmλ+s lm sinmλ ] (5) r m=0 where G is the gravitationalconstant, M is the Earth s mass, R is the Earth s reference radius, the P lm represent the fully normalized Legendre functions of degree l and order m and C lm,s lm are the corresponding normalized harmonic coefficients he objective here is to compute the harmonic coefficients C lm and S lm the most accurately as possible he number of unknown parameters is expressed by n = (l max + ) hese coefficients are computed by solving a linear least squares problem that may involve millions of observations and tens of thousands of variables More details about the physical problem and the resolution methods can be found in [3] he data used in the following experiments were provided by CNES and they correspond to 0 days of observations using GRACE measurements (about 66,000 observations) We compute the spherical harmonic coefficients C lm and S lm up to a degree l max = 50; except the coefficients C,S,C 00,C 0 that areaprioriknown hen wehaven =,597unknowns in the correspondingleast squaresproblems (note that the GRACE satellite enables us to compute a gravityfield model up to degree 50) he problem is solved using the normal equations method and we have the Cholesky decomposition A A = U U We compute the relative condition numbers of each coefficient x i using the formula κ (rel) i (b) = e i U b / x i, and the following code fragment, derived from Code, in which the array D contains the normal equations A A and the vector X contains the right-hand side A b CALL DPOSV( U, N,, D, LDD, X, LDX, INFO) CALL DRRI( U, N, N, D, LDD, INFO) DO I=,N KAPPA(I) = DNRM( N-I+, D(I,I), LDD) * BNORM/ABS(X(I)) END DO Figure 5 represents the relative condition numbers of all the n coefficients We observe the disparity between the condition numbers (between 0 and 0 8 ) o be able to give a physical interpretation, we need first to sort the coefficients by degrees and orders as given in the development of V(r,θ,λ) in Expression (5) In Figure 5, we plot the coefficients C lm as a function of the degrees and orders (the curve with the S lm is similar) We notice that for a given order, the condition number increases with the degree and that, for a given degree, the variation of the sensitivity with the order is less significant We can also study the effect of regularization on the conditioning he physicists use in general a Kaula [6] regularization technique that consists of adding to A A a diagonal matrix D = diag(0,,0,δ,,δ) where δ is a constant that is proportional to 0 5 l and the nonzero max terms in D correspond to the variables that need to be regularized An example of the effect of Kaula regularization is shown in Figure 53 where we consider the coefficients of order 0 also called zonal coefficients We compute here the absolute condition numbers of these coefficients using the formula κ i (b) = e i U Note that the κ i (b) are much lower that his is not Centre National d Etudes Spatiales, oulouse, France Gravity Recovery and Climate Experiment, NASA, launched March 00

12 surprising because typically in our application b 0 5 / and x i 0 which would make the associated relative condition numbers greater than We observe that the regularization is effective on coefficients of highest degree that are in general more sensitive to perturbations conditioning # gravity field coefficients Fig 5 Amplitude of the relative condition numbers for the gravity field coefficients conditioning degree order Fig 5 Conditioning of spherical harmonic coefficients C lm ( l 50, m 50)

13 3 0 0 No regularization Kaula regularization 0 absolute condition number # degree Fig 53 Effect of regularization on zonal coefficients C l0 ( l 50) 6 Conclusion o assess the accuracy of a linear least squares solution, the practitioner of numerical linear algebra uses generally quantities like condition numbers or backward errors when the statistician is more interested in covariance analysis In this paper we proposed quantities that talk to both communities and that can assess the quality of the solution of a least squares problem or one of its component We provided pratical ways to compute these quantities using (Sca)LAPACK and we experimented these computations on pratical examples including a real physical application in the area of space geodesy REFERENCES [] E Anderson, Z Bai, C Bischof, S Blackford, J Demmel, J Dongarra, J D Croz, A Greenbaum, S Hammarling, A McKenney, and D Sorensen, LAPACK Users Guide, Society for Industrial and Applied Mathematics, 3 ed, 999 [] M Arioli, M Baboulin, and S Gratton, A partial condition number for linear least-squares problems, SIAM J Matrix Anal and Appl, 9 (007), pp [3] M Baboulin, Solving large dense linear least squares problems on parallel distributed computers Application to the Earth s gravity field computation, PhD thesis, 006 Institut National Polytechnique de oulouse [4] G Balmino, A Cazenave, A Comolet-irman, J C Husson, and M Lefebvre, Cours de géodésie dynamique et spatiale, ENSA, 98 [5] Å Björck, Numerical Methods for Least Squares Problems, Society Society for Industrial and Applied Mathematics, 996 [6] L S Blackford, J Choi, A Cleary, E D Azevedo, J Demmel, I Dhillon, J Dongarra, S Hammarling, G Henry, A Petitet, K Stanley, D Walker, and R C Whaley, ScaLAPACK Users Guide, Society for Industrial and Applied Mathematics, 997 [7] S Chandrasekaran and I C F Ipsen, On the sensitivity of solution components in linear systems of equations, SIAM J Matrix Anal and Appl, 6 (995), pp 93 [8] J Demmel, Y Hida, X S Li, and E J Riedy, Extra-precise iterative refinement for overdetermined least squares problems, ech Rep EECS , UC Berkeley, 007 Also LAPACK Working Note 88 [9] R W Farebrother, Linear least squares computations, Marcel Dekker Inc editions, 988 [0] A J Geurts, A contribution to the theory of condition, Numerische Mathematik, 39 (98), pp [] S Gratton, On the condition number of linear least squares problems in a weighted Frobenius norm, BI Numerical Mathematics, 36 (996), pp [] N A Group, NAG Library Manual, Mark, NAG, 006 [3] W W Hager, Condition estimates, SIAM J Sci Statist Comput, 5 (984), pp 3 36

14 4 [4] N J Higham, Accuracy and Stability of Numerical Algorithms, Society Society for Industrial and Applied Mathematics, ed, 00 [5] N J Higham and G W Stewart, Numerical linear algebra in statistical computing, in he State of the Art in Numerical Analysis, A Iserles and M J D Powell, eds, Oxford University Press, 987, pp 4 57 [6] W M Kaula, heory of satellite geodesy, Blaisdell Press, Waltham, Mass, 966 [7] C S Kenney, A J Laub, and M S Reese, Statistical condition estimation for linear least squares, SIAM J Matrix Anal and Appl, 9 (998), pp [8] J Langou, Review of théorie analytique des probabilités premier supplément sur l application du calcul des probabilités à la philosophie naturelle from P S Laplace, tech rep, CU Denver, 007 [9] P S Laplace, Premier supplément Sur l application du calcul des probabilités à la philosophie naturelle, in héorie Analytique des Probabilités, Mme Ve Courcier, 80, pp [0] M Zelen, Linear estimation and related topics, in Survey of numerical analysis, Jodd, ed, McGraw-Hill book company, 96, pp

Computing the conditioning of the components of a linear least-squares solution

Computing the conditioning of the components of a linear least-squares solution NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 009; 16:517 533 Published online 6 November 008 in Wiley InterScience www.interscience.wiley.com)..67 Computing the conditioning of

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

Parallel tools for solving incremental dense least squares problems. Application to space geodesy. LAPACK Working Note 179

Parallel tools for solving incremental dense least squares problems. Application to space geodesy. LAPACK Working Note 179 Parallel tools for solving incremental dense least squares problems. Application to space geodesy. LAPACK Working Note 179 Marc Baboulin Luc Giraud Serge Gratton Julien Langou September 19, 2006 Abstract

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 Marc Baboulin, Jack Dongarra, Rémi Lacroix To cite this version: Marc Baboulin, Jack Dongarra, Rémi Lacroix. Computing least squares

More information

LAPACK-Style Codes for Pivoted Cholesky and QR Updating. Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig. MIMS EPrint: 2006.

LAPACK-Style Codes for Pivoted Cholesky and QR Updating. Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig. MIMS EPrint: 2006. LAPACK-Style Codes for Pivoted Cholesky and QR Updating Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig 2007 MIMS EPrint: 2006.385 Manchester Institute for Mathematical Sciences School of Mathematics

More information

LAPACK-Style Codes for Pivoted Cholesky and QR Updating

LAPACK-Style Codes for Pivoted Cholesky and QR Updating LAPACK-Style Codes for Pivoted Cholesky and QR Updating Sven Hammarling 1, Nicholas J. Higham 2, and Craig Lucas 3 1 NAG Ltd.,Wilkinson House, Jordan Hill Road, Oxford, OX2 8DR, England, sven@nag.co.uk,

More information

A PARTIAL CONDITION NUMBER FOR LINEAR LEAST SQUARES PROBLEMS

A PARTIAL CONDITION NUMBER FOR LINEAR LEAST SQUARES PROBLEMS A PARTIAL CONDITION NUMBER OR LINEAR LEAST SQUARES PROBLEMS MARIO ARIOLI, MARC BABOULIN, AND SERGE GRATTON CERACS Technical Report TR/PA/04/, 004 Also appeared as Rutherford Appleton Laboratory Technical

More information

Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems

Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems LESLIE FOSTER and RAJESH KOMMU San Jose State University Existing routines, such as xgelsy or xgelsd in LAPACK, for

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

NAG Library Routine Document F08ZFF (DGGRQF).1

NAG Library Routine Document F08ZFF (DGGRQF).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 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

Generalized interval arithmetic on compact matrix Lie groups

Generalized interval arithmetic on compact matrix Lie groups myjournal manuscript No. (will be inserted by the editor) Generalized interval arithmetic on compact matrix Lie groups Hermann Schichl, Mihály Csaba Markót, Arnold Neumaier Faculty of Mathematics, University

More information

Applied Numerical Linear Algebra. Lecture 8

Applied Numerical Linear Algebra. Lecture 8 Applied Numerical Linear Algebra. Lecture 8 1/ 45 Perturbation Theory for the Least Squares Problem When A is not square, we define its condition number with respect to the 2-norm to be k 2 (A) σ max (A)/σ

More information

NAG Library Routine Document F07HAF (DPBSV)

NAG Library Routine Document F07HAF (DPBSV) NAG Library Routine Document (DPBSV) 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 Fortran Library Routine Document F04CFF.1

NAG Fortran Library Routine Document F04CFF.1 F04 Simultaneous Linear Equations NAG Fortran 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

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

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

Singular Value Decompsition

Singular Value Decompsition Singular Value Decompsition Massoud Malek One of the most useful results from linear algebra, is a matrix decomposition known as the singular value decomposition It has many useful applications in almost

More information

On the Perturbation of the Q-factor of the QR Factorization

On the Perturbation of the Q-factor of the QR Factorization NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. ; :1 6 [Version: /9/18 v1.] On the Perturbation of the Q-factor of the QR Factorization X.-W. Chang McGill University, School of Comptuer

More information

Implementation for LAPACK of a Block Algorithm for Matrix 1-Norm Estimation

Implementation for LAPACK of a Block Algorithm for Matrix 1-Norm Estimation Implementation for LAPACK of a Block Algorithm for Matrix 1-Norm Estimation Sheung Hun Cheng Nicholas J. Higham August 13, 2001 Abstract We describe double precision and complex16 Fortran 77 implementations,

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

More Gaussian Elimination and Matrix Inversion

More Gaussian Elimination and Matrix Inversion Week7 More Gaussian Elimination and Matrix Inversion 7 Opening Remarks 7 Introduction 235 Week 7 More Gaussian Elimination and Matrix Inversion 236 72 Outline 7 Opening Remarks 235 7 Introduction 235 72

More information

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

More information

Numerical Methods I Solving Square Linear Systems: GEM and LU factorization

Numerical Methods I Solving Square Linear Systems: GEM and LU factorization Numerical Methods I Solving Square Linear Systems: GEM and LU factorization Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 18th,

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

Gram-Schmidt Orthogonalization: 100 Years and More

Gram-Schmidt Orthogonalization: 100 Years and More Gram-Schmidt Orthogonalization: 100 Years and More September 12, 2008 Outline of Talk Early History (1795 1907) Middle History 1. The work of Åke Björck Least squares, Stability, Loss of orthogonality

More information

Roundoff Error. Monday, August 29, 11

Roundoff Error. Monday, August 29, 11 Roundoff Error A round-off error (rounding error), is the difference between the calculated approximation of a number and its exact mathematical value. Numerical analysis specifically tries to estimate

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

A hybrid Hermitian general eigenvalue solver

A hybrid Hermitian general eigenvalue solver Available online at www.prace-ri.eu Partnership for Advanced Computing in Europe A hybrid Hermitian general eigenvalue solver Raffaele Solcà *, Thomas C. Schulthess Institute fortheoretical Physics ETHZ,

More information

arxiv: v1 [math.na] 7 May 2009

arxiv: v1 [math.na] 7 May 2009 The hypersecant Jacobian approximation for quasi-newton solves of sparse nonlinear systems arxiv:0905.105v1 [math.na] 7 May 009 Abstract Johan Carlsson, John R. Cary Tech-X Corporation, 561 Arapahoe Avenue,

More information

Intel Math Kernel Library (Intel MKL) LAPACK

Intel Math Kernel Library (Intel MKL) LAPACK Intel Math Kernel Library (Intel MKL) LAPACK Linear equations Victor Kostin Intel MKL Dense Solvers team manager LAPACK http://www.netlib.org/lapack Systems of Linear Equations Linear Least Squares Eigenvalue

More information

ON MATRIX BALANCING AND EIGENVECTOR COMPUTATION

ON MATRIX BALANCING AND EIGENVECTOR COMPUTATION ON MATRIX BALANCING AND EIGENVECTOR COMPUTATION RODNEY JAMES, JULIEN LANGOU, AND BRADLEY R. LOWERY arxiv:40.5766v [math.na] Jan 04 Abstract. Balancing a matrix is a preprocessing step while solving the

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

We first repeat some well known facts about condition numbers for normwise and componentwise perturbations. Consider the matrix

We first repeat some well known facts about condition numbers for normwise and componentwise perturbations. Consider the matrix BIT 39(1), pp. 143 151, 1999 ILL-CONDITIONEDNESS NEEDS NOT BE COMPONENTWISE NEAR TO ILL-POSEDNESS FOR LEAST SQUARES PROBLEMS SIEGFRIED M. RUMP Abstract. The condition number of a problem measures the sensitivity

More information

WHEN MODIFIED GRAM-SCHMIDT GENERATES A WELL-CONDITIONED SET OF VECTORS

WHEN MODIFIED GRAM-SCHMIDT GENERATES A WELL-CONDITIONED SET OF VECTORS IMA Journal of Numerical Analysis (2002) 22, 1-8 WHEN MODIFIED GRAM-SCHMIDT GENERATES A WELL-CONDITIONED SET OF VECTORS L. Giraud and J. Langou Cerfacs, 42 Avenue Gaspard Coriolis, 31057 Toulouse Cedex

More information

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 7: More on Householder Reflectors; Least Squares Problems Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 15 Outline

More information

On aggressive early deflation in parallel variants of the QR algorithm

On aggressive early deflation in parallel variants of the QR algorithm On aggressive early deflation in parallel variants of the QR algorithm Bo Kågström 1, Daniel Kressner 2, and Meiyue Shao 1 1 Department of Computing Science and HPC2N Umeå University, S-901 87 Umeå, Sweden

More information

6 Linear Systems of Equations

6 Linear Systems of Equations 6 Linear Systems of Equations Read sections 2.1 2.3, 2.4.1 2.4.5, 2.4.7, 2.7 Review questions 2.1 2.37, 2.43 2.67 6.1 Introduction When numerically solving two-point boundary value problems, the differential

More information

Some Notes on Least Squares, QR-factorization, SVD and Fitting

Some Notes on Least Squares, QR-factorization, SVD and Fitting Department of Engineering Sciences and Mathematics January 3, 013 Ove Edlund C000M - Numerical Analysis Some Notes on Least Squares, QR-factorization, SVD and Fitting Contents 1 Introduction 1 The Least

More information

The Future of LAPACK and ScaLAPACK

The Future of LAPACK and ScaLAPACK The Future of LAPACK and ScaLAPACK Jason Riedy, Yozo Hida, James Demmel EECS Department University of California, Berkeley November 18, 2005 Outline Survey responses: What users want Improving LAPACK and

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

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 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

Reducing the Amount of Pivoting in Symmetric Indefinite Systems

Reducing the Amount of Pivoting in Symmetric Indefinite Systems Reducing the Amount of Pivoting in Symmetric Indefinite Systems Dulceneia Becker 1, Marc Baboulin 4, and Jack Dongarra 1,2,3 1 University of Tennessee, USA [dbecker7,dongarra]@eecs.utk.edu 2 Oak Ridge

More information

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 Instructions Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 The exam consists of four problems, each having multiple parts. You should attempt to solve all four problems. 1.

More information

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn Today s class Linear Algebraic Equations LU Decomposition 1 Linear Algebraic Equations Gaussian Elimination works well for solving linear systems of the form: AX = B What if you have to solve the linear

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

Scientific Computing: Solving Linear Systems

Scientific Computing: Solving Linear Systems Scientific Computing: Solving Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 September 17th and 24th, 2015 A. Donev (Courant

More information

σ 11 σ 22 σ pp 0 with p = min(n, m) The σ ii s are the singular values. Notation change σ ii A 1 σ 2

σ 11 σ 22 σ pp 0 with p = min(n, m) The σ ii s are the singular values. Notation change σ ii A 1 σ 2 HE SINGULAR VALUE DECOMPOSIION he SVD existence - properties. Pseudo-inverses and the SVD Use of SVD for least-squares problems Applications of the SVD he Singular Value Decomposition (SVD) heorem For

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

Preface to Second Edition... vii. Preface to First Edition...

Preface to Second Edition... vii. Preface to First Edition... Contents Preface to Second Edition..................................... vii Preface to First Edition....................................... ix Part I Linear Algebra 1 Basic Vector/Matrix Structure and

More information

Jacobian conditioning analysis for model validation

Jacobian conditioning analysis for model validation Neural Computation 16: 401-418 (2004). Jacobian conditioning analysis for model validation Isabelle Rivals and Léon Personnaz Équipe de Statistique Appliquée École Supérieure de Physique et de Chimie Industrielles

More information

Efficient Implementation of the Ensemble Kalman Filter

Efficient Implementation of the Ensemble Kalman Filter University of Colorado at Denver and Health Sciences Center Efficient Implementation of the Ensemble Kalman Filter Jan Mandel May 2006 UCDHSC/CCM Report No. 231 CENTER FOR COMPUTATIONAL MATHEMATICS REPORTS

More information

Testing Linear Algebra Software

Testing Linear Algebra Software Testing Linear Algebra Software Nicholas J. Higham, Department of Mathematics, University of Manchester, Manchester, M13 9PL, England higham@ma.man.ac.uk, http://www.ma.man.ac.uk/~higham/ Abstract How

More information

MATH 3511 Lecture 1. Solving Linear Systems 1

MATH 3511 Lecture 1. Solving Linear Systems 1 MATH 3511 Lecture 1 Solving Linear Systems 1 Dmitriy Leykekhman Spring 2012 Goals Review of basic linear algebra Solution of simple linear systems Gaussian elimination D Leykekhman - MATH 3511 Introduction

More information

Linear Least-Squares Data Fitting

Linear Least-Squares Data Fitting CHAPTER 6 Linear Least-Squares Data Fitting 61 Introduction Recall that in chapter 3 we were discussing linear systems of equations, written in shorthand in the form Ax = b In chapter 3, we just considered

More information

A parallel tiled solver for dense symmetric indefinite systems on multicore architectures

A parallel tiled solver for dense symmetric indefinite systems on multicore architectures A parallel tiled solver for dense symmetric indefinite systems on multicore architectures Marc Baboulin, Dulceneia Becker, Jack Dongarra INRIA Saclay-Île de France, F-91893 Orsay, France Université Paris

More information

Structured Condition Numbers of Symmetric Algebraic Riccati Equations

Structured Condition Numbers of Symmetric Algebraic Riccati Equations Proceedings of the 2 nd International Conference of Control Dynamic Systems and Robotics Ottawa Ontario Canada May 7-8 2015 Paper No. 183 Structured Condition Numbers of Symmetric Algebraic Riccati Equations

More information

Scientific Computing: Dense Linear Systems

Scientific Computing: Dense Linear Systems Scientific Computing: Dense Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 February 9th, 2012 A. Donev (Courant Institute)

More information

Dense LU factorization and its error analysis

Dense LU factorization and its error analysis Dense LU factorization and its error analysis Laura Grigori INRIA and LJLL, UPMC February 2016 Plan Basis of floating point arithmetic and stability analysis Notation, results, proofs taken from [N.J.Higham,

More information

Numerical Methods. Elena loli Piccolomini. Civil Engeneering. piccolom. Metodi Numerici M p. 1/??

Numerical Methods. Elena loli Piccolomini. Civil Engeneering.  piccolom. Metodi Numerici M p. 1/?? Metodi Numerici M p. 1/?? Numerical Methods Elena loli Piccolomini Civil Engeneering http://www.dm.unibo.it/ piccolom elena.loli@unibo.it Metodi Numerici M p. 2/?? Least Squares Data Fitting Measurement

More information

Introduction. Chapter One

Introduction. Chapter One Chapter One Introduction The aim of this book is to describe and explain the beautiful mathematical relationships between matrices, moments, orthogonal polynomials, quadrature rules and the Lanczos and

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

Theoretical Computer Science

Theoretical Computer Science Theoretical Computer Science 412 (2011) 1484 1491 Contents lists available at ScienceDirect Theoretical Computer Science journal homepage: wwwelseviercom/locate/tcs Parallel QR processing of Generalized

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 3 Chapter 10 LU Factorization PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or display.

More information

COMPUTING THE CONDITION NUMBER OF TRIDIAGONAL AND DIAGONAL-PLUS-SEMISEPARABLE MATRICES IN LINEAR TIME

COMPUTING THE CONDITION NUMBER OF TRIDIAGONAL AND DIAGONAL-PLUS-SEMISEPARABLE MATRICES IN LINEAR TIME COMPUTING THE CONDITION NUMBER OF TRIDIAGONAL AND DIAGONAL-PLUS-SEMISEPARABLE MATRICES IN LINEAR TIME GARETH I HARGREAVES Abstract For an n n tridiagonal matrix we exploit the structure of its QR factorization

More information

1 Cricket chirps: an example

1 Cricket chirps: an example Notes for 2016-09-26 1 Cricket chirps: an example Did you know that you can estimate the temperature by listening to the rate of chirps? The data set in Table 1 1. represents measurements of the number

More information

University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra Ph.D. Preliminary Exam January 13, 2014

University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra Ph.D. Preliminary Exam January 13, 2014 University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra Ph.D. Preliminary Exam January 13, 2014 Name: Exam Rules: This is a closed book exam. Once the exam

More information

AM205: Assignment 2. i=1

AM205: Assignment 2. i=1 AM05: Assignment Question 1 [10 points] (a) [4 points] For p 1, the p-norm for a vector x R n is defined as: ( n ) 1/p x p x i p ( ) i=1 This definition is in fact meaningful for p < 1 as well, although

More information

Analysis of Block LDL T Factorizations for Symmetric Indefinite Matrices

Analysis of Block LDL T Factorizations for Symmetric Indefinite Matrices Analysis of Block LDL T Factorizations for Symmetric Indefinite Matrices Haw-ren Fang August 24, 2007 Abstract We consider the block LDL T factorizations for symmetric indefinite matrices in the form LBL

More information

Numerical Analysis FMN011

Numerical Analysis FMN011 Numerical Analysis FMN011 Carmen Arévalo Lund University carmen@maths.lth.se Lecture 4 Linear Systems Ax = b A is n n matrix, b is given n-vector, x is unknown solution n-vector. A n n is non-singular

More information

Nearest Correlation Matrix

Nearest Correlation Matrix Nearest Correlation Matrix The NAG Library has a range of functionality in the area of computing the nearest correlation matrix. In this article we take a look at nearest correlation matrix problems, giving

More information

Review Questions REVIEW QUESTIONS 71

Review Questions REVIEW QUESTIONS 71 REVIEW QUESTIONS 71 MATLAB, is [42]. For a comprehensive treatment of error analysis and perturbation theory for linear systems and many other problems in linear algebra, see [126, 241]. An overview of

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

ACCURACY AND STABILITY OF THE NULL SPACE METHOD FOR SOLVING THE EQUALITY CONSTRAINED LEAST SQUARES PROBLEM

ACCURACY AND STABILITY OF THE NULL SPACE METHOD FOR SOLVING THE EQUALITY CONSTRAINED LEAST SQUARES PROBLEM BIT 0006-3835/98/3901-0034 $15.00 1999, Vol. 39, No. 1, pp. 34 50 c Swets & Zeitlinger ACCURACY AND STABILITY OF THE NULL SPACE METHOD FOR SOLVING THE EQUALITY CONSTRAINED LEAST SQUARES PROBLEM ANTHONY

More information

The LINPACK Benchmark in Co-Array Fortran J. K. Reid Atlas Centre, Rutherford Appleton Laboratory, Chilton, Didcot, Oxon OX11 0QX, UK J. M. Rasmussen

The LINPACK Benchmark in Co-Array Fortran J. K. Reid Atlas Centre, Rutherford Appleton Laboratory, Chilton, Didcot, Oxon OX11 0QX, UK J. M. Rasmussen The LINPACK Benchmark in Co-Array Fortran J. K. Reid Atlas Centre, Rutherford Appleton Laboratory, Chilton, Didcot, Oxon OX11 0QX, UK J. M. Rasmussen and P. C. Hansen Department of Mathematical Modelling,

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

Numerical Methods I: Numerical linear algebra

Numerical Methods I: Numerical linear algebra 1/3 Numerical Methods I: Numerical linear algebra Georg Stadler Courant Institute, NYU stadler@cimsnyuedu September 1, 017 /3 We study the solution of linear systems of the form Ax = b with A R n n, x,

More information

Porting a Sphere Optimization Program from lapack to scalapack

Porting a Sphere Optimization Program from lapack to scalapack Porting a Sphere Optimization Program from lapack to scalapack Paul C. Leopardi Robert S. Womersley 12 October 2008 Abstract The sphere optimization program sphopt was originally written as a sequential

More information

Matrix decompositions

Matrix decompositions Matrix decompositions How can we solve Ax = b? 1 Linear algebra Typical linear system of equations : x 1 x +x = x 1 +x +9x = 0 x 1 +x x = The variables x 1, x, and x only appear as linear terms (no powers

More information

Scientific Computing

Scientific Computing Scientific Computing Direct solution methods Martin van Gijzen Delft University of Technology October 3, 2018 1 Program October 3 Matrix norms LU decomposition Basic algorithm Cost Stability Pivoting Pivoting

More information

Using Random Butterfly Transformations to Avoid Pivoting in Sparse Direct Methods

Using Random Butterfly Transformations to Avoid Pivoting in Sparse Direct Methods Using Random Butterfly Transformations to Avoid Pivoting in Sparse Direct Methods Marc Baboulin 1, Xiaoye S. Li 2 and François-Henry Rouet 2 1 University of Paris-Sud, Inria Saclay, France 2 Lawrence Berkeley

More information

Numerical Methods in Matrix Computations

Numerical Methods in Matrix Computations Ake Bjorck Numerical Methods in Matrix Computations Springer Contents 1 Direct Methods for Linear Systems 1 1.1 Elements of Matrix Theory 1 1.1.1 Matrix Algebra 2 1.1.2 Vector Spaces 6 1.1.3 Submatrices

More information

A note on eigenvalue computation for a tridiagonal matrix with real eigenvalues Akiko Fukuda

A note on eigenvalue computation for a tridiagonal matrix with real eigenvalues Akiko Fukuda Journal of Math-for-Industry Vol 3 (20A-4) pp 47 52 A note on eigenvalue computation for a tridiagonal matrix with real eigenvalues Aio Fuuda Received on October 6 200 / Revised on February 7 20 Abstract

More information

Multiplicative Perturbation Analysis for QR Factorizations

Multiplicative Perturbation Analysis for QR Factorizations Multiplicative Perturbation Analysis for QR Factorizations Xiao-Wen Chang Ren-Cang Li Technical Report 011-01 http://www.uta.edu/math/preprint/ Multiplicative Perturbation Analysis for QR Factorizations

More information

Using Godunov s Two-Sided Sturm Sequences to Accurately Compute Singular Vectors of Bidiagonal Matrices.

Using Godunov s Two-Sided Sturm Sequences to Accurately Compute Singular Vectors of Bidiagonal Matrices. Using Godunov s Two-Sided Sturm Sequences to Accurately Compute Singular Vectors of Bidiagonal Matrices. A.M. Matsekh E.P. Shurina 1 Introduction We present a hybrid scheme for computing singular vectors

More information

Process Model Formulation and Solution, 3E4

Process Model Formulation and Solution, 3E4 Process Model Formulation and Solution, 3E4 Section B: Linear Algebraic Equations Instructor: Kevin Dunn dunnkg@mcmasterca Department of Chemical Engineering Course notes: Dr Benoît Chachuat 06 October

More information

Latent Semantic Models. Reference: Introduction to Information Retrieval by C. Manning, P. Raghavan, H. Schutze

Latent Semantic Models. Reference: Introduction to Information Retrieval by C. Manning, P. Raghavan, H. Schutze Latent Semantic Models Reference: Introduction to Information Retrieval by C. Manning, P. Raghavan, H. Schutze 1 Vector Space Model: Pros Automatic selection of index terms Partial matching of queries

More information

Practical Linear Algebra: A Geometry Toolbox

Practical Linear Algebra: A Geometry Toolbox Practical Linear Algebra: A Geometry Toolbox Third edition Chapter 12: Gauss for Linear Systems Gerald Farin & Dianne Hansford CRC Press, Taylor & Francis Group, An A K Peters Book www.farinhansford.com/books/pla

More information

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY published in IMA Journal of Numerical Analysis (IMAJNA), Vol. 23, 1-9, 23. OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY SIEGFRIED M. RUMP Abstract. In this note we give lower

More information

14.2 QR Factorization with Column Pivoting

14.2 QR Factorization with Column Pivoting page 531 Chapter 14 Special Topics Background Material Needed Vector and Matrix Norms (Section 25) Rounding Errors in Basic Floating Point Operations (Section 33 37) Forward Elimination and Back Substitution

More information

MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS

MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS Instructor: Shmuel Friedland Department of Mathematics, Statistics and Computer Science email: friedlan@uic.edu Last update April 18, 2010 1 HOMEWORK ASSIGNMENT

More information

Least Squares. Tom Lyche. October 26, Centre of Mathematics for Applications, Department of Informatics, University of Oslo

Least Squares. Tom Lyche. October 26, Centre of Mathematics for Applications, Department of Informatics, University of Oslo Least Squares Tom Lyche Centre of Mathematics for Applications, Department of Informatics, University of Oslo October 26, 2010 Linear system Linear system Ax = b, A C m,n, b C m, x C n. under-determined

More information

Least squares: the big idea

Least squares: the big idea Notes for 2016-02-22 Least squares: the big idea Least squares problems are a special sort of minimization problem. Suppose A R m n where m > n. In general, we cannot solve the overdetermined system Ax

More information

EECS 275 Matrix Computation

EECS 275 Matrix Computation EECS 275 Matrix Computation Ming-Hsuan Yang Electrical Engineering and Computer Science University of California at Merced Merced, CA 95344 http://faculty.ucmerced.edu/mhyang Lecture 9 1 / 23 Overview

More information

LECTURE 7. Least Squares and Variants. Optimization Models EE 127 / EE 227AT. Outline. Least Squares. Notes. Notes. Notes. Notes.

LECTURE 7. Least Squares and Variants. Optimization Models EE 127 / EE 227AT. Outline. Least Squares. Notes. Notes. Notes. Notes. Optimization Models EE 127 / EE 227AT Laurent El Ghaoui EECS department UC Berkeley Spring 2015 Sp 15 1 / 23 LECTURE 7 Least Squares and Variants If others would but reflect on mathematical truths as deeply

More information

Introduction to Numerical Linear Algebra II

Introduction to Numerical Linear Algebra II Introduction to Numerical Linear Algebra II Petros Drineas These slides were prepared by Ilse Ipsen for the 2015 Gene Golub SIAM Summer School on RandNLA 1 / 49 Overview We will cover this material in

More information

Sparse BLAS-3 Reduction

Sparse BLAS-3 Reduction Sparse BLAS-3 Reduction to Banded Upper Triangular (Spar3Bnd) Gary Howell, HPC/OIT NC State University gary howell@ncsu.edu Sparse BLAS-3 Reduction p.1/27 Acknowledgements James Demmel, Gene Golub, Franc

More information

AM 205: lecture 8. Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition

AM 205: lecture 8. Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition AM 205: lecture 8 Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition QR Factorization A matrix A R m n, m n, can be factorized

More information