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