 aligned_allocator< T > | STL compatible allocator to use with with 16 byte aligned types |
 AlignedBox< _Scalar, _AmbientDim > | An axis aligned box |
 ArrayXpr | |
 Block< XprType, BlockRows, BlockCols, InnerPanel, HasDirectAccess > | Expression of a fixed-size or dynamic-size block |
 Block< VectorType, internal::traits< VectorType >::Flags &RowMajorBit?1:Size, internal::traits< VectorType >::Flags &RowMajorBit?Size:1 > | |
  VectorBlock< MatrixType, Size > | Expression of a fixed-size or dynamic-size sub-vector |
 CholmodBase< _MatrixType, _UpLo, Derived > | The base class for the direct Cholesky factorization of Cholmod |
 CholmodBase< _MatrixType, _UpLo, CholmodDecomposition< _MatrixType, _UpLo > > | |
  CholmodDecomposition< _MatrixType, _UpLo > | A general Cholesky factorization and solver based on Cholmod |
 CholmodBase< _MatrixType, _UpLo, CholmodSimplicialLDLT< _MatrixType, _UpLo > > | |
  CholmodSimplicialLDLT< _MatrixType, _UpLo > | A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod |
 CholmodBase< _MatrixType, _UpLo, CholmodSimplicialLLT< _MatrixType, _UpLo > > | |
  CholmodSimplicialLLT< _MatrixType, _UpLo > | A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod |
 CholmodBase< _MatrixType, _UpLo, CholmodSupernodalLLT< _MatrixType, _UpLo > > | |
  CholmodSupernodalLLT< _MatrixType, _UpLo > | A supernodal Cholesky (LLT) factorization and solver based on Cholmod |
 ColPivHouseholderQR< MatrixType > | Householder rank-revealing QR decomposition of a matrix with column-pivoting |
 CommaInitializer< XprType > | Helper class used by the comma initializer operator |
 ComplexEigenSolver< _MatrixType > | Computes eigenvalues and eigenvectors of general complex matrices |
 ComplexSchur< _MatrixType > | Performs a complex Schur decomposition of a real or complex square matrix |
 ComplexSchur< MatrixType > | |
 CwiseBinaryOp< BinaryOp, Lhs, Rhs > | Generic expression where a coefficient-wise binary operator is applied to two expressions |
 CwiseNullaryOp< NullaryOp, PlainObjectType > | Generic expression of a matrix where all coefficients are defined by a functor |
 CwiseUnaryOp< UnaryOp, XprType > | Generic expression where a coefficient-wise unary operator is applied to an expression |
 CwiseUnaryView< ViewOp, MatrixType > | Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector |
 Dense | |
 DenseBase< Derived > | Base class for all dense matrices, vectors, and arrays |
  ArrayBase< Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
   dense_xpr_base_dispatcher_for_doxygen< Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
    PlainObjectBase< Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
     Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > | General-purpose arrays with easy API for coefficient-wise operations |
  ArrayBase< ArrayWrapper< ExpressionType > > | |
   ArrayWrapper< ExpressionType > | Expression of a mathematical vector or matrix as an array object |
  ArrayBase< Derived > | Base class for all 1D and 2D array, and related expressions |
  MatrixBase< Derived > | Base class for all dense matrices, vectors, and expressions |
  MatrixBase< CoeffBasedProduct< LhsNested, RhsNested, NestingFlags > > | |
  MatrixBase< DiagonalProduct< MatrixType, DiagonalType, ProductOrder > > | |
  MatrixBase< Homogeneous< MatrixType, _Direction > > | |
   Homogeneous< MatrixType, Direction > | Expression of one (or a set of) homogeneous vector(s) |
  MatrixBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
   dense_xpr_base_dispatcher_for_doxygen< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
    PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > > | |
     Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > | The matrix class, also used for vectors and row-vectors |
  MatrixBase< MatrixWrapper< ExpressionType > > | |
   MatrixWrapper< ExpressionType > | Expression of an array as a mathematical vector or matrix |
 Diagonal< MatrixType, DiagIndex > | Expression of a diagonal/subdiagonal/superdiagonal in a matrix |
 DiagonalMatrix< _Scalar, SizeAtCompileTime, MaxSizeAtCompileTime > | Represents a diagonal matrix with its storage |
 DiagonalPreconditioner< _Scalar > | A preconditioner based on the digonal entries |
 DiagonalWrapper< _DiagonalVectorType > | Expression of a diagonal matrix |
 EigenBase< Derived > | |
  DenseCoeffsBase< Derived, ReadOnlyAccessors > | Base class providing read-only coefficient access to matrices and arrays |
   DenseCoeffsBase< Derived, DirectAccessors > | Base class providing direct read-only coefficient access to matrices and arrays |
   DenseCoeffsBase< Derived, WriteAccessors > | Base class providing read/write coefficient access to matrices and arrays |
    DenseCoeffsBase< Derived, DirectWriteAccessors > | Base class providing direct read/write coefficient access to matrices and arrays |
  PermutationBase< Derived > | Base class for permutations |
   PermutationMatrix< Dynamic, Dynamic, Index > | |
  SparseMatrixBase< Derived > | Base class of any sparse matrices or sparse expressions |
   SparseMatrix< Scalar > | |
   SparseMatrix< Scalar, ColMajor, Index > | |
   SparseMatrix< Scalar, ColMajor, int > | |
   SparseMatrix< Scalar, RowMajor > | |
   SparseMatrix< Scalar, RowMajor, Index > | |
  PermutationBase< Map< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType >, _PacketAccess > > | |
  PermutationBase< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType > > | |
   PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType > | Permutation matrix |
   PermutationMatrix< ColsAtCompileTime, MaxColsAtCompileTime > | |
   PermutationMatrix< RowsAtCompileTime, MaxRowsAtCompileTime > | |
  PermutationBase< PermutationWrapper< _IndicesType > > | |
   PermutationWrapper< _IndicesType > | Class to view a vector of integers as a permutation matrix |
  SparseMatrixBase< CwiseBinaryOp< BinaryOp, Lhs, Rhs > > | |
  SparseMatrixBase< CwiseUnaryOp< UnaryOp, MatrixType > > | |
  SparseMatrixBase< CwiseUnaryView< ViewOp, MatrixType > > | |
  SparseMatrixBase< MappedSparseMatrix< _Scalar, _Flags, _Index > > | |
   MappedSparseMatrix< _Scalar, _Flags, _Index > | Sparse matrix |
  SparseMatrixBase< SparseDenseOuterProduct< Lhs, Rhs, Tr > > | |
  SparseMatrixBase< SparseDiagonalProduct< Lhs, Rhs > > | |
  SparseMatrixBase< SparseInnerVectorSet< MatrixType, Size > > | |
  SparseMatrixBase< SparseInnerVectorSet< SparseMatrix< _Scalar, _Options, _Index >, Size > > | |
  SparseMatrixBase< SparseMatrix< _Scalar, _Options, _Index > > | |
   SparseMatrix< _Scalar, _Options, _Index > | A versatible sparse matrix representation |
  SparseMatrixBase< SparseSparseProduct< LhsNested, RhsNested > > | |
  SparseMatrixBase< SparseTriangularView< MatrixType, Mode > > | |
  SparseMatrixBase< SparseVector< _Scalar, _Options, _Index > > | |
   SparseVector< _Scalar, _Flags, _Index > | Sparse vector class |
  SparseMatrixBase< SparseView< MatrixType > > | |
  SparseMatrixBase< Transpose< MatrixType > > | |
 EigenBase< BandMatrix< _Scalar, Rows, Cols, Supers, Subs, Options > > | |
 EigenBase< BandMatrixWrapper< _CoefficientsType, _Rows, _Cols, _Supers, _Subs, _Options > > | |
 EigenBase< HouseholderSequence< VectorsType, CoeffsType, Side > > | |
  HouseholderSequence< VectorsType, CoeffsType, Side > | Sequence of Householder reflections acting on subspaces with decreasing size |
 EigenBase< SparseSelfAdjointView< MatrixType, UpLo > > | |
  SparseSelfAdjointView< MatrixType, UpLo > | Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix |
 EigenBase< SparseSymmetricPermutationProduct< MatrixType, UpLo > > | |
 EigenBase< Transpose< PermutationBase< Derived > > > | |
 EigenSolver< _MatrixType > | Computes eigenvalues and eigenvectors of general matrices |
 ForceAlignedAccess< ExpressionType > | Enforce aligned packet loads and stores regardless of what is requested |
 FullPivHouseholderQR< MatrixType > | Householder rank-revealing QR decomposition of a matrix with full pivoting |
 FullPivLU< MatrixType > | LU decomposition of a matrix with complete pivoting, and related features |
 GeneralProduct< Lhs, Rhs, ProductType > | Expression of the product of two general matrices or vectors |
 HessenbergDecomposition< _MatrixType > | Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation |
 HessenbergDecomposition< MatrixType > | |
 HouseholderQR< MatrixType > | Householder QR decomposition of a matrix |
 Hyperplane< _Scalar, _AmbientDim, Options > | A hyperplane |
 IdentityPreconditioner | A naive preconditioner which approximates any matrix as the identity matrix |
 IncompleteLUT< _Scalar > | Incomplete LU factorization with dual-threshold strategy During the numerical factorization, two dropping rules are used : 1) any element whose magnitude is less than some tolerance is dropped. This tolerance is obtained by multiplying the input tolerance droptol by the average magnitude of all the original elements in the current row. 2) After the elimination of the row, only the fill largest elements in the L part and the fill largest elements in the U part are kept (in addition to the diagonal element ). Note that fill is computed from the input parameter fillfactor which is used the ratio to control the fill_in relatively to the initial number of nonzero elements |
 IOFormat | Stores a set of parameters controlling the way matrices are printed |
 IterativeSolverBase< Derived > | Base class for linear iterative solvers |
 IterativeSolverBase< BiCGSTAB< _MatrixType, _Preconditioner > > | |
  BiCGSTAB< _MatrixType, _Preconditioner > | A bi conjugate gradient stabilized solver for sparse square problems |
 IterativeSolverBase< ConjugateGradient< _MatrixType, _UpLo, _Preconditioner > > | |
  ConjugateGradient< _MatrixType, _UpLo, _Preconditioner > | A conjugate gradient solver for sparse self-adjoint problems |
 JacobiRotation< Scalar > | Rotation given by a cosine-sine pair |
 JacobiSVD< MatrixType, QRPreconditioner > | Two-sided Jacobi SVD decomposition of a rectangular matrix |
 SimplicialCholeskyBase< Derived >::keep_diag | |
 IncompleteLUT< _Scalar >::keep_diag | |
 LDLT< _MatrixType, _UpLo > | Robust Cholesky decomposition of a matrix with pivoting |
 LLT< _MatrixType, _UpLo > | Standard Cholesky decomposition (LL^T) of a matrix and associated features |
 MapBase< Derived, Level > | Base class for Map and Block expression with direct access |
 MapBase< Block< XprType, BlockRows, BlockCols, InnerPanel, true > > | |
 MapBase< Derived, ReadOnlyAccessors > | |
 MapBase< Map< PlainObjectType, MapOptions, StrideType > > | |
  Map< PlainObjectType, MapOptions, StrideType > | A matrix or vector expression mapping an existing array of data |
 MatrixXpr | |
 NestByValue< ExpressionType > | Expression which must be nested by value |
 NoAlias< ExpressionType, StorageBase > | Pseudo expression providing an operator = assuming no aliasing |
 NumTraits< T > | Holds information about the various numeric (i.e. scalar) types allowed by Eigen |
 NumTraits< Scalar > | |
 NumTraits< typename MatrixType::Scalar > | |
 ParametrizedLine< _Scalar, _AmbientDim, Options > | A parametrized line |
 PardisoLDLT< _MatrixType, Options > | A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library |
 PardisoLLT< _MatrixType, Options > | A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library |
 PardisoLU< _MatrixType > | A sparse direct LU factorization and solver based on the PARDISO library |
 PartialPivLU< MatrixType > | LU decomposition of a matrix with partial pivoting, and related features |
 PartialReduxExpr< MatrixType, BinaryOp, Direction > | Generic expression of a partially reduxed matrix |
 PastixLDLT< _MatrixType, Options > | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
 PastixLLT< _MatrixType, Options > | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
 PastixLU< _MatrixType, IsStrSym > | Interface to the PaStix solver |
 PlainObjectBase< Derived > | Dense storage base class for matrices and arrays |
  Array< Index, 64, 1, DontAlign > | |
  Matrix< ComplexScalar, ColsAtCompileTime, 1, Options &(~RowMajor), MaxColsAtCompileTime, 1 > | |
  Matrix< ComplexScalar, ColsAtCompileTime, 1, Options &~RowMajor, MaxColsAtCompileTime, 1 > | |
  Matrix< ComplexScalar, RowsAtCompileTime, ColsAtCompileTime, Options, MaxRowsAtCompileTime, MaxColsAtCompileTime > | |
  Matrix< double, DPARM_SIZE, 1 > | |
  Matrix< Index, 1, ColsAtCompileTime, RowMajor, 1, MaxColsAtCompileTime > | |
  Matrix< Index, Dynamic, 1 > | |
  Matrix< Index, MatrixType::RowsAtCompileTime, 1 > | |
  Matrix< int, 1, MatrixType::ColsAtCompileTime > | |
  Matrix< int, Dynamic, 1 > | |
  Matrix< int, IPARM_SIZE, 1 > | |
  Matrix< int, MatrixType::RowsAtCompileTime, 1 > | |
  Matrix< RealScalar, Dynamic, 1 > | |
  Matrix< Scalar, 1, Size, Options|RowMajor, 1, MaxSize > | |
  Matrix< Scalar, 3, 1 > | |
  Matrix< Scalar, AmbientDimAtCompileTime, 1 > | |
  Matrix< Scalar, AmbientDimAtCompileTime, 1, Options > | |
  Matrix< Scalar, ColsAtCompileTime, 1, Options &~RowMajor, MaxColsAtCompileTime, 1 > | |
  Matrix< Scalar, ColsAtCompileTime, ColsAtCompileTime, MatrixOptions, MaxColsAtCompileTime, MaxColsAtCompileTime > | |
  Matrix< Scalar, DiagSizeAtCompileTime, DiagSizeAtCompileTime, MatrixOptions, MaxDiagSizeAtCompileTime, MaxDiagSizeAtCompileTime > | |
  Matrix< Scalar, Dim, 1 > | |
  Matrix< Scalar, Dynamic, 1 > | |
  Matrix< Scalar, Index(AmbientDimAtCompileTime)==Dynamic?Dynamic:Index(AmbientDimAtCompileTime)+1, 1, Options > | |
  Matrix< Scalar, RowsAtCompileTime, 1, Options, MaxRowsAtCompileTime, 1 > | |
  Matrix< Scalar, RowsAtCompileTime, RowsAtCompileTime, MatrixOptions, MaxRowsAtCompileTime, MaxRowsAtCompileTime > | |
  Matrix< Scalar, SizeMinusOne, 1, Options &~RowMajor, MaxSizeMinusOne, 1 > | |
 Product< Lhs, Rhs > | Expression of the product of two arbitrary matrices or vectors |
 ProductReturnType< Lhs, Rhs, ProductType > | Helper class to get the correct and optimized returned type of operator* |
 ProductReturnType< Lhs, Rhs, LazyCoeffBasedProductMode > | |
 RealSchur< _MatrixType > | Performs a real Schur decomposition of a square matrix |
 RealSchur< MatrixType > | |
 Replicate< MatrixType, RowFactor, ColFactor > | Expression of the multiple replication of a matrix or vector |
 Reverse< MatrixType, Direction > | Expression of the reverse of a vector or matrix |
 RotationBase< Derived, _Dim > | Common base class for compact rotation representations |
 RotationBase< AngleAxis< _Scalar >, 3 > | |
  AngleAxis< Scalar > | Represents a 3D rotation as a rotation angle around an arbitrary 3D axis |
 RotationBase< Derived, 3 > | |
  QuaternionBase< Derived > | Base class for quaternion expressions |
 RotationBase< Map< const Quaternion< _Scalar >, _Options >, 3 > | |
  QuaternionBase< Map< const Quaternion< _Scalar >, _Options > > | |
   Map< const Quaternion< _Scalar >, _Options > | Quaternion expression mapping a constant memory buffer |
 RotationBase< Map< Quaternion< _Scalar >, _Options >, 3 > | |
  QuaternionBase< Map< Quaternion< _Scalar >, _Options > > | |
   Map< Quaternion< _Scalar >, _Options > | Expression of a quaternion from a memory buffer |
 RotationBase< Quaternion< _Scalar, _Options >, 3 > | |
  QuaternionBase< Quaternion< _Scalar, _Options > > | |
   Quaternion< Scalar, Options > | The quaternion class used to represent 3D orientations and rotations |
 RotationBase< Rotation2D< _Scalar >, 2 > | |
  Rotation2D< Scalar > | Represents a rotation/orientation in a 2 dimensional space |
 Scaling | Represents a generic uniform scaling transformation |
 Select< ConditionMatrixType, ThenMatrixType, ElseMatrixType > | Expression of a coefficient wise version of the C++ ternary operator ?: |
 SelfAdjointEigenSolver< _MatrixType > | Computes eigenvalues and eigenvectors of selfadjoint matrices |
  GeneralizedSelfAdjointEigenSolver< _MatrixType > | Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem |
 SelfAdjointView< MatrixType, UpLo > | Expression of a selfadjoint matrix from a triangular part of a dense matrix |
 SimplicialCholeskyBase< Derived > | A direct sparse Cholesky factorizations |
 SimplicialCholeskyBase< SimplicialCholesky< _MatrixType, _UpLo > > | |
  SimplicialCholesky< _MatrixType, _UpLo > | |
 SimplicialCholeskyBase< SimplicialLDLT< _MatrixType, _UpLo > > | |
  SimplicialLDLT< _MatrixType, _UpLo > | A direct sparse LDLT Cholesky factorizations without square root |
 SimplicialCholeskyBase< SimplicialLLT< _MatrixType, _UpLo > > | |
  SimplicialLLT< _MatrixType, _UpLo > | A direct sparse LLT Cholesky factorizations |
 Sparse | |
 Stride< _OuterStrideAtCompileTime, _InnerStrideAtCompileTime > | Holds strides information for Map |
 Stride< 0, Value > | |
  InnerStride< Value > | Convenience specialization of Stride to specify only an inner stride See class Map for some examples |
 Stride< Value, 0 > | |
  OuterStride< Value > | Convenience specialization of Stride to specify only an outer stride See class Map for some examples |
 SuperLUBase< _MatrixType, Derived > | The base class for the direct and incomplete LU factorization of SuperLU |
 SuperLUBase< _MatrixType, SuperILU< _MatrixType > > | |
  SuperILU< _MatrixType > | A sparse direct incomplete LU factorization and solver based on the SuperLU library |
 SuperLUBase< _MatrixType, SuperLU< _MatrixType > > | |
  SuperLU< _MatrixType > | A sparse direct LU factorization and solver based on the SuperLU library |
 Transform< Scalar, Dim, Mode, _Options > | Represents an homogeneous transformation in a N dimensional space |
 Translation< Scalar, Dim > | Represents a translation transformation |
 Transpose< MatrixType > | Expression of the transpose of a matrix |
 Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType > | Represents a sequence of transpositions (row/column interchange) |
 Transpositions< RowsAtCompileTime, MaxRowsAtCompileTime > | |
 TriangularView< _MatrixType, _Mode > | Base class for triangular part in a matrix |
 Tridiagonalization< _MatrixType > | Tridiagonal decomposition of a selfadjoint matrix |
 Triplet< Scalar, Index > | A small structure to hold a non zero as a triplet (i,j,value) |
 UmfPackLU< _MatrixType > | A sparse LU factorization and solver based on UmfPack |
 VectorwiseOp< ExpressionType, Direction > | Pseudo expression providing partial reduction operations |
 WithFormat< ExpressionType > | Pseudo expression providing matrix output with given format |