►NEigen | Namespace containing all symbols from the Eigen library |
►Ndoxygen | |
Cdense_xpr_base_dispatcher | |
Cdense_xpr_base_dispatcher< Array< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
Cdense_xpr_base_dispatcher< Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►Nsymbolic | |
CBaseExpr | |
CSymbolExpr | |
CSymbolValue | |
Caligned_allocator | STL compatible allocator to use with types requiring a non-standard alignment |
CAlignedBox | An axis aligned box |
CAMDOrdering | |
CAngleAxis | Represents a 3D rotation as a rotation angle around an arbitrary 3D axis |
CArithmeticSequence | |
CArray | General-purpose arrays with easy API for coefficient-wise operations |
CArrayBase | Base class for all 1D and 2D array, and related expressions |
CArrayWrapper | Expression of a mathematical vector or matrix as an array object |
CArrayXpr | |
CBDCSVD | Class Bidiagonal Divide and Conquer SVD |
CBiCGSTAB | A bi conjugate gradient stabilized solver for sparse square problems |
CBlock | Expression of a fixed-size or dynamic-size block |
CBlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Sparse > | |
CCholmodBase | The base class for the direct Cholesky factorization of Cholmod |
CCholmodDecomposition | A general Cholesky factorization and solver based on Cholmod |
CCholmodSimplicialLDLT | A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod |
CCholmodSimplicialLLT | A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod |
CCholmodSupernodalLLT | A supernodal Cholesky (LLT) factorization and solver based on Cholmod |
CCOLAMDOrdering | |
CColPivHouseholderQR | Householder rank-revealing QR decomposition of a matrix with column-pivoting |
CCommaInitializer | Helper class used by the comma initializer operator |
CCompleteOrthogonalDecomposition | Complete orthogonal decomposition (COD) of a matrix |
CComplexEigenSolver | Computes eigenvalues and eigenvectors of general complex matrices |
CComplexSchur | Performs a complex Schur decomposition of a real or complex square matrix |
CConjugateGradient | A conjugate gradient solver for sparse (or dense) self-adjoint problems |
CCwiseBinaryOp | Generic expression where a coefficient-wise binary operator is applied to two expressions |
CCwiseNullaryOp | Generic expression of a matrix where all coefficients are defined by a functor |
CCwiseTernaryOp | Generic expression where a coefficient-wise ternary operator is applied to two expressions |
CCwiseUnaryOp | Generic expression where a coefficient-wise unary operator is applied to an expression |
CCwiseUnaryView | Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector |
CDense | |
CDenseBase | Base class for all dense matrices, vectors, and arrays |
CDenseCoeffsBase< Derived, DirectAccessors > | Base class providing direct read-only coefficient access to matrices and arrays |
CDenseCoeffsBase< Derived, DirectWriteAccessors > | Base class providing direct read/write coefficient access to matrices and arrays |
CDenseCoeffsBase< Derived, ReadOnlyAccessors > | Base class providing read-only coefficient access to matrices and arrays |
CDenseCoeffsBase< Derived, WriteAccessors > | Base class providing read/write coefficient access to matrices and arrays |
CDiagonal | Expression of a diagonal/subdiagonal/superdiagonal in a matrix |
CDiagonalBase | Base class for diagonal matrices and expressions |
CDiagonalMatrix | Represents a diagonal matrix with its storage |
CDiagonalPreconditioner | A preconditioner based on the digonal entries |
CDiagonalWrapper | Expression of a diagonal matrix |
CEigenBase | |
CEigenSolver | Computes eigenvalues and eigenvectors of general matrices |
CForceAlignedAccess | Enforce aligned packet loads and stores regardless of what is requested |
CFullPivHouseholderQR | Householder rank-revealing QR decomposition of a matrix with full pivoting |
CFullPivLU | LU decomposition of a matrix with complete pivoting, and related features |
CGeneralizedEigenSolver | Computes the generalized eigenvalues and eigenvectors of a pair of general matrices |
CGeneralizedSelfAdjointEigenSolver | Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem |
CHessenbergDecomposition | Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation |
CHomogeneous | Expression of one (or a set of) homogeneous vector(s) |
CHouseholderQR | Householder QR decomposition of a matrix |
CHouseholderSequence | Sequence of Householder reflections acting on subspaces with decreasing size |
CHyperplane | A hyperplane |
CIdentityPreconditioner | A naive preconditioner which approximates any matrix as the identity matrix |
CIncompleteCholesky | Modified Incomplete Cholesky with dual threshold |
►CIncompleteLUT | Incomplete LU factorization with dual-threshold strategy |
Ckeep_diag | |
CIndexedView | Expression of a non-sequential sub-matrix defined by arbitrary sequences of row and column indices |
CInnerStride | Convenience specialization of Stride to specify only an inner stride See class Map for some examples |
CInverse | Expression of the inverse of another expression |
CIOFormat | Stores a set of parameters controlling the way matrices are printed |
CIterativeSolverBase | Base class for linear iterative solvers |
CJacobiRotation | Rotation given by a cosine-sine pair |
CJacobiSVD | Two-sided Jacobi SVD decomposition of a rectangular matrix |
CLDLT | Robust Cholesky decomposition of a matrix with pivoting |
CLeastSquareDiagonalPreconditioner | Jacobi preconditioner for LeastSquaresConjugateGradient |
CLeastSquaresConjugateGradient | A conjugate gradient solver for sparse (or dense) least-square problems |
CLLT | Standard Cholesky decomposition (LL^T) of a matrix and associated features |
CMap | A matrix or vector expression mapping an existing array of data |
CMap< const Quaternion< Scalar_ >, Options_ > | Quaternion expression mapping a constant memory buffer |
CMap< Quaternion< Scalar_ >, Options_ > | Expression of a quaternion from a memory buffer |
CMap< SparseMatrixType > | Specialization of class Map for SparseMatrix-like storage |
CMapBase< Derived, ReadOnlyAccessors > | Base class for dense Map and Block expression with direct access |
CMapBase< Derived, WriteAccessors > | Base class for non-const dense Map and Block expression with direct access |
CMatrix | The matrix class, also used for vectors and row-vectors |
CMatrixBase | Base class for all dense matrices, vectors, and expressions |
CMatrixWrapper | Expression of an array as a mathematical vector or matrix |
CMatrixXpr | |
CMaxSizeVector | The MaxSizeVector class |
CMetisOrdering | |
CNaturalOrdering | |
CNestByValue | Expression which must be nested by value |
CNoAlias | Pseudo expression providing an operator = assuming no aliasing |
CNumTraits | Holds information about the various numeric (i.e. scalar) types allowed by Eigen |
COuterStride | Convenience specialization of Stride to specify only an outer stride See class Map for some examples |
CParametrizedLine | A parametrized line |
CPardisoLDLT | A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library |
CPardisoLLT | A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library |
CPardisoLU | A sparse direct LU factorization and solver based on the PARDISO library |
CPartialPivLU | LU decomposition of a matrix with partial pivoting, and related features |
CPartialReduxExpr | Generic expression of a partially reduxed matrix |
CPastixLDLT | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
CPastixLLT | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
CPastixLU | Interface to the PaStix solver |
CPermutationBase | Base class for permutations |
CPermutationMatrix | Permutation matrix |
CPermutationStorage | |
CPermutationWrapper | Class to view a vector of integers as a permutation matrix |
CPlainObjectBase | Dense storage base class for matrices and arrays |
CProduct | Expression of the product of two arbitrary matrices or vectors |
CQuaternion | The quaternion class used to represent 3D orientations and rotations |
CQuaternionBase | Base class for quaternion expressions |
CRealQZ | Performs a real QZ decomposition of a pair of square matrices |
CRealSchur | Performs a real Schur decomposition of a square matrix |
CRef | A matrix or vector expression mapping an existing expression |
CRef< SparseMatrixType, Options > | A sparse matrix expression referencing an existing sparse expression |
CRef< SparseVectorType > | A sparse vector expression referencing an existing sparse vector expression |
CReplicate | Expression of the multiple replication of a matrix or vector |
CReshaped | Expression of a fixed-size or dynamic-size reshape |
CReverse | Expression of the reverse of a vector or matrix |
CRotation2D | Represents a rotation/orientation in a 2 dimensional space |
CRotationBase | Common base class for compact rotation representations |
CScalarBinaryOpTraits | Determines whether the given binary operation of two numeric types is allowed and what the scalar return type is |
CSelect | Expression of a coefficient wise version of the C++ ternary operator ?: |
CSelfAdjointEigenSolver | Computes eigenvalues and eigenvectors of selfadjoint matrices |
CSelfAdjointView | Expression of a selfadjoint matrix from a triangular part of a dense matrix |
CSerializer | |
CSimplicialCholesky | |
►CSimplicialCholeskyBase | A base class for direct sparse Cholesky factorizations |
Ckeep_diag | |
CSimplicialLDLT | A direct sparse LDLT Cholesky factorizations without square root |
CSimplicialLLT | A direct sparse LLT Cholesky factorizations |
CSimplicialNonHermitianLDLT | A direct sparse LDLT Cholesky factorizations without square root, for symmetric non-hermitian matrices |
CSimplicialNonHermitianLLT | A direct sparse LLT Cholesky factorizations, for symmetric non-hermitian matrices |
CSkewSymmetricBase | Base class for skew symmetric matrices and expressions |
CSkewSymmetricMatrix3 | Represents a 3x3 skew symmetric matrix with its storage |
CSkewSymmetricWrapper | Expression of a skew symmetric matrix |
CSolve | Pseudo expression representing a solving operation |
CSolverBase | A base class for matrix decomposition and solvers |
CSolverStorage | |
CSolveWithGuess | Pseudo expression representing a solving operation |
CSparse | |
CSparseCompressedBase | Common base class for sparse [compressed]-{row|column}-storage format |
CSparseLU | Sparse supernodal LU factorization for general matrices |
CSparseMapBase< Derived, ReadOnlyAccessors > | Common base class for Map and Ref instance of sparse matrix and vector |
CSparseMapBase< Derived, WriteAccessors > | Common base class for writable Map and Ref instance of sparse matrix and vector |
CSparseMatrix | A versatible sparse matrix representation |
CSparseMatrixBase | Base class of any sparse matrices or sparse expressions |
CSparseQR | Sparse left-looking QR factorization with numerical column pivoting |
CSparseSelfAdjointView | Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix |
CSparseSolverBase | A base class for sparse solvers |
CSparseVector | Sparse vector class |
CSparseView | Expression of a dense or sparse matrix with zero or too small values removed |
CSPQR | Sparse QR factorization based on SuiteSparseQR library |
CStride | Holds strides information for Map |
CSuperILU | A sparse direct incomplete LU factorization and solver based on the SuperLU library |
CSuperLU | A sparse direct LU factorization and solver based on the SuperLU library |
CSuperLUBase | The base class for the direct and incomplete LU factorization of SuperLU |
CSVDBase | Base class of SVD algorithms |
CTransform | Represents an homogeneous transformation in a N dimensional space |
CTranslation | Represents a translation transformation |
CTranspose | Expression of the transpose of a matrix |
CTranspositions | Represents a sequence of transpositions (row/column interchange) |
CTranspositionsStorage | |
CTriangularBase | Base class for triangular part in a matrix |
CTriangularView | Expression of a triangular part in a matrix |
CTriangularViewImpl< MatrixType, Mode, Sparse > | Base class for a triangular part in a sparse matrix |
CTriangularViewImpl< MatrixType_, Mode_, Dense > | Base class for a triangular part in a dense matrix |
CTridiagonalization | Tridiagonal decomposition of a selfadjoint matrix |
CTriplet | A small structure to hold a non zero as a triplet (i,j,value) |
CUmfPackLU | A sparse LU factorization and solver based on UmfPack |
CUniformScaling | Represents a generic uniform scaling transformation |
CVectorBlock | Expression of a fixed-size or dynamic-size sub-vector |
CVectorwiseOp | Pseudo expression providing broadcasting and partial reduction operations |
CWithFormat | Pseudo expression providing matrix output with given format |
CAccelerateCholeskyAtA | A QR factorization and solver based on Accelerate without storing Q (equivalent to A^TA = R^T R) |
CAccelerateLDLT | The default Cholesky (LDLT) factorization and solver based on Accelerate |
CAccelerateLDLTSBK | A direct Cholesky (LDLT) factorization and solver based on Accelerate with Supernode Bunch-Kaufman and static pivoting |
CAccelerateLDLTTPP | A direct Cholesky (LDLT) factorization and solver based on Accelerate with full threshold partial pivoting |
CAccelerateLDLTUnpivoted | A direct Cholesky-like LDL^T factorization and solver based on Accelerate with only 1x1 pivots and no pivoting |
CAccelerateLLT | A direct Cholesky (LLT) factorization and solver based on Accelerate |
CAccelerateQR | A QR factorization and solver based on Accelerate |