hide long namesshow long names
hide short namesshow short names
Integer type:  int32  int64  nag_int  show int32  show int32  show int64  show int64  show nag_int  show nag_int

PDF version (NAG web site, 64-bit version, 64-bit version)
Chapter Contents
Chapter Introduction
NAG Toolbox

NAG Toolbox Chapter Introduction

F01 — matrix operations, including inversion

Scope of the Chapter

This chapter provides facilities for four types of problem:
(i) Matrix Inversion
(ii) Matrix Factorizations
(iii) Matrix Arithmetic and Manipulation
(iv) Matrix Functions
See Matrix Inversion, Matrix Factorizations, Matrix Arithmetic and Manipulation and Matrix Functions where these problems are discussed.

Background to the Problems

Matrix Inversion

(i) Nonsingular square matrices of order n.
If A, a square matrix of order n, is nonsingular (has rank n), then its inverse X exists and satisfies the equations AX=XA=I (the identity or unit matrix).
It is worth noting that if AX-I=R, so that R is the ‘residual’ matrix, then a bound on the relative error is given by R, i.e.,
X-A-1 A-1 R.  
(ii) General real rectangular matrices.
A real matrix A has no inverse if it is square (n by n) and singular (has rank <n), or if it is of shape (m by n) with mn, but there is a Generalized or Pseudo-inverse A+ which satisfies the equations
AA+A=A,  A+AA+=A+,  AA+T=AA+,  A+AT=A+A  
(which of course are also satisfied by the inverse X of A if A is square and nonsingular).
(a) if mn and rankA=n then A can be factorized using a QR factorization, given by
A=Q R 0 ,  
where Q is an m by m orthogonal matrix and R is an n by n, nonsingular, upper triangular matrix. The pseudo-inverse of A is then given by
A+=R-1Q~T,  
where Q~ consists of the first n columns of Q.
(b) if mn and rankA=m then A can be factorized using an RQ factorization, given by
A=R0QT  
where Q is an n by n orthogonal matrix and R is an m by m, nonsingular, upper triangular matrix. The pseudo-inverse of A is then given by
A+ = Q~R-1 ,  
where Q~ consists of the first m columns of Q.
(c) if mn and rankA=rn then A can be factorized using a QR factorization, with column interchanges, as
A=Q R 0 PT,  
where Q is an m by m orthogonal matrix, R is an r by n upper trapezoidal matrix and P is an n by n permutation matrix. The pseudo-inverse of A is then given by
A+=PRTRRT-1Q~T,  
where Q~ consists of the first r columns of Q.
(d) if rankA=rk=minm,n, then A can be factorized as the singular value decomposition
A=UΣVT,  
where U is an m by m orthogonal matrix, V is an n by n orthogonal matrix and Σ is an m by n diagonal matrix with non-negative diagonal elements σ. The first k columns of U and V are the left- and right-hand singular vectors of A respectively and the k diagonal elements of Σ are the singular values of A. Σ may be chosen so that
σ1σ2σk0  
and in this case if rankA=r then
σ1σ2σr>0,  σr+1==σk=0.  
If U~ and V~ consist of the first r columns of U and V respectively and Σ~ is an r by r diagonal matrix with diagonal elements σ1,σ2,,σr then A is given by
A=U~Σ~V~T  
and the pseudo-inverse of A is given by
A+=V~Σ~-1U~T.  
Notice that
ATA=VΣTΣVT  
which is the classical eigenvalue (spectral) factorization of ATA.
(e) if A is complex then the above relationships are still true if we use ‘unitary’ in place of ‘orthogonal’ and conjugate transpose in place of transpose. For example, the singular value decomposition of A is
A=UΣVH,  
where U and V are unitary, VH the conjugate transpose of V and Σ is as in (d) above.

Matrix Factorizations

The functions in this section perform matrix factorizations which are required for the solution of systems of linear equations with various special structures. A few functions which perform associated computations are also included.
Other functions for matrix factorizations are to be found in Chapters F07, F08 and F11.
This section also contains a few functions associated with eigenvalue problems (see Chapter F02). (Historical note: this section used to contain many more such functions, but they have now been superseded by functions in Chapter F08.)

Matrix Arithmetic and Manipulation

The intention of functions in this section (sub-chapters F01C, F01V and F01Z) is to cater for some of the commonly occurring operations in matrix manipulation, i.e., transposing a matrix or adding part of one matrix to another, and for conversion between different storage formats,such as conversion between rectangular band matrix storage and packed band matrix storage. For vector or matrix-vector or matrix-matrix operations refer to Chapter F16.

Matrix Functions

Given a square matrix A, the matrix function fA is a matrix with the same dimensions as A which provides a generalization of the scalar function f.
If A has a full set of eigenvectors V then A can be factorized as
A = V D V-1 ,  
where D is the diagonal matrix whose diagonal elements, di, are the eigenvalues of A. fA is given by
fA = V fD V-1 ,  
where fD is the diagonal matrix whose ith diagonal element is fdi.
In general, A may not have a full set of eigenvectors. The matrix function can then be defined via a Cauchy integral. For An×n,
fA = 1 2π i Γ fz zI-A-1 dz ,  
where Γ is a closed contour surrounding the eigenvalues of A, and f is analytic within Γ.
Some matrix functions are defined implicitly. A matrix logarithm is a solution X to the equation
eX=A .  
In general X is not unique, but if A has no eigenvalues on the closed negative real line then a unique principal logarithm exists whose eigenvalues have imaginary part between π and -π. Similarly, a matrix square root is a solution X to the equation
X2=A .  
If A has no eigenvalues on the closed negative real line then a unique principal square root exists with eigenvalues in the right half-plane. If A has a vanishing eigenvalue then logA cannot be computed. If the vanishing eigenvalue is defective (its algebraic multiplicity exceeds its geometric multiplicity, or equivalently it occurs in a Jordan block of size greater than 1) then the square root cannot be computed. If the vanishing eigenvalue is semisimple (its algebraic and geometric multiplicities are equal, or equivalently it occurs only in Jordan blocks of size 1) then a square root can be computed.
Algorithms for computing matrix functions are usually tailored to a specific function. Currently Chapter F01 contains routines for calculating the exponential, logarithm, sine, cosine, sinh, cosh, square root and general real power of both real and complex matrices. In addition there are routines to compute a general function of real symmetric and complex Hermitian matrices and a general function of general real and complex matrices.
The Fréchet derivative of a matrix function fA in the direction of the matrix E is the linear function mapping E to LfA,E such that
fA+E - fA - LfA,E = OE .  
The Fréchet derivative measures the first-order effect on fA of perturbations in A. Chapter F01 contains functions for calculating the Fréchet derivative of the exponential, logarithm and real powers of both real and complex matrices.
The condition number of a matrix function is a measure of its sensitivity to perturbations in the data. The absolute condition number measures these perturbations in an absolute sense, and is defined by
condabs f,A := lim ε0 sup E0 fA+E - fA ε .  
The relative condition number, which is usually of more interest, measures these perturbations in a relative sense, and is defined by
condrel f,A = condabs f,A A fA .  
The absolute and relative condition numbers can be expressed in terms of the norm of the Fréchet derivative by
condabs f,A = max E0 LA,E E ,  
condrel f,A = A fA max E0 LA,E E .  
Chapter F01 contains routines for calculating the condition number of the matrix exponential, logarithm, sine, cosine, sinh, cosh, square root and general real power of both real and complex matrices. It also contains routines for estimating the condition number of a general function of a real or complex matrix.

Recommendations on Choice and Use of Available Functions

Matrix Inversion

Note:  before using any function for matrix inversion, consider carefully whether it is really needed.
Although the solution of a set of linear equations Ax=b can be written as x=A-1b, the solution should never be computed by first inverting A and then computing A-1b; the functions in Chapters F04 or F07 should always be used to solve such sets of equations directly; they are faster in execution, and numerically more stable and accurate. Similar remarks apply to the solution of least squares problems which again should be solved by using the functions in Chapters F04 and F08 rather than by computing a pseudo-inverse.
(a) Nonsingular square matrices of order n 
This chapter describes techniques for inverting a general real matrix A and matrices which are positive definite (have all eigenvalues positive) and are either real and symmetric or complex and Hermitian. It is wasteful and uneconomical not to use the appropriate function when a matrix is known to have one of these special forms. A general function must be used when the matrix is not known to be positive definite. In most functions the inverse is computed by solving the linear equations Axi=ei, for i=1,2,,n, where ei is the ith column of the identity matrix.
Functions are given for calculating the approximate inverse, that is solving the linear equations just once, and also for obtaining the accurate inverse by successive iterative corrections of this first approximation. The latter, of course, are more costly in terms of time and storage, since each correction involves the solution of n sets of linear equations and since the original A and its LU decomposition must be stored together with the first and successively corrected approximations to the inverse. In practice the storage requirements for the ‘corrected’ inverse functions are about double those of the ‘approximate’ inverse functions, though the extra computer time is not prohibitive since the same matrix and the same LU decomposition is used in every linear equation solution.
Despite the extra work of the ‘corrected’ inverse functions they are superior to the ‘approximate’ inverse functions. A correction provides a means of estimating the number of accurate figures in the inverse or the number of ‘meaningful’ figures relating to the degree of uncertainty in the coefficients of the matrix.
The residual matrix R=AX-I, where X is a computed inverse of A, conveys useful information. Firstly R is a bound on the relative error in X and secondly R<12  guarantees the convergence of the iterative process in the ‘corrected’ inverse functions.
The decision trees for inversion show which functions in Chapter F04 and Chapter F07 should be used for the inversion of other special types of matrices not treated in the chapter.
(b) General real rectangular matrices
For real matrices nag_lapack_dgeqrf (f08ae) and nag_matop_real_gen_rq (f01qj) return QR and RQ factorizations of A respectively and nag_lapack_dgeqp3 (f08bf) returns the QR factorization with column interchanges. The corresponding complex functions are nag_lapack_zgeqrf (f08as), nag_matop_complex_gen_rq (f01rj) and nag_lapack_zgeqp3 (f08bt) respectively. Functions are also provided to form the orthogonal matrices and transform by the orthogonal matrices following the use of the above functions. nag_matop_real_trapez_rq (f01qg) and nag_matop_complex_trapez_rq (f01rg) form the RQ factorization of an upper trapezoidal matrix for the real and complex cases respectively.
nag_matop_real_gen_pseudinv (f01bl) uses the QR factorization as described in Matrix Inversion(ii)(a) and is the only function that explicitly returns a pseudo-inverse. If mn, then the function will calculate the pseudo-inverse A+ of the matrix A. If m<n, then the n by m matrix AT should be used. The function will calculate the pseudo-inverse Z=AT+=A+T of AT and the required pseudo-inverse will be ZT. The function also attempts to calculate the rank, r, of the matrix given a tolerance to decide when elements can be regarded as zero. However, should this function fail due to an incorrect determination of the rank, the singular value decomposition method (described below) should be used.
nag_lapack_dgesvd (f08kb) and nag_lapack_zgesvd (f08kp) compute the singular value decomposition as described in Background to the Problems for real and complex matrices respectively. If A has rank rk=minm,n then the k-r smallest singular values will be negligible and the pseudo-inverse of A can be obtained as A+=VΣ-1UT as described in Background to the Problems. If the rank of A is not known in advance it can be estimated from the singular values (see The Rank of a Matrix in the F04 Chapter Introduction). In the real case with mn, nag_lapack_dgeqrf (f08ae) followed by nag_eigen_real_triang_svd (f02wu) provide details of the QR factorization or the singular value decomposition depending on whether or not A is of full rank and for some problems provides an attractive alternative to nag_lapack_dgesvd (f08kb). For large sparse matrices, leading terms in the singular value decomposition can be computed using functions from Chapter F12.

Matrix Factorizations

Each of these functions serves a special purpose required for the solution of sets of simultaneous linear equations or the eigenvalue problem. For further details you should consult Recommendations on Choice and Use of Available Functions or Decision Trees in the F02 Chapter Introduction or Recommendations on Choice and Use of Available Functions or Decision Trees in the F04 Chapter Introduction.
nag_matop_real_gen_sparse_lu (f01br) and nag_matop_real_gen_sparse_lu_reuse (f01bs) are provided for factorizing general real sparse matrices. A more recent algorithm for the same problem is available through nag_sparse_direct_real_gen_lu (f11me). For factorizing real symmetric positive definite sparse matrices, see nag_sparse_real_symm_precon_ichol (f11ja). These functions should be used only when A is not banded and when the total number of nonzero elements is less than 10% of the total number of elements. In all other cases either the band functions or the general functions should be used.

Matrix Arithmetic and Manipulation

The functions in the F01C section are designed for the general handling of m by n matrices. Emphasis has been placed on flexibility in the argument specifications and on avoiding, where possible, the use of internally declared arrays. They are therefore suited for use with large matrices of variable row and column dimensions. Functions are included for the addition and subtraction of sub-matrices of larger matrices, as well as the standard manipulations of full matrices. Those functions involving matrix multiplication may use additional-precision arithmetic for the accumulation of inner products. See also .
The functions in the F01V (LAPACK) and F01Z section are designed to allow conversion between full storage format and one of the packed storage schemes required by some of the functions in Chapters F02, F04, F07 and F08.

NAG Names and LAPACK Names

Functions with NAG name beginning F01V may be called either by their NAG names or by their LAPACK names. When using the NAG Library, the double precision form of the LAPACK name must be used (beginning with D- or Z-).
References to Chapter F01 functions in the manual normally include the LAPACK double precision names, for example, nag_matop_dtrttf (f01ve).
The LAPACK function names follow a simple scheme (which is similar to that used for the BLAS in ). Most names have the structure XYYTZZ, where the components have the following meanings:
– the initial letter, X, indicates the data type (real or complex) and precision:
– the fourth letter, T, indicates that the function is performing a storage scheme transformation (conversion)
– the letters YY indicate the original storage scheme used to store a triangular part of the matrix A, while the letters ZZ indicate the target storage scheme of the conversion (YY cannot equal ZZ since this would do nothing):

Matrix Functions

nag_matop_real_gen_matrix_exp (f01ec) and nag_matop_complex_gen_matrix_exp (f01fc) compute the matrix exponential, eA, of a real and complex square matrix A respectively. If estimates of the condition number of the matrix exponential are required then nag_matop_real_gen_matrix_cond_exp (f01jg) and nag_matop_complex_gen_matrix_cond_exp (f01kg) should be used. If Fréchet derivatives are required then nag_matop_real_gen_matrix_frcht_exp (f01jh) and nag_matop_complex_gen_matrix_frcht_exp (f01kh) should be used.
nag_matop_real_symm_matrix_exp (f01ed) and nag_matop_complex_herm_matrix_exp (f01fd) compute the matrix exponential, eA, of a real symmetric and complex Hermitian matrix respectively. If the matrix is real symmetric, or complex Hermitian then it is recommended that nag_matop_real_symm_matrix_exp (f01ed), or nag_matop_complex_herm_matrix_exp (f01fd) be used as they are more efficient and, in general, more accurate than nag_matop_real_gen_matrix_exp (f01ec) and nag_matop_complex_gen_matrix_exp (f01fc).
nag_matop_real_gen_matrix_log (f01ej) and nag_matop_complex_gen_matrix_log (f01fj) compute the principal matrix logarithm, logA, of a real and complex square matrix A respectively. If estimates of the condition number of the matrix logarithm are required then nag_matop_real_gen_matrix_cond_log (f01jj) and nag_matop_complex_gen_matrix_cond_log (f01kj) should be used. If Fréchet derivatives are required then nag_matop_real_gen_matrix_frcht_log (f01jk) and nag_matop_complex_gen_matrix_frcht_log (f01kk) should be used.
nag_matop_real_gen_matrix_fun_std (f01ek) and nag_matop_complex_gen_matrix_fun_std (f01fk) compute the matrix exponential, sine, cosine, sinh or cosh of a real and complex square matrix A respectively. If the matrix exponential is required then it is recommended that nag_matop_real_gen_matrix_exp (f01ec) or nag_matop_complex_gen_matrix_exp (f01fc) be used as they are, in general, more accurate than nag_matop_real_gen_matrix_fun_std (f01ek) and nag_matop_complex_gen_matrix_fun_std (f01fk). If estimates of the condition number of the matrix function are required then nag_matop_real_gen_matrix_cond_std (f01ja) and nag_matop_complex_gen_matrix_cond_std (f01ka) should be used.
nag_matop_real_gen_matrix_fun_num (f01el) and nag_matop_real_gen_matrix_fun_usd (f01em) compute the matrix function, fA, of a real square matrix. nag_matop_complex_gen_matrix_fun_num (f01fl) and nag_matop_complex_gen_matrix_fun_usd (f01fm) compute the matrix function of a complex square matrix. The derivatives of f are required for these computations. nag_matop_real_gen_matrix_fun_num (f01el) and nag_matop_complex_gen_matrix_fun_num (f01fl) use numerical differentiation to obtain the derivatives of f. nag_matop_real_gen_matrix_fun_usd (f01em) and nag_matop_complex_gen_matrix_fun_usd (f01fm) use derivatives you have supplied. If estimates of the condition number are required but you are not supplying derivatives then nag_matop_real_gen_matrix_cond_num (f01jb) and nag_matop_complex_gen_matrix_cond_num (f01kb) should be used. If estimates of the condition number of the matrix function are required and you are supplying derivatives of f, then nag_matop_real_gen_matrix_cond_usd (f01jc) and nag_matop_complex_gen_matrix_cond_usd (f01kc) should be used.
If the matrix A is real symmetric or complex Hermitian then it is recommended that to compute the matrix function, fA, nag_matop_real_symm_matrix_fun (f01ef) and nag_matop_complex_herm_matrix_fun (f01ff) are used respectively as they are more efficient and, in general, more accurate than nag_matop_real_gen_matrix_fun_num (f01el), nag_matop_real_gen_matrix_fun_usd (f01em), nag_matop_complex_gen_matrix_fun_num (f01fl) and nag_matop_complex_gen_matrix_fun_usd (f01fm).
nag_matop_real_gen_matrix_actexp (f01ga) and nag_matop_complex_gen_matrix_actexp (f01ha) compute the matrix function etAB for explicitly stored dense real and complex matrices A and B respectively while nag_matop_real_gen_matrix_actexp_rcomm (f01gb) and nag_matop_complex_gen_matrix_actexp_rcomm (f01hb) compute the same using reverse communication. In the latter case, control is returned to you. You should calculate any required matrix-matrix products and then call the function again. See Direct and Reverse Communication functions in Calling NAG Routines From MATLAB for further information.
nag_matop_real_gen_matrix_sqrt (f01en) and nag_matop_complex_gen_matrix_sqrt (f01fn) compute the principal square root A1/2 of a real and complex square matrix A respectively. If A is complex and upper triangular then nag_matop_complex_tri_matrix_sqrt (f01fp) should be used. If A is real and upper quasi-triangular then nag_matop_real_tri_matrix_sqrt (f01ep) should be used. If estimates of the condition number of the matrix square root are required then nag_matop_real_gen_matrix_cond_sqrt (f01jd) and nag_matop_complex_gen_matrix_cond_sqrt (f01kd) should be used.
nag_matop_real_gen_matrix_pow (f01eq) and nag_matop_complex_gen_matrix_pow (f01fq) compute the matrix power Ap, where p, of real and complex matrices respectively. If estimates of the condition number of the matrix power are required then nag_matop_real_gen_matrix_cond_pow (f01je) and nag_matop_complex_gen_matrix_cond_pow (f01ke) should be used. If Fréchet derivatives are required then nag_matop_real_gen_matrix_frcht_pow (f01jf) and nag_matop_complex_gen_matrix_frcht_pow (f01kf) should be used.

Decision Trees

The decision trees show the functions in this chapter and in Chapter F04, Chapter F07 and Chapter F08 that should be used for inverting matrices of various types. They also show which function should be used to calculate various matrix functions.
(i) Matrix Inversion:

Tree 1

Is A an n by n matrix of rank n?   Is A a real matrix?   see Tree 2
yesyes
  no   no
see Tree 3
see Tree 4

Tree 2: Inverse of a real n by n matrix of full rank

Is A a band matrix?   See Note 1.
yes
  no
Is A symmetric?   Is A positive definite?   Do you want guaranteed accuracy? (See Note 2)   nag_matop_real_symm_posdef_inv (f01ab)
yesyesyes
  no   no   no
Is one triangle of A stored as a linear array?   nag_lapack_dpptrf (f07gd) and nag_lapack_dpptri (f07gj)
yes
  no
nag_matop_real_symm_posdef_inv_noref (f01ad) or nag_lapack_dpotrf (f07fd) and nag_lapack_dpotri (f07fj)
Is one triangle of A stored as a linear array?   nag_lapack_dsptrf (f07pd) and nag_lapack_dsptri (f07pj)
yes
  no
nag_lapack_dsytrf (f07md) and nag_lapack_dsytri (f07mj)
Is A triangular?   Is A stored as a linear array?   nag_lapack_dtptri (f07uj)
yesyes
  no   no
nag_lapack_dtrtri (f07tj)
Do you want guaranteed accuracy? (See Note 2)   nag_linsys_real_square_solve_ref (f04ae)
yes
  no
nag_lapack_dgetrf (f07ad) and nag_lapack_dgetri (f07aj)

Tree 3: Inverse of a complex n by n matrix of full rank

Is A a band matrix?   See Note 1.
yes
  no
Is A Hermitian?   Is A positive definite?   Is one triangle of A stored as a linear array?   nag_lapack_zpptrf (f07gr) and nag_lapack_zpptri (f07gw)
yesyesyes
  no   no   no
nag_lapack_zpotrf (f07fr) and nag_lapack_zpotri (f07fw)
Is one triangle A stored as a linear array?   nag_lapack_zhptrf (f07pr) and nag_lapack_zhptri (f07pw)
yes
  no
nag_lapack_zhetrf (f07mr) and nag_lapack_zhetri (f07mw)
Is A symmetric?   Is one triangle of A stored as a linear array?   nag_lapack_zsptrf (f07qr) and nag_lapack_zsptri (f07qw)
yesyes
  no   no
nag_lapack_zsytrf (f07nr) and nag_lapack_zsytri (f07nw)
Is A triangular?   Is A stored as a linear array?   nag_lapack_ztptri (f07uw)
yesyes
  no   no
nag_lapack_ztrtri (f07tw)
nag_lapack_zgesv (f07an) or nag_lapack_zgetrf (f07ar) and nag_lapack_zgetri (f07aw)

Tree 4: Pseudo-inverses

Is A a complex matrix?   Is A of full rank?   Is A an m by n matrix with m<n?   nag_matop_complex_gen_rq (f01rj) and nag_matop_complex_gen_rq_formq (f01rk)
yesyesyes
  no   no   no
nag_lapack_zgeqrf (f08as) and nag_lapack_zunmqr (f08au) or nag_lapack_zungqr (f08at)
nag_lapack_zgesvd (f08kp)
Is A of full rank?   Is A an m by n matrix with m<n?   nag_matop_real_gen_rq (f01qj) and nag_matop_real_gen_rq_formq (f01qk)
yesyes
  no   no
nag_lapack_dgeqrf (f08ae) and nag_lapack_dormqr (f08ag) or nag_lapack_dorgqr (f08af)
Is A an m by n matrix with m<n?   nag_lapack_dgesvd (f08kb)
yes
  no
Is reliability more important than efficiency?   nag_lapack_dgesvd (f08kb)
yes
  no
nag_matop_real_gen_pseudinv (f01bl)
Note 1: the inverse of a band matrix A does not in general have the same shape as A, and no functions are provided specifically for finding such an inverse. The matrix must either be treated as a full matrix, or the equations AX=B must be solved, where B has been initialized to the identity matrix I. In the latter case, see the decision trees in Decision Trees in the F04 Chapter Introduction.
Note 2: by ‘guaranteed accuracy’ we mean that the accuracy of the inverse is improved by use of the iterative refinement technique using additional precision.
(ii) Matrix Factorizations: see the decision trees in Decision Trees in the F02 and F04 Chapter Introductions.
(iii) Matrix Arithmetic and Manipulation: not appropriate.
(iv) Matrix Functions:

Tree 5: Matrix functions fA of an n by n real matrix A 

Is etAB required?   Is A stored in dense format?   nag_matop_real_gen_matrix_actexp (f01ga)
yesyes
  no   no
nag_matop_real_gen_matrix_actexp_rcomm (f01gb)
Is A real symmetric?   Is eA required?   nag_matop_real_symm_matrix_exp (f01ed)
yesyes
  no   no
nag_matop_real_symm_matrix_fun (f01ef)
Is cosA or coshA or sinA or sinhA required?   Is the condition number of the matrix function required?   nag_matop_real_gen_matrix_cond_std (f01ja)
yesyes
  no   no
nag_matop_real_gen_matrix_fun_std (f01ek)
Is logA required?   Is the condition number of the matrix logarithm required?   nag_matop_real_gen_matrix_cond_log (f01jj)
yesyes
  no   no
Is the Fréchet derivative of the matrix logarithm required?   nag_matop_real_gen_matrix_frcht_log (f01jk)
yes
  no
nag_matop_real_gen_matrix_log (f01ej)
Is expA required?   Is the condition number of the matrix exponential required?   nag_matop_real_gen_matrix_cond_exp (f01jg)
yesyes
  no   no
Is the Fréchet derivative of the matrix exponential required?   nag_matop_real_gen_matrix_frcht_exp (f01jh)
yes
  no
nag_matop_real_gen_matrix_exp (f01ec)
Is A1/2 required?   Is the condition number of the matrix square root required?   nag_matop_real_gen_matrix_cond_sqrt (f01jd)
yesyes
  no   no
Is the matrix upper quasi-triangular?   nag_matop_real_tri_matrix_sqrt (f01ep)
yes
  no
nag_matop_real_gen_matrix_sqrt (f01en)
Is Ap required?   Is the condition number of the matrix power required?   nag_matop_real_gen_matrix_cond_pow (f01je)
yesyes
  no   no
Is the Fréchet derivative of the matrix power required?   nag_matop_real_gen_matrix_frcht_pow (f01jf)
yes
  no
nag_matop_real_gen_matrix_pow (f01eq)
fA will be computed. Will derivatives of f be supplied by the user?   Is the condition number of the matrix function required?   nag_matop_real_gen_matrix_cond_usd (f01jc)
yesyes
  no   no
nag_matop_real_gen_matrix_fun_usd (f01em)
Is the condition number of the matrix function required?   nag_matop_real_gen_matrix_cond_num (f01jb)
yes
  no
nag_matop_real_gen_matrix_fun_num (f01el)

Tree 6: Matrix functions fA of an n by n complex matrix A 

Is etAB required?   Is A stored in dense format?   nag_matop_complex_gen_matrix_actexp (f01ha)
yesyes
  no   no
nag_matop_complex_gen_matrix_actexp_rcomm (f01hb)
Is A complex Hermitian?   Is eA required?   nag_matop_complex_herm_matrix_exp (f01fd)
yesyes
  no   no
nag_matop_complex_herm_matrix_fun (f01ff)
Is cosA or coshA or sinA or sinhA required?   Is the condition number of the matrix function required?   nag_matop_complex_gen_matrix_cond_std (f01ka)
yesyes
  no   no
nag_matop_complex_gen_matrix_fun_std (f01fk)
Is logA required?   Is the condition number of the matrix logarithm required?   nag_matop_complex_gen_matrix_cond_log (f01kj)
yesyes
  no   no
Is the Fréchet derivative of the matrix logarithm required?   nag_matop_complex_gen_matrix_frcht_log (f01kk)
yes
  no
nag_matop_complex_gen_matrix_log (f01fj)
Is expA required?   Is the condition number of the matrix exponential required?   nag_matop_complex_gen_matrix_cond_exp (f01kg)
yesyes
  no   no
Is the Fréchet derivative of the matrix exponential required?   nag_matop_complex_gen_matrix_frcht_exp (f01kh)
yes
  no
nag_matop_complex_gen_matrix_exp (f01fc)
Is A1/2 required?   Is the condition number of the matrix square root required?   nag_matop_complex_gen_matrix_cond_sqrt (f01kd)
yesyes
  no   no
Is the matrix upper triangular?   nag_matop_complex_tri_matrix_sqrt (f01fp)
yes
  no
nag_matop_complex_gen_matrix_sqrt (f01fn)
Is Ap required?   Is the condition number of the matrix power required?   nag_matop_complex_gen_matrix_cond_pow (f01ke)
yesyes
  no   no
Is the Fréchet derivative of the matrix power required?   nag_matop_complex_gen_matrix_frcht_pow (f01kf)
yes
  no
nag_matop_complex_gen_matrix_pow (f01fq)
fA will be computed. Will derivatives of f be supplied by the user?   Is the condition number of the matrix function required?   nag_matop_complex_gen_matrix_cond_usd (f01kc)
yesyes
  no   no
nag_matop_complex_gen_matrix_fun_usd (f01fm)
Is the condition number of the matrix function required?   nag_matop_complex_gen_matrix_cond_num (f01kb)
yes
  no
nag_matop_complex_gen_matrix_fun_num (f01fl)

Functionality Index

Action of the matrix exponential on a complex matrix nag_matop_complex_gen_matrix_actexp (f01ha)
Action of the matrix exponential on a complex matrix (reverse communication) nag_matop_complex_gen_matrix_actexp_rcomm (f01hb)
Action of the matrix exponential on a real matrix nag_matop_real_gen_matrix_actexp (f01ga)
Action of the matrix exponential on a real matrix (reverse communication) nag_matop_real_gen_matrix_actexp_rcomm (f01gb)
Inversion (also see Chapter F07), 
    real m by n matrix, 
        pseudo-inverse nag_matop_real_gen_pseudinv (f01bl)
    real symmetric positive definite matrix, 
        accurate inverse nag_matop_real_symm_posdef_inv (f01ab)
        approximate inverse nag_matop_real_symm_posdef_inv_noref (f01ad)
Matrix Arithmetic and Manipulation, 
    matrix addition, 
        complex matrices nag_matop_complex_addsub (f01cw)
        real matrices nag_matop_real_addsub (f01ct)
    matrix multiplication nag_matop_real_gen_matmul (f01ck)
    matrix storage conversion, 
        full to packed triangular storage, 
            complex matrices nag_matop_ztrttp (f01vb)
            real matrices nag_matop_dtrttp (f01va)
        full to Rectangular Full Packed storage, 
            complex matrix nag_matop_ztrttf (f01vf)
            real matrix nag_matop_dtrttf (f01ve)
        packed band  ↔  rectangular storage, special provision for diagonal 
            complex matrices nag_matop_complex_band_pack (f01zd)
            real matrices nag_matop_real_band_pack (f01zc)
        packed triangular to full storage, 
            complex matrices nag_matop_ztpttr (f01vd)
            real matrices nag_matop_dtpttr (f01vc)
        packed triangular to Rectangular Full Packed storage, 
            complex matrices nag_matop_ztpttf (f01vk)
            real matrices nag_matop_dtpttf (f01vj)
        packed triangular  ↔  square storage, special provision for diagonal 
            complex matrices nag_matop_complex_tri_pack (f01zb)
            real matrices nag_matop_real_tri_pack (f01za)
        Rectangular Full Packed to full storage, 
            complex matrices nag_matop_ztfttr (f01vh)
            real matrices nag_matop_dtfttr (f01vg)
        Rectangular Full Packed to packed triangular storage, 
            complex matrices nag_matop_ztfttp (f01vm)
            real matrices nag_matop_dtfttp (f01vl)
    matrix subtraction, 
        complex matrices nag_matop_complex_addsub (f01cw)
        real matrices nag_matop_real_addsub (f01ct)
    matrix transpose nag_matop_real_gen_trans_inplace (f01cr)
Matrix function, 
    complex Hermitian n by n matrix, 
        matrix exponential nag_matop_complex_herm_matrix_exp (f01fd)
        matrix function nag_matop_complex_herm_matrix_fun (f01ff)
    complex n by n matrix, 
        condition number for a matrix exponential nag_matop_complex_gen_matrix_cond_exp (f01kg)
        condition number for a matrix exponential, logarithm, sine, cosine, sinh or cosh nag_matop_complex_gen_matrix_cond_std (f01ka)
        condition number for a matrix function, using numerical differentiation nag_matop_complex_gen_matrix_cond_num (f01kb)
        condition number for a matrix function, using user-supplied derivatives nag_matop_complex_gen_matrix_cond_usd (f01kc)
        condition number for a matrix logarithm nag_matop_complex_gen_matrix_cond_log (f01kj)
        condition number for a matrix power nag_matop_complex_gen_matrix_cond_pow (f01ke)
        condition number for the matrix square root, logarithm, sine, cosine, sinh or cosh nag_matop_complex_gen_matrix_cond_sqrt (f01kd)
        Fréchet derivative 
            matrix exponential nag_matop_complex_gen_matrix_frcht_exp (f01kh)
            matrix logarithm nag_matop_complex_gen_matrix_frcht_log (f01kk)
            matrix power nag_matop_complex_gen_matrix_frcht_pow (f01kf)
        general power 
            matrix nag_matop_complex_gen_matrix_pow (f01fq)
        matrix exponential nag_matop_complex_gen_matrix_exp (f01fc)
        matrix exponential, sine, cosine, sinh or cosh nag_matop_complex_gen_matrix_fun_std (f01fk)
        matrix function, using numerical differentiation nag_matop_complex_gen_matrix_fun_num (f01fl)
        matrix function, using user-supplied derivatives nag_matop_complex_gen_matrix_fun_usd (f01fm)
        matrix logarithm nag_matop_complex_gen_matrix_log (f01fj)
        matrix square root nag_matop_complex_gen_matrix_sqrt (f01fn)
        upper triangular 
            matrix square root nag_matop_complex_tri_matrix_sqrt (f01fp)
    real n by n matrix, 
        condition number for a matrix exponential nag_matop_real_gen_matrix_cond_exp (f01jg)
        condition number for a matrix function, using numerical differentiation nag_matop_real_gen_matrix_cond_num (f01jb)
        condition number for a matrix function, using user-supplied derivatives nag_matop_real_gen_matrix_cond_usd (f01jc)
        condition number for a matrix logarithm nag_matop_real_gen_matrix_cond_log (f01jj)
        condition number for a matrix power nag_matop_real_gen_matrix_cond_pow (f01je)
        condition number for the matrix exponential, logarithm, sine, cosine, sinh or cosh nag_matop_real_gen_matrix_cond_std (f01ja)
        condition number for the matrix square root, logarithm, sine, cosine, sinh or cosh nag_matop_real_gen_matrix_cond_sqrt (f01jd)
        Fréchet derivative 
            matrix exponential nag_matop_real_gen_matrix_frcht_exp (f01jh)
            matrix logarithm nag_matop_real_gen_matrix_frcht_log (f01jk)
            matrix power nag_matop_real_gen_matrix_frcht_pow (f01jf)
        general power 
            matrix exponential nag_matop_real_gen_matrix_pow (f01eq)
        matrix exponential nag_matop_real_gen_matrix_exp (f01ec)
        matrix exponential, sine, cosine, sinh or cosh nag_matop_real_gen_matrix_fun_std (f01ek)
        matrix function, using numerical differentiation nag_matop_real_gen_matrix_fun_num (f01el)
        matrix function, using user-supplied derivatives nag_matop_real_gen_matrix_fun_usd (f01em)
        matrix logarithm nag_matop_real_gen_matrix_log (f01ej)
        matrix square root nag_matop_real_gen_matrix_sqrt (f01en)
        upper quasi-triangular 
            matrix square root nag_matop_real_tri_matrix_sqrt (f01ep)
    real symmetric n by n matrix, 
        matrix exponential nag_matop_real_symm_matrix_exp (f01ed)
        matrix function nag_matop_real_symm_matrix_fun (f01ef)
Matrix Transformations, 
    complex matrix, form unitary matrix nag_matop_complex_gen_rq_formq (f01rk)
    complex m by n(m ≤ n) matrix, 
        RQ factorization nag_matop_complex_gen_rq (f01rj)
    complex upper trapezoidal matrix, 
        RQ factorization nag_matop_complex_trapez_rq (f01rg)
    eigenproblem Ax = λBx, A, B banded, 
        reduction to standard symmetric problem nag_matop_real_symm_posdef_geneig (f01bv)
    real almost block-diagonal matrix, 
        LU factorization nag_matop_real_gen_blkdiag_lu (f01lh)
    real band symmetric positive definite matrix, 
        ULDLTUT factorization nag_matop_real_symm_posdef_fac (f01bu)
        variable bandwidth, LDLT factorization nag_matop_real_vband_posdef_fac (f01mc)
    real matrix, 
        form orthogonal matrix nag_matop_real_gen_rq_formq (f01qk)
    real m by n(m  ≤  n) matrix, 
        RQ factorization nag_matop_real_gen_rq (f01qj)
    real sparse matrix, 
        factorization nag_matop_real_gen_sparse_lu (f01br)
        factorization, known sparsity pattern nag_matop_real_gen_sparse_lu_reuse (f01bs)
    real upper trapezoidal matrix, 
        RQ factorization nag_matop_real_trapez_rq (f01qg)
    tridiagonal matrix, 
        LU factorization nag_matop_real_gen_tridiag_lu (f01le)

References

Golub G H and Van Loan C F (1996) Matrix Computations (3rd Edition) Johns Hopkins University Press, Baltimore
Higham N J (2008) Functions of Matrices: Theory and Computation SIAM, Philadelphia, PA, USA
Wilkinson J H (1965) The Algebraic Eigenvalue Problem Oxford University Press, Oxford
Wilkinson J H (1977) Some recent advances in numerical linear algebra The State of the Art in Numerical Analysis (ed D A H Jacobs) Academic Press
Wilkinson J H and Reinsch C (1971) Handbook for Automatic Computation II, Linear Algebra Springer–Verlag

PDF version (NAG web site, 64-bit version, 64-bit version)
Chapter Contents
Chapter Introduction
NAG Toolbox

© The Numerical Algorithms Group Ltd, Oxford, UK. 2009–2015