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