Classes
-
namespace Eigen Namespace containing all symbols from the Eigen library.
- namespace indexing
-
namespace symbolic
- class BaseExpr
- class SymbolExpr
- class SymbolValue
- class aligned_allocator STL compatible allocator to use with types requiring a non standrad alignment.
- class AlignedBox An axis aligned box.
- class AMDOrdering
- class AngleAxis Represents a 3D rotation as a rotation angle around an arbitrary 3D axis.
- class ArithmeticSequence
- class Array General-purpose arrays with easy API for coefficient-wise operations.
- class ArrayBase Base class for all 1D and 2D array, and related expressions.
- class ArrayWrapper Expression of a mathematical vector or matrix as an array object.
- struct ArrayXpr
- class BDCSVD class Bidiagonal Divide and Conquer SVD
- class BiCGSTAB A bi conjugate gradient stabilized solver for sparse square problems.
- class Block Expression of a fixed-size or dynamic-size block.
- class BlockImpl<XprType, BlockRows, BlockCols, InnerPanel, Sparse>
- class CholmodBase The base class for the direct Cholesky factorization of Cholmod.
- class CholmodDecomposition A general Cholesky factorization and solver based on Cholmod.
- class CholmodSimplicialLDLT A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod.
- class CholmodSimplicialLLT A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod.
- class CholmodSupernodalLLT A supernodal Cholesky (LLT) factorization and solver based on Cholmod.
- class COLAMDOrdering
- class ColPivHouseholderQR Householder rank-revealing QR decomposition of a matrix with column-pivoting.
- class CommaInitializer Helper class used by the comma initializer operator.
- class CompleteOrthogonalDecomposition Complete orthogonal decomposition (COD) of a matrix.
- class ComplexEigenSolver Computes eigenvalues and eigenvectors of general complex matrices.
- class ComplexSchur Performs a complex Schur decomposition of a real or complex square matrix.
- class ConjugateGradient A conjugate gradient solver for sparse (or dense) self-adjoint problems.
- class CwiseBinaryOp Generic expression where a coefficient-wise binary operator is applied to two expressions.
- class CwiseNullaryOp Generic expression of a matrix where all coefficients are defined by a functor.
- class CwiseTernaryOp Generic expression where a coefficient-wise ternary operator is applied to two expressions.
- class CwiseUnaryOp Generic expression where a coefficient-wise unary operator is applied to an expression.
- class CwiseUnaryView Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector.
- struct Dense
- class DenseBase Base class for all dense matrices, vectors, and arrays.
- class DenseCoeffsBase<Derived, DirectAccessors> Base class providing direct read-only coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, DirectWriteAccessors> Base class providing direct read/write coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, ReadOnlyAccessors> Base class providing read-only coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, WriteAccessors> Base class providing read/write coefficient access to matrices and arrays.
- class Diagonal Expression of a diagonal/subdiagonal/superdiagonal in a matrix.
- class DiagonalMatrix Represents a diagonal matrix with its storage.
- class DiagonalPreconditioner A preconditioner based on the digonal entries.
- class DiagonalWrapper Expression of a diagonal matrix.
- class EigenBase
- class EigenSolver Computes eigenvalues and eigenvectors of general matrices.
- class ForceAlignedAccess Enforce aligned packet loads and stores regardless of what is requested.
- class FullPivHouseholderQR Householder rank-revealing QR decomposition of a matrix with full pivoting.
- class FullPivLU LU decomposition of a matrix with complete pivoting, and related features.
- class GeneralizedEigenSolver Computes the generalized eigenvalues and eigenvectors of a pair of general matrices.
- class GeneralizedSelfAdjointEigenSolver Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem.
- class HessenbergDecomposition Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation.
- class Homogeneous Expression of one (or a set of) homogeneous vector(s)
- class HouseholderQR Householder QR decomposition of a matrix.
- class HouseholderSequence Sequence of Householder reflections acting on subspaces with decreasing size.
- class Hyperplane A hyperplane.
- class IdentityPreconditioner A naive preconditioner which approximates any matrix as the identity matrix.
- class IncompleteCholesky Modified Incomplete Cholesky with dual threshold.
-
class IncompleteLUT Incomplete LU factorization with dual-threshold strategy.
- struct keep_diag
- class IndexedView Expression of a non-sequential sub-matrix defined by arbitrary sequences of row and column indices.
- class InnerStride Convenience specialization of Stride to specify only an inner stride See class Map for some examples.
- class Inverse Expression of the inverse of another expression.
- class IOFormat Stores a set of parameters controlling the way matrices are printed.
- class IterativeSolverBase Base class for linear iterative solvers.
- class JacobiRotation Rotation given by a cosine-sine pair.
- class JacobiSVD Two-sided Jacobi SVD decomposition of a rectangular matrix.
- class LDLT Robust Cholesky decomposition of a matrix with pivoting.
- class LeastSquareDiagonalPreconditioner Jacobi preconditioner for LeastSquaresConjugateGradient.
- class LeastSquaresConjugateGradient A conjugate gradient solver for sparse (or dense) least-square problems.
- class LLT Standard Cholesky decomposition (LL^T) of a matrix and associated features.
- class Map A matrix or vector expression mapping an existing array of data.
- class Map<const Quaternion<_Scalar>, _Options> Quaternion expression mapping a constant memory buffer.
- class Map<Quaternion<_Scalar>, _Options> Expression of a quaternion from a memory buffer.
- class Map<SparseMatrixType> Specialization of class Map for SparseMatrix-like storage.
- class MapBase<Derived, ReadOnlyAccessors> Base class for dense Map and Block expression with direct access.
- class MapBase<Derived, WriteAccessors> Base class for non-const dense Map and Block expression with direct access.
- class MappedSparseMatrix deprecated Sparse matrix.
- class Matrix The matrix class, also used for vectors and row-vectors.
- class MatrixBase Base class for all dense matrices, vectors, and expressions.
- class MatrixWrapper Expression of an array as a mathematical vector or matrix.
- struct MatrixXpr
- class MetisOrdering
- class NaturalOrdering
- class NestByValue Expression which must be nested by value.
- class NoAlias Pseudo expression providing an operator = assuming no aliasing.
- class NumTraits Holds information about the various numeric (i.e. scalar) types allowed by Eigen.
- class OuterStride Convenience specialization of Stride to specify only an outer stride See class Map for some examples.
- class ParametrizedLine A parametrized line.
- class PardisoLDLT A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library.
- class PardisoLLT A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library.
- class PardisoLU A sparse direct LU factorization and solver based on the PARDISO library.
- class PartialPivLU LU decomposition of a matrix with partial pivoting, and related features.
- class PartialReduxExpr Generic expression of a partially reduxed matrix.
- class PastixLDLT A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library.
- class PastixLLT A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library.
- class PastixLU Interface to the PaStix solver.
- class PermutationBase Base class for permutations.
- class PermutationMatrix Permutation matrix.
- struct PermutationStorage
- class PermutationWrapper Class to view a vector of integers as a permutation matrix.
- class PlainObjectBase Dense storage base class for matrices and arrays.
- class Product Expression of the product of two arbitrary matrices or vectors.
- class Quaternion The quaternion class used to represent 3D orientations and rotations.
- class QuaternionBase Base class for quaternion expressions.
- class RealQZ Performs a real QZ decomposition of a pair of square matrices.
- class RealSchur Performs a real Schur decomposition of a square matrix.
- class Ref A matrix or vector expression mapping an existing expression.
- class Ref<SparseMatrixType, Options> A sparse matrix expression referencing an existing sparse expression.
- class Ref<SparseVectorType> A sparse vector expression referencing an existing sparse vector expression.
- class Replicate Expression of the multiple replication of a matrix or vector.
- class Reshaped Expression of a fixed-size or dynamic-size reshape.
- class Reverse Expression of the reverse of a vector or matrix.
- class Rotation2D Represents a rotation/orientation in a 2 dimensional space.
- class RotationBase Common base class for compact rotation representations.
- class ScalarBinaryOpTraits Determines whether the given binary operation of two numeric types is allowed and what the scalar return type is.
- class Select Expression of a coefficient wise version of the C++ ternary operator ?:
- class SelfAdjointEigenSolver Computes eigenvalues and eigenvectors of selfadjoint matrices.
- class SelfAdjointView Expression of a selfadjoint matrix from a triangular part of a dense matrix.
- class SimplicialCholesky deprecated
-
class SimplicialCholeskyBase A base class for direct sparse Cholesky factorizations.
- struct keep_diag
- class SimplicialLDLT A direct sparse LDLT Cholesky factorizations without square root.
- class SimplicialLLT A direct sparse LLT Cholesky factorizations.
- class Solve Pseudo expression representing a solving operation.
- class SolverBase A base class for matrix decomposition and solvers.
- struct SolverStorage
- class SolveWithGuess Pseudo expression representing a solving operation.
- struct Sparse
- class SparseCompressedBase Common base class for sparse [compressed]-{row|column}-storage format.
- class SparseLU Sparse supernodal LU factorization for general matrices.
- class SparseMapBase<Derived, ReadOnlyAccessors> Common base class for Map and Ref instance of sparse matrix and vector.
- class SparseMapBase<Derived, WriteAccessors> Common base class for writable Map and Ref instance of sparse matrix and vector.
- class SparseMatrix A versatible sparse matrix representation.
- class SparseMatrixBase Base class of any sparse matrices or sparse expressions.
- class SparseQR Sparse left-looking rank-revealing QR factorization.
- class SparseSelfAdjointView Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix.
- class SparseSolverBase A base class for sparse solvers.
- class SparseVector a sparse vector class
- class SparseView Expression of a dense or sparse matrix with zero or too small values removed.
- class SPQR Sparse QR factorization based on SuiteSparseQR library.
- class Stride Holds strides information for Map.
- class SuperILU A sparse direct incomplete LU factorization and solver based on the SuperLU library.
- class SuperLU A sparse direct LU factorization and solver based on the SuperLU library.
- class SuperLUBase The base class for the direct and incomplete LU factorization of SuperLU.
- class SVDBase Base class of SVD algorithms.
- class Transform Represents an homogeneous transformation in a N dimensional space.
- class Translation Represents a translation transformation.
- class Transpose Expression of the transpose of a matrix.
- class Transpositions Represents a sequence of transpositions (row/column interchange)
- struct TranspositionsStorage
- class TriangularBase Base class for triangular part in a matrix.
- class TriangularView Expression of a triangular part in a matrix.
- class TriangularViewImpl<_MatrixType, _Mode, Dense> Base class for a triangular part in a dense matrix.
- class TriangularViewImpl<MatrixType, Mode, Sparse> Base class for a triangular part in a sparse matrix.
- class Tridiagonalization Tridiagonal decomposition of a selfadjoint matrix.
- class Triplet A small structure to hold a non zero as a triplet (i,j,value).
- class UmfPackLU A sparse LU factorization and solver based on UmfPack.
- class VectorBlock Expression of a fixed-size or dynamic-size sub-vector.
- class VectorwiseOp Pseudo expression providing broadcasting and partial reduction operations.
- class WithFormat Pseudo expression providing matrix output with given format.
- class Scaling Represents a generic uniform scaling transformation.
- namespace indexing
-
namespace symbolic
- class BaseExpr
- class SymbolExpr
- class SymbolValue
- class aligned_allocator STL compatible allocator to use with types requiring a non standrad alignment.
- class AlignedBox An axis aligned box.
- class AMDOrdering
- class AngleAxis Represents a 3D rotation as a rotation angle around an arbitrary 3D axis.
- class ArithmeticSequence
- class Array General-purpose arrays with easy API for coefficient-wise operations.
- class ArrayBase Base class for all 1D and 2D array, and related expressions.
- class ArrayWrapper Expression of a mathematical vector or matrix as an array object.
- struct ArrayXpr
- class BDCSVD class Bidiagonal Divide and Conquer SVD
- class BiCGSTAB A bi conjugate gradient stabilized solver for sparse square problems.
- class Block Expression of a fixed-size or dynamic-size block.
- class BlockImpl<XprType, BlockRows, BlockCols, InnerPanel, Sparse>
- class CholmodBase The base class for the direct Cholesky factorization of Cholmod.
- class CholmodDecomposition A general Cholesky factorization and solver based on Cholmod.
- class CholmodSimplicialLDLT A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod.
- class CholmodSimplicialLLT A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod.
- class CholmodSupernodalLLT A supernodal Cholesky (LLT) factorization and solver based on Cholmod.
- class COLAMDOrdering
- class ColPivHouseholderQR Householder rank-revealing QR decomposition of a matrix with column-pivoting.
- class CommaInitializer Helper class used by the comma initializer operator.
- class CompleteOrthogonalDecomposition Complete orthogonal decomposition (COD) of a matrix.
- class ComplexEigenSolver Computes eigenvalues and eigenvectors of general complex matrices.
- class ComplexSchur Performs a complex Schur decomposition of a real or complex square matrix.
- class ConjugateGradient A conjugate gradient solver for sparse (or dense) self-adjoint problems.
- class CwiseBinaryOp Generic expression where a coefficient-wise binary operator is applied to two expressions.
- class CwiseNullaryOp Generic expression of a matrix where all coefficients are defined by a functor.
- class CwiseTernaryOp Generic expression where a coefficient-wise ternary operator is applied to two expressions.
- class CwiseUnaryOp Generic expression where a coefficient-wise unary operator is applied to an expression.
- class CwiseUnaryView Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector.
- struct Dense
- class DenseBase Base class for all dense matrices, vectors, and arrays.
- class DenseCoeffsBase<Derived, DirectAccessors> Base class providing direct read-only coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, DirectWriteAccessors> Base class providing direct read/write coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, ReadOnlyAccessors> Base class providing read-only coefficient access to matrices and arrays.
- class DenseCoeffsBase<Derived, WriteAccessors> Base class providing read/write coefficient access to matrices and arrays.
- class Diagonal Expression of a diagonal/subdiagonal/superdiagonal in a matrix.
- class DiagonalMatrix Represents a diagonal matrix with its storage.
- class DiagonalPreconditioner A preconditioner based on the digonal entries.
- class DiagonalWrapper Expression of a diagonal matrix.
- class EigenBase
- class EigenSolver Computes eigenvalues and eigenvectors of general matrices.
- class ForceAlignedAccess Enforce aligned packet loads and stores regardless of what is requested.
- class FullPivHouseholderQR Householder rank-revealing QR decomposition of a matrix with full pivoting.
- class FullPivLU LU decomposition of a matrix with complete pivoting, and related features.
- class GeneralizedEigenSolver Computes the generalized eigenvalues and eigenvectors of a pair of general matrices.
- class GeneralizedSelfAdjointEigenSolver Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem.
- class HessenbergDecomposition Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation.
- class Homogeneous Expression of one (or a set of) homogeneous vector(s)
- class HouseholderQR Householder QR decomposition of a matrix.
- class HouseholderSequence Sequence of Householder reflections acting on subspaces with decreasing size.
- class Hyperplane A hyperplane.
- class IdentityPreconditioner A naive preconditioner which approximates any matrix as the identity matrix.
- class IncompleteCholesky Modified Incomplete Cholesky with dual threshold.
-
class IncompleteLUT Incomplete LU factorization with dual-threshold strategy.
- struct keep_diag
- class IndexedView Expression of a non-sequential sub-matrix defined by arbitrary sequences of row and column indices.
- class InnerStride Convenience specialization of Stride to specify only an inner stride See class Map for some examples.
- class Inverse Expression of the inverse of another expression.
- class IOFormat Stores a set of parameters controlling the way matrices are printed.
- class IterativeSolverBase Base class for linear iterative solvers.
- class JacobiRotation Rotation given by a cosine-sine pair.
- class JacobiSVD Two-sided Jacobi SVD decomposition of a rectangular matrix.
- class LDLT Robust Cholesky decomposition of a matrix with pivoting.
- class LeastSquareDiagonalPreconditioner Jacobi preconditioner for LeastSquaresConjugateGradient.
- class LeastSquaresConjugateGradient A conjugate gradient solver for sparse (or dense) least-square problems.
- class LLT Standard Cholesky decomposition (LL^T) of a matrix and associated features.
- class Map A matrix or vector expression mapping an existing array of data.
- class Map<const Quaternion<_Scalar>, _Options> Quaternion expression mapping a constant memory buffer.
- class Map<Quaternion<_Scalar>, _Options> Expression of a quaternion from a memory buffer.
- class Map<SparseMatrixType> Specialization of class Map for SparseMatrix-like storage.
- class MapBase<Derived, ReadOnlyAccessors> Base class for dense Map and Block expression with direct access.
- class MapBase<Derived, WriteAccessors> Base class for non-const dense Map and Block expression with direct access.
- class MappedSparseMatrix deprecated Sparse matrix.
- class Matrix The matrix class, also used for vectors and row-vectors.
- class MatrixBase Base class for all dense matrices, vectors, and expressions.
- class MatrixWrapper Expression of an array as a mathematical vector or matrix.
- struct MatrixXpr
- class MetisOrdering
- class NaturalOrdering
- class NestByValue Expression which must be nested by value.
- class NoAlias Pseudo expression providing an operator = assuming no aliasing.
- class NumTraits Holds information about the various numeric (i.e. scalar) types allowed by Eigen.
- class OuterStride Convenience specialization of Stride to specify only an outer stride See class Map for some examples.
- class ParametrizedLine A parametrized line.
- class PardisoLDLT A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library.
- class PardisoLLT A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library.
- class PardisoLU A sparse direct LU factorization and solver based on the PARDISO library.
- class PartialPivLU LU decomposition of a matrix with partial pivoting, and related features.
- class PartialReduxExpr Generic expression of a partially reduxed matrix.
- class PastixLDLT A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library.
- class PastixLLT A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library.
- class PastixLU Interface to the PaStix solver.
- class PermutationBase Base class for permutations.
- class PermutationMatrix Permutation matrix.
- struct PermutationStorage
- class PermutationWrapper Class to view a vector of integers as a permutation matrix.
- class PlainObjectBase Dense storage base class for matrices and arrays.
- class Product Expression of the product of two arbitrary matrices or vectors.
- class Quaternion The quaternion class used to represent 3D orientations and rotations.
- class QuaternionBase Base class for quaternion expressions.
- class RealQZ Performs a real QZ decomposition of a pair of square matrices.
- class RealSchur Performs a real Schur decomposition of a square matrix.
- class Ref A matrix or vector expression mapping an existing expression.
- class Ref<SparseMatrixType, Options> A sparse matrix expression referencing an existing sparse expression.
- class Ref<SparseVectorType> A sparse vector expression referencing an existing sparse vector expression.
- class Replicate Expression of the multiple replication of a matrix or vector.
- class Reshaped Expression of a fixed-size or dynamic-size reshape.
- class Reverse Expression of the reverse of a vector or matrix.
- class Rotation2D Represents a rotation/orientation in a 2 dimensional space.
- class RotationBase Common base class for compact rotation representations.
- class ScalarBinaryOpTraits Determines whether the given binary operation of two numeric types is allowed and what the scalar return type is.
- class Select Expression of a coefficient wise version of the C++ ternary operator ?:
- class SelfAdjointEigenSolver Computes eigenvalues and eigenvectors of selfadjoint matrices.
- class SelfAdjointView Expression of a selfadjoint matrix from a triangular part of a dense matrix.
- class SimplicialCholesky deprecated
-
class SimplicialCholeskyBase A base class for direct sparse Cholesky factorizations.
- struct keep_diag
- class SimplicialLDLT A direct sparse LDLT Cholesky factorizations without square root.
- class SimplicialLLT A direct sparse LLT Cholesky factorizations.
- class Solve Pseudo expression representing a solving operation.
- class SolverBase A base class for matrix decomposition and solvers.
- struct SolverStorage
- class SolveWithGuess Pseudo expression representing a solving operation.
- struct Sparse
- class SparseCompressedBase Common base class for sparse [compressed]-{row|column}-storage format.
- class SparseLU Sparse supernodal LU factorization for general matrices.
- class SparseMapBase<Derived, ReadOnlyAccessors> Common base class for Map and Ref instance of sparse matrix and vector.
- class SparseMapBase<Derived, WriteAccessors> Common base class for writable Map and Ref instance of sparse matrix and vector.
- class SparseMatrix A versatible sparse matrix representation.
- class SparseMatrixBase Base class of any sparse matrices or sparse expressions.
- class SparseQR Sparse left-looking rank-revealing QR factorization.
- class SparseSelfAdjointView Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix.
- class SparseSolverBase A base class for sparse solvers.
- class SparseVector a sparse vector class
- class SparseView Expression of a dense or sparse matrix with zero or too small values removed.
- class SPQR Sparse QR factorization based on SuiteSparseQR library.
- class Stride Holds strides information for Map.
- class SuperILU A sparse direct incomplete LU factorization and solver based on the SuperLU library.
- class SuperLU A sparse direct LU factorization and solver based on the SuperLU library.
- class SuperLUBase The base class for the direct and incomplete LU factorization of SuperLU.
- class SVDBase Base class of SVD algorithms.
- class Transform Represents an homogeneous transformation in a N dimensional space.
- class Translation Represents a translation transformation.
- class Transpose Expression of the transpose of a matrix.
- class Transpositions Represents a sequence of transpositions (row/column interchange)
- struct TranspositionsStorage
- class TriangularBase Base class for triangular part in a matrix.
- class TriangularView Expression of a triangular part in a matrix.
- class TriangularViewImpl<_MatrixType, _Mode, Dense> Base class for a triangular part in a dense matrix.
- class TriangularViewImpl<MatrixType, Mode, Sparse> Base class for a triangular part in a sparse matrix.
- class Tridiagonalization Tridiagonal decomposition of a selfadjoint matrix.
- class Triplet A small structure to hold a non zero as a triplet (i,j,value).
- class UmfPackLU A sparse LU factorization and solver based on UmfPack.
- class VectorBlock Expression of a fixed-size or dynamic-size sub-vector.
- class VectorwiseOp Pseudo expression providing broadcasting and partial reduction operations.
- class WithFormat Pseudo expression providing matrix output with given format.