Important changes to repositories hosted on mbed.com
Mbed hosted mercurial repositories are deprecated and are due to be permanently deleted in July 2026.
To keep a copy of this software download the repository Zip archive or clone locally using Mercurial.
It is also possible to export all your personal repositories from the account settings page.
Dependents: Eigen_test Odometry_test AttitudeEstimation_usingTicker MPU9250_Quaternion_Binary_Serial ... more
SelfAdjointEigenSolver< _MatrixType > Class Template Reference
[Eigenvalues module]
#include <SelfAdjointEigenSolver.h>
Inherited by GeneralizedSelfAdjointEigenSolver< _MatrixType >.
Public Types | |
typedef MatrixType::Scalar | Scalar |
Scalar type for matrices of type _MatrixType . | |
typedef NumTraits< Scalar >::Real | RealScalar |
Real scalar type for _MatrixType . | |
typedef internal::plain_col_type < MatrixType, RealScalar > ::type | RealVectorType |
Type for vector of eigenvalues as returned by eigenvalues(). | |
Public Member Functions | |
SelfAdjointEigenSolver () | |
Default constructor for fixed-size matrices. | |
SelfAdjointEigenSolver (Index size) | |
Constructor, pre-allocates memory for dynamic-size matrices. | |
SelfAdjointEigenSolver (const MatrixType &matrix, int options=ComputeEigenvectors) | |
Constructor; computes eigendecomposition of given matrix. | |
SelfAdjointEigenSolver & | compute (const MatrixType &matrix, int options=ComputeEigenvectors) |
Computes eigendecomposition of given matrix. | |
SelfAdjointEigenSolver & | computeDirect (const MatrixType &matrix, int options=ComputeEigenvectors) |
Computes eigendecomposition of given matrix using a direct algorithm. | |
const EigenvectorsType & | eigenvectors () const |
Returns the eigenvectors of given matrix. | |
const RealVectorType & | eigenvalues () const |
Returns the eigenvalues of given matrix. | |
MatrixType | operatorSqrt () const |
Computes the positive-definite square root of the matrix. | |
MatrixType | operatorInverseSqrt () const |
Computes the inverse square root of the matrix. | |
ComputationInfo | info () const |
Reports whether previous computation was successful. | |
Static Public Attributes | |
static const int | m_maxIterations = 30 |
Maximum number of iterations. |
Detailed Description
template<typename _MatrixType>
class Eigen::SelfAdjointEigenSolver< _MatrixType >
Computes eigenvalues and eigenvectors of selfadjoint matrices
- Template Parameters:
-
_MatrixType the type of the matrix of which we are computing the eigendecomposition; this is expected to be an instantiation of the Matrix class template.
A matrix is selfadjoint if it equals its adjoint. For real matrices, this means that the matrix is symmetric: it equals its transpose. This class computes the eigenvalues and eigenvectors of a selfadjoint matrix. These are the scalars
and vectors
such that
. The eigenvalues of a selfadjoint matrix are always real. If
is a diagonal matrix with the eigenvalues on the diagonal, and
is a matrix with the eigenvectors as its columns, then
(for selfadjoint matrices, the matrix
is always invertible). This is called the eigendecomposition.
The algorithm exploits the fact that the matrix is selfadjoint, making it faster and more accurate than the general purpose eigenvalue algorithms implemented in EigenSolver and ComplexEigenSolver.
Only the lower triangular part of the input matrix is referenced.
Call the function compute() to compute the eigenvalues and eigenvectors of a given matrix. Alternatively, you can use the SelfAdjointEigenSolver(const MatrixType&, int) constructor which computes the eigenvalues and eigenvectors at construction time. Once the eigenvalue and eigenvectors are computed, they can be retrieved with the eigenvalues() and eigenvectors() functions.
The documentation for SelfAdjointEigenSolver(const MatrixType&, int) contains an example of the typical use of this class.
To solve the generalized eigenvalue problem and the likes, see the class GeneralizedSelfAdjointEigenSolver.
- See also:
- MatrixBase::eigenvalues(), class EigenSolver, class ComplexEigenSolver
Definition at line 68 of file SelfAdjointEigenSolver.h.
Member Typedef Documentation
typedef NumTraits<Scalar>::Real RealScalar |
Real scalar type for _MatrixType
.
This is just Scalar
if Scalar is real (e.g., float
or double
), and the type of the real part of Scalar
if Scalar is complex.
Definition at line 92 of file SelfAdjointEigenSolver.h.
typedef internal::plain_col_type<MatrixType, RealScalar>::type RealVectorType |
Type for vector of eigenvalues as returned by eigenvalues().
This is a column vector with entries of type RealScalar. The length of the vector is the size of _MatrixType
.
Definition at line 101 of file SelfAdjointEigenSolver.h.
typedef MatrixType::Scalar Scalar |
Scalar type for matrices of type _MatrixType
.
Definition at line 81 of file SelfAdjointEigenSolver.h.
Constructor & Destructor Documentation
Default constructor for fixed-size matrices.
The default constructor is useful in cases in which the user intends to perform decompositions via compute(). This constructor can only be used if _MatrixType
is a fixed-size matrix; use SelfAdjointEigenSolver(Index) for dynamic-size matrices.
Example:
Output:
Definition at line 114 of file SelfAdjointEigenSolver.h.
SelfAdjointEigenSolver | ( | Index | size ) |
Constructor, pre-allocates memory for dynamic-size matrices.
- Parameters:
-
[in] size Positive integer, size of the matrix whose eigenvalues and eigenvectors will be computed.
This constructor is useful for dynamic-size matrices, when the user intends to perform decompositions via compute(). The size
parameter is only used as a hint. It is not an error to give a wrong size
, but it may impair performance.
- See also:
- compute() for an example
Definition at line 133 of file SelfAdjointEigenSolver.h.
SelfAdjointEigenSolver | ( | const MatrixType & | matrix, |
int | options = ComputeEigenvectors |
||
) |
Constructor; computes eigendecomposition of given matrix.
- Parameters:
-
[in] matrix Selfadjoint matrix whose eigendecomposition is to be computed. Only the lower triangular part of the matrix is referenced. [in] options Can be ComputeEigenvectors (default) or EigenvaluesOnly.
This constructor calls compute(const MatrixType&, int) to compute the eigenvalues of the matrix matrix
. The eigenvectors are computed if options
equals ComputeEigenvectors.
Example:
Output:
- See also:
- compute(const MatrixType&, int)
Definition at line 155 of file SelfAdjointEigenSolver.h.
Member Function Documentation
SelfAdjointEigenSolver< MatrixType > & compute | ( | const MatrixType & | matrix, |
int | options = ComputeEigenvectors |
||
) |
Computes eigendecomposition of given matrix.
- Parameters:
-
[in] matrix Selfadjoint matrix whose eigendecomposition is to be computed. Only the lower triangular part of the matrix is referenced. [in] options Can be ComputeEigenvectors (default) or EigenvaluesOnly.
- Returns:
- Reference to
*this
This function computes the eigenvalues of matrix
. The eigenvalues() function can be used to retrieve them. If options
equals ComputeEigenvectors, then the eigenvectors are also computed and can be retrieved by calling eigenvectors().
This implementation uses a symmetric QR algorithm. The matrix is first reduced to tridiagonal form using the Tridiagonalization class. The tridiagonal matrix is then brought to diagonal form with implicit symmetric QR steps with Wilkinson shift. Details can be found in Section 8.3 of Golub & Van Loan, Matrix Computations.
The cost of the computation is about if the eigenvectors are required and
if they are not required.
This method reuses the memory in the SelfAdjointEigenSolver object that was allocated when the object was constructed, if the size of the matrix does not change.
Example:
Output:
Definition at line 392 of file SelfAdjointEigenSolver.h.
SelfAdjointEigenSolver< MatrixType > & computeDirect | ( | const MatrixType & | matrix, |
int | options = ComputeEigenvectors |
||
) |
Computes eigendecomposition of given matrix using a direct algorithm.
This is a variant of compute(const MatrixType&, int options) which directly solves the underlying polynomial equation.
Currently only 3x3 matrices for which the sizes are known at compile time are supported (e.g., Matrix3d).
This method is usually significantly faster than the QR algorithm but it might also be less accurate. It is also worth noting that for 3x3 matrices it involves trigonometric operations which are not necessarily available for all scalar types.
Definition at line 732 of file SelfAdjointEigenSolver.h.
const RealVectorType& eigenvalues | ( | ) | const |
Returns the eigenvalues of given matrix.
- Returns:
- A const reference to the column vector containing the eigenvalues.
- Precondition:
- The eigenvalues have been computed before.
The eigenvalues are repeated according to their algebraic multiplicity, so there are as many eigenvalues as rows in the matrix. The eigenvalues are sorted in increasing order.
Example:
Output:
- See also:
- eigenvectors(), MatrixBase::eigenvalues()
Definition at line 252 of file SelfAdjointEigenSolver.h.
const EigenvectorsType& eigenvectors | ( | ) | const |
Returns the eigenvectors of given matrix.
- Returns:
- A const reference to the matrix whose columns are the eigenvectors.
- Precondition:
- The eigenvectors have been computed before.
Column of the returned matrix is an eigenvector corresponding to eigenvalue number
as returned by eigenvalues(). The eigenvectors are normalized to have (Euclidean) norm equal to one. If this object was used to solve the eigenproblem for the selfadjoint matrix
, then the matrix returned by this function is the matrix
in the eigendecomposition
.
Example:
Output:
- See also:
- eigenvalues()
Definition at line 230 of file SelfAdjointEigenSolver.h.
ComputationInfo info | ( | ) | const |
Reports whether previous computation was successful.
- Returns:
Success
if computation was succesful,NoConvergence
otherwise.
Definition at line 312 of file SelfAdjointEigenSolver.h.
MatrixType operatorInverseSqrt | ( | ) | const |
Computes the inverse square root of the matrix.
- Returns:
- the inverse positive-definite square root of the matrix
- Precondition:
- The eigenvalues and eigenvectors of a positive-definite matrix have been computed before.
This function uses the eigendecomposition to compute the inverse square root as
. This is cheaper than first computing the square root with operatorSqrt() and then its inverse with MatrixBase::inverse().
Example:
Output:
- See also:
- operatorSqrt(), MatrixBase::inverse(), MatrixFunctions Module
Definition at line 301 of file SelfAdjointEigenSolver.h.
MatrixType operatorSqrt | ( | ) | const |
Computes the positive-definite square root of the matrix.
- Returns:
- the positive-definite square root of the matrix
- Precondition:
- The eigenvalues and eigenvectors of a positive-definite matrix have been computed before.
The square root of a positive-definite matrix is the positive-definite matrix whose square equals
. This function uses the eigendecomposition
to compute the square root as
.
Example:
Output:
- See also:
- operatorInverseSqrt(), MatrixFunctions Module
Definition at line 276 of file SelfAdjointEigenSolver.h.
Field Documentation
const int m_maxIterations = 30 [static] |
Maximum number of iterations.
The algorithm terminates if it does not converge within m_maxIterations * n iterations, where n denotes the size of the matrix. This value is currently set to 30 (copied from LAPACK).
Definition at line 323 of file SelfAdjointEigenSolver.h.
Generated on Tue Jul 12 2022 17:47:05 by
