F02 Chapter Contents
F02 Chapter Introduction (PDF version)
NAG Library Manual

NAG Library Chapter Introduction

F02 – Eigenvalues and Eigenvectors

+ Contents

1  Scope of the Chapter

This chapter provides routines for various types of matrix eigenvalue problem: Routines are provided for both real and complex data.
The majority of routines for these problems can be found in Chapter F08 which contains software derived from LAPACK (see Anderson et al. (1999)). However, you should read the introduction to this chapter before turning to Chapter F08, especially if you are a new user. Chapter F12 contains routines for large sparse eigenvalue problems, although one such routine is also available in this chapter.
Chapters F02 and F08 contain Black Box (or Driver) routines that enable many problems to be solved by a call to a single routine, and the decision trees in Section 4 direct you to the most appropriate routines in Chapters F02 and F08. The Chapter F02 routines call routines in Chapters F07 and F08 wherever possible to perform the computations, and there are pointers in Section 4 to the relevant decision trees in Chapter F08.

2  Background to the Problems

Here we describe the different types of problem which can be tackled by the routines in this chapter, and give a brief outline of the methods used to solve them. If you have one specific type of problem to solve, you need only read the relevant sub-section and then turn to Section 3. Consult a standard textbook for a more thorough discussion, for example Golub and Van Loan (1996) or Parlett (1998).
In each sub-section, we first describe the problem in terms of real matrices. The changes needed to adapt the discussion to complex matrices are usually simple and obvious: a matrix transpose such as QT must be replaced by its conjugate transpose QH; symmetric matrices must be replaced by Hermitian matrices, and orthogonal matrices by unitary matrices. Any additional changes are noted at the end of the sub-section.

2.1  Standard Eigenvalue Problems

Let A be a square matrix of order n. The standard eigenvalue problem is to find eigenvalues, λ, and corresponding eigenvectors, x0, such that
Ax=λx. (1)
(The phrase ‘eigenvalue problem’ is sometimes abbreviated to eigenproblem.)

2.1.1  Standard symmetric eigenvalue problems

If A is real symmetric, the eigenvalue problem has many desirable features, and it is advisable to take advantage of symmetry whenever possible.
The eigenvalues λ are all real, and the eigenvectors can be chosen to be mutually orthogonal. That is, we can write
Azi=λizi  for ​i=1,2,,n
or equivalently:
AZ=ZΛ (2)
where Λ is a real diagonal matrix whose diagonal elements λi are the eigenvalues, and Z is a real orthogonal matrix whose columns zi are the eigenvectors. This implies that ziT zj = 0  if ij, and zi2=1.
Equation (2) can be rewritten
A=ZΛZT. (3)
This is known as the eigen-decomposition or spectral factorization of A.
Eigenvalues of a real symmetric matrix are well-conditioned, that is, they are not unduly sensitive to perturbations in the original matrix A. The sensitivity of an eigenvector depends on how small the gap is between its eigenvalue and any other eigenvalue: the smaller the gap, the more sensitive the eigenvector. More details on the accuracy of computed eigenvalues and eigenvectors are given in the routine documents, and in the F08 Chapter Introduction.
For dense or band matrices, the computation of eigenvalues and eigenvectors proceeds in the following stages:
  1. A is reduced to a symmetric tridiagonal matrix T by an orthogonal similarity transformation: A=QTQT, where Q is orthogonal. (A tridiagonal matrix is zero except for the main diagonal and the first subdiagonal and superdiagonal on either side.) T has the same eigenvalues as A and is easier to handle.
  2. Eigenvalues and eigenvectors of T are computed as required. If all eigenvalues (and optionally eigenvectors) are required, they are computed by the QR algorithm, which effectively factorizes T as T=SΛST, where S is orthogonal. If only selected eigenvalues are required, they are computed by bisection, and if selected eigenvectors are required, they are computed by inverse iteration. If s is an eigenvector of T, then Qs is an eigenvector of A.
All the above remarks also apply – with the obvious changes – to the case when A is a complex Hermitian matrix. The eigenvectors are complex, but the eigenvalues are all real, and so is the tridiagonal matrix T.
If A is large and sparse, the methods just described would be very wasteful in both storage and computing time, and therefore an alternative algorithm, known as subspace iteration, is provided (for real problems only) to find a (usually small) subset of the eigenvalues and their corresponding eigenvectors. Chapter F12 contains routines based on the Lanczos method for real symmetric large sparse eigenvalue problems, and these routines are usually more efficient than subspace iteration.

2.1.2  Standard nonsymmetric eigenvalue problems

A real nonsymmetric matrix A may have complex eigenvalues, occurring as complex conjugate pairs. If x is an eigenvector corresponding to a complex eigenvalue λ, then the complex conjugate vector x- is the eigenvector corresponding to the complex conjugate eigenvalue λ-. Note that the vector x defined in equation (1) is sometimes called a right eigenvector; a left eigenvector y is defined by
yHA=λyH  or  ATy=λ-y.
Routines in this chapter only compute right eigenvectors (the usual requirement), but routines in Chapter F08 can compute left or right eigenvectors or both.
The eigenvalue problem can be solved via the Schur factorization of A, defined as
A=ZTZT,
where Z is an orthogonal matrix and T is a real upper quasi-triangular matrix, with the same eigenvalues as A. T is called the Schur form of A. If all the eigenvalues of A are real, then T is upper triangular, and its diagonal elements are the eigenvalues of A. If A has complex conjugate pairs of eigenvalues, then T has 2 by 2 diagonal blocks, whose eigenvalues are the complex conjugate pairs of eigenvalues of A. (The structure of T is simpler if the matrices are complex – see below.)
For example, the following matrix is in quasi-triangular form
1 * * * 0 2 -1 * 0 1 2 * 0 0 0 3
and has eigenvalues 1, 2±i, and 3. (The elements indicated by ‘*’ may take any values.)
The columns of Z are called the Schur vectors. For each k1kn, the first k columns of Z form an orthonormal basis for the invariant subspace corresponding to the first k eigenvalues on the diagonal of T. (An invariant subspace (for A) is a subspace S such that for any vector v in S, Av is also in S.) Because this basis is orthonormal, it is preferable in many applications to compute Schur vectors rather than eigenvectors. It is possible to order the Schur factorization so that any desired set of k eigenvalues occupy the k leading positions on the diagonal of T, and routines for this purpose are provided in Chapter F08.
Note that if A is symmetric, the Schur vectors are the same as the eigenvectors, but if A is nonsymmetric, they are distinct, and the Schur vectors, being orthonormal, are often more satisfactory to work with in numerical computation.
Eigenvalues and eigenvectors of a nonsymmetric matrix may be ill-conditioned, that is, sensitive to perturbations in A. Chapter F08 contains routines which compute or estimate the condition numbers of eigenvalues and eigenvectors, and the F08 Chapter Introduction gives more details about the error analysis of nonsymmetric eigenproblems. The accuracy with which eigenvalues and eigenvectors can be obtained is often improved by balancing a matrix. This is discussed further in Section 3.4.
Computation of eigenvalues, eigenvectors or the Schur factorization proceeds in the following stages:
  1. A is reduced to an upper Hessenberg matrix H by an orthogonal similarity transformation: A=QHQT, where Q is orthogonal. (An upper Hessenberg matrix is zero below the first subdiagonal.) H has the same eigenvalues as A, and is easier to handle.
  2. The upper Hessenberg matrix H is reduced to Schur form T by the QR algorithm, giving the Schur factorization H=STST. The eigenvalues of A are obtained from the diagonal blocks of T. The matrix Z of Schur vectors (if required) is computed as Z=QS.
  3. After the eigenvalues have been found, eigenvectors may be computed, if required, in two different ways. Eigenvectors of H can be computed by inverse iteration, and then pre-multiplied by Q to give eigenvectors of A; this approach is usually preferred if only a few eigenvectors are required. Alternatively, eigenvectors of T can be computed by back-substitution, and pre-multiplied by Z to give eigenvectors of A.
All the above remarks also apply – with the obvious changes – to the case when A is a complex matrix. The eigenvalues are in general complex, so there is no need for special treatment of complex conjugate pairs, and the Schur form T is simply a complex upper triangular matrix.
As for the symmetric eigenvalue problem, if A and is large and sparse then it is generally preferable to use an alternative method. Chapter F12 provides routines based on Arnoldi's method for both real and complex matrices, intended to find a subset of the eigenvalues and vectors.

2.2  The Singular Value Decomposition

The singular value decomposition (SVD) of a real m by n matrix A is given by
A=UΣVT,
where U and V are orthogonal and Σ is an m by n diagonal matrix with real diagonal elements, σi, such that
σ1σ2σminm,n0.
The σi are the singular values of A and the first minm,n columns of U and V are, respectively, the left and right singular vectors of A. The singular values and singular vectors satisfy
Avi=σiui  and  ATui=σivi
where ui and vi are the ith columns of U and V respectively.
The singular value decomposition of A is closely related to the eigen-decompositions of the symmetric matrices ATA or AAT, because:
ATAvi=σi2vi  and  AATui=σi2ui.
However, these relationships are not recommended as a means of computing singular values or vectors unless A is sparse and routines from Chapter F12 are to be used.
If Uk, Vk denote the leading k columns of U and V respectively, and if Σk denotes the leading principal submatrix of Σ, then
Ak Uk Σk VTk
is the best rank-k approximation to A in both the 2-norm and the Frobenius norm.
Singular values are well-conditioned; that is, they are not unduly sensitive to perturbations in A. The sensitivity of a singular vector depends on how small the gap is between its singular value and any other singular value: the smaller the gap, the more sensitive the singular vector. More details on the accuracy of computed singular values and vectors are given in the routine documents and in the F08 Chapter Introduction.
The singular value decomposition is useful for the numerical determination of the rank of a matrix, and for solving linear least squares problems, especially when they are rank-deficient (or nearly so). See Chapter F04.
Computation of singular values and vectors proceeds in the following stages:
  1. A is reduced to an upper bidiagonal matrix B by an orthogonal transformation A=U1BV1T, where U1 and V1 are orthogonal. (An upper bidiagonal matrix is zero except for the main diagonal and the first superdiagonal.) B has the same singular values as A, and is easier to handle.
  2. The SVD of the bidiagonal matrix B is computed as B = U2 Σ V2T , where U2 and V2 are orthogonal and Σ is diagonal as described above. Then in the SVD of A, U=U1U2 and V=V1V2.
All the above remarks also apply – with the obvious changes – to the case when A is a complex matrix. The singular vectors are complex, but the singular values are real and non-negative, and the bidiagonal matrix B is also real.
By formulating the problems appropriately, real large sparse singular value problems may be solved using the symmetric eigenvalue routines in Chapter F12.

2.3  Generalized Eigenvalue Problems

Let A and B be square matrices of order n. The generalized eigenvalue problem is to find eigenvalues, λ, and corresponding eigenvectors, x0, such that
Ax=λBx. (4)
For given A and B, the set of all matrices of the form A-λB is called a pencil, and λ and x are said to be an eigenvalue and eigenvector of the pencil A-λB.
When B is nonsingular, equation (4) is mathematically equivalent to B-1Ax=λx, and when A is nonsingular, it is equivalent to A-1Bx=1/λx. Thus, in theory, if one of the matrices A or B is known to be nonsingular, the problem could be reduced to a standard eigenvalue problem.
However, for this reduction to be satisfactory from the point of view of numerical stability, it is necessary not only that B (or A) should be nonsingular, but that it should be well-conditioned with respect to inversion. The nearer B is to singularity, the more unsatisfactory B-1A will be as a vehicle for determining the required eigenvalues. Well-determined eigenvalues of the original problem (4) may be poorly determined even by the correctly rounded version of B-1A.
We consider first a special class of problems in which B is known to be nonsingular, and then return to the general case in the following sub-section.

2.3.1  Generalized symmetric-definite eigenvalue problems

If A and B are symmetric and B is positive definite, then the generalized eigenvalue problem has desirable properties similar to those of the standard symmetric eigenvalue problem. The eigenvalues are all real, and the eigenvectors, while not orthogonal in the usual sense, satisfy the relations ziT B zj = 0  for ij and can be normalized so that ziT B zi = 1 .
Note that it is not enough for A and B to be symmetric; B must also be positive definite, which implies nonsingularity. Eigenproblems with these properties are referred to as symmetric-definite problems.
If Λ is the diagonal matrix whose diagonal elements are the eigenvalues, and Z is the matrix whose columns are the eigenvectors, then
ZTAZ=Λ  and  ZTBZ=I.
To compute eigenvalues and eigenvectors, the problem can be reduced to a standard symmetric eigenvalue problem, using the Cholesky factorization of B as LLT or UTU (see Chapter F07). Note, however, that this reduction does implicitly involve the inversion of B, and hence this approach should not be used if B is ill-conditioned with respect to inversion.
For example, with B=LLT, we have
Az=λBz L-1AL-T LTz = λLTz .
Hence the eigenvalues of Az=λBz are those of Cy=λy, where C is the symmetric matrix C = L-1 AL-T  and y=LTz. The standard symmetric eigenproblem Cy=λy may be solved by the methods described in Section 2.1.1. The eigenvectors z of the original problem may be recovered by computing z = L-T y .
Most of the routines which solve this class of problems can also solve the closely related problems
ABx=λx  or  BAx=λx
where again A and B are symmetric and B is positive definite. See the routine documents for details.
All the above remarks also apply – with the obvious changes – to the case when A and B are complex Hermitian matrices. Such problems are called Hermitian-definite. The eigenvectors are complex, but the eigenvalues are all real.
If A and B are large and sparse, reduction to an equivalent standard eigenproblem as described above would almost certainly result in a large dense matrix C, and hence would be very wasteful in both storage and computing time. The methods of subspace iteration and Lanczos type methods, mentioned in Section 2.1.1, can also be used for large sparse generalized symmetric-definite problems.

2.3.2  Generalized nonsymmetric eigenvalue problems

Any generalized eigenproblem which is not symmetric-definite with well-conditioned B must be handled as if it were a general nonsymmetric problem.
If B is singular, the problem has infinite eigenvalues. These are not a problem; they are equivalent to zero eigenvalues of the problem Bx=μAx. Computationally they appear as very large values.
If A and B are both singular and have a common null space, then A-λB is singular for all λ; in other words, any value λ can be regarded as an eigenvalue. Pencils with this property are called singular.
As with standard nonsymmetric problems, a real problem may have complex eigenvalues, occurring as complex conjugate pairs.
The generalized eigenvalue problem can be solved via the generalized Schur factorization of A and B:
A=QUZT,  B=QVZT
where Q and Z are orthogonal, V is upper triangular, and U is upper quasi-triangular (defined just as in Section 2.1.2).
If all the eigenvalues are real, then U is upper triangular; the eigenvalues are given by λi=uii/vii. If there are complex conjugate pairs of eigenvalues, then U has 2 by 2 diagonal blocks.
Eigenvalues and eigenvectors of a generalized nonsymmetric problem may be ill-conditioned; that is, sensitive to perturbations in A or B.
Particular care must be taken if, for some i, uii=vii=0, or in practical terms if uii and vii are both small; this means that the pencil is singular, or approximately so. Not only is the particular value λi undetermined, but also no reliance can be placed on any of the computed eigenvalues. See also the routine documents.
Computation of eigenvalues and eigenvectors proceeds in the following stages.
  1. The pencil A-λB is reduced by an orthogonal transformation to a pencil H-λK in which H is upper Hessenberg and K is upper triangular: A = Q1 H Z1T  and B = Q1 K Z1T . The pencil H-λK has the same eigenvalues as A-λB, and is easier to handle.
  2. The upper Hessenberg matrix H is reduced to upper quasi-triangular form, while K is maintained in upper triangular form, using the QZ algorithm. This gives the generalized Schur factorization: H=Q2UZ2 and K=Q2VZ2.
  3. Eigenvectors of the pencil U-λV are computed (if required) by back-substitution, and pre-multiplied by Z1Z2 to give eigenvectors of A.
All the above remarks also apply – with the obvious changes – to the case when A and B are complex matrices. The eigenvalues are in general complex, so there is no need for special treatment of complex conjugate pairs, and the matrix U in the generalized Schur factorization is simply a complex upper triangular matrix.
As for the generalized symmetric-definite eigenvalue problem, if A and B are large and sparse then it is generally preferable to use an alternative method. Chapter F12 provides routines based on Arnoldi's method for both real and complex matrices, intended to find a subset of the eigenvalues and vectors.

3  Recommendations on Choice and Use of Available Routines

3.1  Black Box Routines and General Purpose Routines

Routines in the NAG Library for solving eigenvalue problems fall into two categories.
  1. Black Box Routines: these are designed to solve a standard type of problem in a single call – for example, to compute all the eigenvalues and eigenvectors of a real symmetric matrix. You are recommended to use a black box routine if there is one to meet your needs; refer to the decision tree in Section 4.1 or the index in Section 5.
  2. General Purpose Routines: these perform the computational subtasks which make up the separate stages of the overall task, as described in Section 2 – for example, reducing a real symmetric matrix to tridiagonal form. General purpose routines are to be found, for historical reasons, some in this chapter, a few in Chapter F01, but most in Chapter F08. If there is no black box routine that meets your needs, you will need to use one or more general purpose routines.
The decision trees in Section 4.2 list the combinations of general purpose routines which are needed to solve many common types of problem.
Sometimes a combination of a black box routine and one or more general purpose routines will be the most convenient way to solve your problem: the black box routine can be used to compute most of the results, and a general purpose routine can be used to perform a subsidiary computation, such as computing condition numbers of eigenvalues and eigenvectors.

3.2  Computing Selected Eigenvalues and Eigenvectors

The decision trees and the routine documents make a distinction between routines which compute all eigenvalues or eigenvectors, and routines which compute selected eigenvalues or eigenvectors; the two classes of routine use different algorithms.
It is difficult to give clear guidance on which of these two classes of routine to use in a particular case, especially with regard to computing eigenvectors. If you only wish to compute a very few eigenvectors, then a routine for selected eigenvectors will be more economical, but if you want to compute a substantial subset (an old rule of thumb suggested more than 25%), then it may be more economical to compute all of them. Conversely, if you wish to compute all the eigenvectors of a sufficiently large symmetric tridiagonal matrix, the routine for selected eigenvectors may be faster.
The choice depends on the properties of the matrix and on the computing environment; if it is critical, you should perform your own timing tests.
For dense nonsymmetric eigenproblems, there are no algorithms provided for computing selected eigenvalues; it is always necessary to compute all the eigenvalues, but you can then select specific eigenvectors for computation by inverse iteration.

3.3  Storage Schemes for Symmetric Matrices

Routines which handle symmetric matrices are usually designed to use either the upper or lower triangle of the matrix; it is not necessary to store the whole matrix. If either the upper or lower triangle is stored conventionally in the upper or lower triangle of a two-dimensional array, the remaining elements of the array can be used to store other useful data. However, that is not always convenient, and if it is important to economize on storage, the upper or lower triangle can be stored in a one-dimensional array of length nn+1/2; in other words, the storage is almost halved. This storage format is referred to as packed storage.
Routines designed for packed storage are usually less efficient, especially on high-performance computers, so there is a trade-off between storage and efficiency.
A band matrix is one whose nonzero elements are confined to a relatively small number of subdiagonals or superdiagonals on either side of the main diagonal. Algorithms can take advantage of bandedness to reduce the amount of work and storage required.
Routines which take advantage of packed storage or bandedness are provided for both standard symmetric eigenproblems and generalized symmetric-definite eigenproblems.

3.4  Balancing for Nonsymmmetric Eigenproblems

There are two preprocessing steps which one may perform on a nonsymmetric matrix A in order to make its eigenproblem easier. Together they are referred to as balancing.
  1. Permutation: this involves reordering the rows and columns to make A more nearly upper triangular (and thus closer to Schur form): A=PAPT, where P is a permutation matrix. If A has a significant number of zero elements, this preliminary permutation can reduce the amount of work required, and also improve the accuracy of the computed eigenvalues. In the extreme case, if A is permutable to upper triangular form, then no floating point operations are needed to reduce it to Schur form.
  2. Scaling: a diagonal matrix D is used to make the rows and columns of A more nearly equal in norm: A=DAD-1. Scaling can make the matrix norm smaller with respect to the eigenvalues, and so possibly reduce the inaccuracy contributed by roundoff (see Chapter II/11 of Wilkinson and Reinsch (1971)).
Routines are provided in Chapter F08 for performing either or both of these preprocessing steps, and also for transforming computed eigenvectors or Schur vectors back to those of the original matrix.
The black box routines in this chapter which compute eigenvectors perform both forms of balancing.

3.5  Non-uniqueness of Eigenvectors and Singular Vectors

Eigenvectors, as defined by equations (1) or (4), are not uniquely defined. If x is an eigenvector, then so is kx where k is any nonzero scalar. Eigenvectors computed by different algorithms, or on different computers, may appear to disagree completely, though in fact they differ only by a scalar factor (which may be complex). These differences should not be significant in any application in which the eigenvectors will be used, but they can arouse uncertainty about the correctness of computed results.
Even if eigenvectors x are normalized so that x2=1, this is not sufficient to fix them uniquely, since they can still be multiplied by a scalar factor k such that k=1. To counteract this inconvenience, most of the routines in this chapter, and in Chapter F08, normalize eigenvectors (and Schur vectors) so that x2=1 and the component of x with largest absolute value is real and positive. (There is still a possible indeterminacy if there are two components of equal largest absolute value – or in practice if they are very close – but this is rare.)
In symmetric problems the computed eigenvalues are sorted into ascending order, but in nonsymmetric problems the order in which the computed eigenvalues are returned is dependent on the detailed working of the algorithm and may be sensitive to rounding errors. The Schur form and Schur vectors depend on the ordering of the eigenvalues and this is another possible cause of non-uniqueness when they are computed. However, it must be stressed again that variations in the results from this cause should not be significant. (Routines in Chapter F08 can be used to transform the Schur form and Schur vectors so that the eigenvalues appear in any given order if this is important.)
In singular value problems, the left and right singular vectors u and v which correspond to a singular value σ cannot be normalized independently: if u is multiplied by a factor k such that k=1, then v must also be multiplied by k.
Non-uniqueness also occurs among eigenvectors which correspond to a multiple eigenvalue, or among singular vectors which correspond to a multiple singular value. In practice, this is more likely to be apparent as the extreme sensitivity of eigenvectors which correspond to a cluster of close eigenvalues (or of singular vectors which correspond to a cluster of close singular values).

4  Decision Trees

4.1  Black Box Routines

The decision tree for this section is divided into three sub-trees.
Note: for the Chapter F08 routines there is generally a choice of simple and comprehensive routine. The comprehensive routines return additional information such as condition and/or error estimates.

Tree 1: Eigenvalues and Eigenvectors of Real Matrices

Is this a sparse eigenproblem Ax=λx or Ax=λBx? _
yes
Is the problem symmetric? _
yes
F02FJF
| no
|
| F02EKF
no
|
Is the eigenproblem Ax=λBx? _
yes
Are A and B symmetric with B positive definite and well-conditioned w.r.t inversion? _
yes
Are A and B band matrices? _
yes
F08UAF, F08UBF or F12FFF and F12AGF
| | no
|
| | F08SAF or F08SBF
| no
|
| Are A and B band matrices? _
yes
F12AFF and F12AGF
| no
|
| Is the generalized Schur factorization required? _
yes
F08XAF
| no
|
| F08WAF or F08WBF
no
|
The eigenproblem is Ax=λx. Is A symmetric? _
yes
Are all eigenvalues or all eigenvectors required? _
yes
F08FAF
| no
|
| F08FBF
no
|
Are eigenvalues only required? _
yes
F08NAF or F08NBF
no
|
Is the Schur factorization required? _
yes
F08PAF or F08PBF
no
|
Are all eigenvectors required? _
yes
F08NAF or F08NBF
no
|
F02ECF

Tree 2: Eigenvalues and Eigenvectors of Complex Matrices

Is this a sparse eigenproblem Ax=λx or Ax=λBx? _
yes
Are A and B banded matrices? _
yes
F12ATF and F12AUF
| no
|
| Chapter F12
no
|
Is the eigenproblem Ax=λBx? _
yes
Are A and B Hermitian with B positive definite and well-conditioned w.r.t. inversion? _
yes
F08UNF or F08UPF
| no
|
| Is the generalized Schur factorization required? _
yes
F08XNF
| no
|
| F08WNF
no
|
The eigenproblem is Ax=λx. Is A Hermitian? _
yes
Are all eigenvalues and eigenvectors required? _
yes
F08FNF or F08FPF
| no
|
| F08FPF
no
|
Are eigenvalues only required? _
yes
F08NNF or F08NPF
no
|
Is the Schur factorization required? _
yes
F08PNF or F08PPF
no
|
Are all eigenvectors required? _
yes
F08NNF or F08NPF
no
|
F02GCF

Tree 3: Singular Values and Singular Vectors

Is A a complex matrix? _
yes
Is A upper triangular? _
yes
F02XUF
| no
|
| F08KPF
no
|
Is A upper triangular? _
yes
F02WUF
no
|
Are only the leading terms required? _
yes
F02WGF
no
|
F08KBF

4.2  General Purpose Routines (Eigenvalues and Eigenvectors)

Routines for large sparse eigenvalue problems are to be found in Chapter F12, see the F12 Chapter Introduction.
The decision tree for this section addressing dense problems, is divided into eight sub-trees:
As it is very unlikely that one of the routines in this section will be called on its own, the other routines required to solve a given problem are listed in the order in which they should be called.

4.3  General Purpose Routines (Singular Value Decomposition)

See Section 4.2 in the F08 Chapter Introduction. For real sparse matrices where only selected singular values are required (possibly with their singular vectors), routines from Chapter F12 may be applied to the symmetric matrix ATA; see Section 9 in F12FBF.

5  Functionality Index

Black Box routines, 
    complex eigenproblem, 
        selected eigenvalues and eigenvectors F02GCF
    complex upper triangular matrix, 
        singular values and, optionally, left and/or right singular vectors F02XUF
    generalized real sparse symmetric-definite eigenproblem, 
        selected eigenvalues and eigenvectors F02FJF
    real eigenproblem, 
        selected eigenvalues and eigenvectors F02ECF
    real sparse eigenproblem 
        selected eigenvalues and eigenvectors F02EKF
    real sparse symmetric matrix, 
        selected eigenvalues and eigenvectors F02FJF
    real upper triangular matrix, 
        singular values and, optionally, left and/or right singular vectors F02WUF
General Purpose routines (see also Chapter F08), 
    real band matrix, selected eigenvector, A − λB F02SDF
    real m by n matrix (m ≥ n), QR factorization and SVD F02WDF
General Purpose routines (see also Chapter F12), 
    real m by n matrix, leading terms SVD F02WGF

6  Auxiliary Routines Associated with Library Routine Parameters

F02EKY
See the description of the argument OPTION in F02EKF.
F02EKZ
See the description of the argument MONIT in F02EKF.
F02FJZnagf_eigen_real_symm_sparse_eigsys_dummy_monit
See the description of the argument MONIT in F02FJF.

7  Routines Withdrawn or Scheduled for Withdrawal

The following lists all those routines that have been withdrawn since Mark 17 of the Library or are scheduled for withdrawal at one of the next two marks.
Withdrawn
Routine
Mark of
Withdrawal

Replacement Routine(s)
F02AAF18F08FAF (DSYEV)
F02ABF18F08FAF (DSYEV)
F02ADF18F08SAF (DSYGV)
F02AEF18F08SAF (DSYGV)
F02AFF18F08NAF (DGEEV)
F02AGF18F08NAF (DGEEV)
F02AJF18F08NNF (ZGEEV)
F02AKF18F08NNF (ZGEEV)
F02AMF18F08JEF (DSTEQR)
F02ANF18F08PSF (ZHSEQR)
F02APF18F08PEF (DHSEQR)
F02AQF18F08PEF (DHSEQR) and F08QKF (DTREVC)
F02ARF18F08PSF (ZHSEQR) and F08QXF (ZTREVC)
F02AVF18F08JFF (DSTERF)
F02AWF18F08FNF (ZHEEV)
F02AXF18F08FNF (ZHEEV)
F02AYF18F08JSF (ZSTEQR)
F02BBF19F08FBF (DSYEVX)
F02BCF19F02ECF
F02BDF19F02GCF
F02BEF18F08JJF (DSTEBZ) and F08JKF (DSTEIN)
F02BFF18F08JJF (DSTEBZ)
F02BJF23F08WAF (DGGEV)
F02BKF18F08PKF (DHSEIN)
F02BLF18F08PXF (ZHSEIN)
F02EAF23F08PAF (DGEES)
F02EBF23F08NAF (DGEEV)
F02FAF23F08FAF (DSYEV)
F02FCF23F08FBF (DSYEVX)
F02FDF23F08SAF (DSYGV)
F02FHF23F08UAF (DSBGV)
F02GAF23F08PNF (ZGEES)
F02GBF23F08NNF (ZGEEV)
F02GJF23F08WNF (ZGGEV)
F02HAF23F08FNF (ZHEEV)
F02HCF23F08FPF (ZHEEVX)
F02HDF23F08SNF (ZHEGV)
F02SWF18F08KEF (DGEBRD)
F02SXF18F08KFF (DORGBR) and F08KGF (DORMBR)
F02SYF18F08MEF (DBDSQR)
F02UWF18F08KSF (ZGEBRD), F06TFF, F08KTF (ZUNGBR) and F08KUF (ZUNMBR)
F02UXF18F08KTF (ZUNGBR) or F08KUF (ZUNMBR)
F02UYF18F08MSF (ZBDSQR)
F02WEF23F08KBF (DGESVD)
F02XEF23F08KPF (ZGESVD)

8  References

Anderson E, Bai Z, Bischof C, Blackford S, Demmel J, Dongarra J J, Du Croz J J, Greenbaum A, Hammarling S, McKenney A and Sorensen D (1999) LAPACK Users' Guide (3rd Edition) SIAM, Philadelphia
Golub G H and Van Loan C F (1996) Matrix Computations (3rd Edition) Johns Hopkins University Press, Baltimore
Parlett B N (1998) The Symmetric Eigenvalue Problem SIAM, Philadelphia
Wilkinson J H and Reinsch C (1971) Handbook for Automatic Computation II, Linear Algebra Springer–Verlag

F02 Chapter Contents
F02 Chapter Introduction (PDF version)
NAG Library Manual

© The Numerical Algorithms Group Ltd, Oxford, UK. 2012