►NEigen | : InteropHeaders |
►Nbfloat16_impl | |
C__bfloat16_raw | |
Cbfloat16_base | |
Cnumeric_limits_bfloat16_impl | |
►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_ > > | |
►Nhalf_impl | |
C__half_raw | |
Cfloat32_bits | |
Chalf_base | |
Cnumeric_limits_half_impl | |
►Nnumext | |
Cequal_strict_impl | |
Cequal_strict_impl< X, Y, true, false, true, true > | |
Cequal_strict_impl< X, Y, true, true, true, false > | |
Cget_integer_by_size | |
Cget_integer_by_size< 1 > | |
Cget_integer_by_size< 2 > | |
Cget_integer_by_size< 4 > | |
Cget_integer_by_size< 8 > | |
Csignbit_impl | |
Csignbit_impl< Scalar, false, true > | |
Csignbit_impl< Scalar, true, false > | |
Csignbit_impl< Scalar, true, true > | |
►Nsymbolic | |
CAddExpr | |
CBaseExpr | |
Cis_symbolic | |
CNegateExpr | |
CProductExpr | |
CQuotientExpr | |
CSymbol | |
CSymbolExpr | |
CSymbolValue | |
CValueExpr | |
CAccelerateImpl | |
►Caligned_allocator | STL compatible allocator to use with types requiring a non-standard alignment |
Crebind | |
►Caligned_allocator_indirection | |
Crebind | |
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 |
CPrivateType | |
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 | |
CBandShape | |
CBarrier | |
CBDCSVD | Class Bidiagonal Divide and Conquer SVD |
Cbfloat16 | |
CBiCGSTAB | A bi conjugate gradient stabilized solver for sparse square problems |
CBlock | Expression of a fixed-size or dynamic-size block |
CBlockImpl | |
CBlockImpl< const SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols, true, Sparse > | |
CBlockImpl< SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols, true, Sparse > | |
CBlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Dense > | |
CBlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Sparse > | |
CBlockImpl< XprType, BlockRows, BlockCols, true, 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 |
CConjugate | |
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 |
CCwiseBinaryOpImpl | |
CCwiseBinaryOpImpl< BinaryOp, Lhs, Rhs, Sparse > | |
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 |
CCwiseTernaryOpImpl | |
CCwiseUnaryOp | Generic expression where a coefficient-wise unary operator is applied to an expression |
CCwiseUnaryOpImpl | |
CCwiseUnaryView | Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector |
CCwiseUnaryViewImpl | |
CCwiseUnaryViewImpl< ViewOp, MatrixType, StrideType, Dense > | |
CDense | |
CDenseBase | Base class for all dense matrices, vectors, and arrays |
CDenseCoeffsBase | |
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 |
CDenseShape | |
CDenseSparseProductReturnType | |
CDenseStorage | |
CDenseTimeSparseProduct | |
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 |
CDiagonalProduct | |
CDiagonalShape | |
CDiagonalWrapper | Expression of a diagonal matrix |
CEigenBase | |
CEigenSolver | Computes eigenvalues and eigenvectors of general matrices |
►CEventCount | |
CWaiter | |
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 |
Cgeneral_product_to_triangular_selector | |
Cgeneral_product_to_triangular_selector< MatrixType, ProductType, UpLo, false > | |
Cgeneral_product_to_triangular_selector< MatrixType, ProductType, UpLo, true > | |
CGeneralizedEigenSolver | Computes the generalized eigenvalues and eigenvectors of a pair of general matrices |
CGeneralizedSelfAdjointEigenSolver | Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem |
CGenericNumTraits | |
Chalf | |
CHessenbergDecomposition | Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation |
CHomogeneous | Expression of one (or a set of) homogeneous vector(s) |
CHomogeneousShape | |
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 |
CIndexedViewImpl | |
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 |
CInverseImpl | |
CInverseImpl< PermutationType, PermutationStorage > | |
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 |
CKLU | |
CLazyProductReturnType | |
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< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess_ > | |
CMap< Quaternion< Scalar_ >, Options_ > | Expression of a quaternion from a memory buffer |
CMap< SparseMatrixType > | Specialization of class Map for SparseMatrix-like storage |
CMap< Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess > | |
CMapBase | |
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 |
CConstSelfAdjointViewReturnType | |
CConstTriangularViewReturnType | |
CSelfAdjointViewReturnType | |
CTriangularViewReturnType | |
CMatrixComplexPowerReturnValue | |
CMatrixExponentialReturnValue | |
CMatrixFunctionReturnValue | |
CMatrixLogarithmReturnValue | |
CMatrixPowerReturnValue | |
CMatrixSquareRootReturnValue | |
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 |
CNotification | |
CNumTraits | Holds information about the various numeric (i.e. scalar) types allowed by Eigen |
CNumTraits< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
CNumTraits< bool > | |
CNumTraits< double > | |
CNumTraits< Eigen::bfloat16 > | |
CNumTraits< Eigen::half > | |
CNumTraits< float > | |
CNumTraits< long double > | |
CNumTraits< std::complex< Real_ > > | |
CNumTraits< std::string > | |
CNumTraits< void > | |
COuterStride | Convenience specialization of Stride to specify only an outer stride See class Map for some examples |
CParametrizedLine | A parametrized line |
CPardisoImpl | |
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 |
Cpartial_redux_dummy_func | |
CPartialPivLU | LU decomposition of a matrix with partial pivoting, and related features |
CPartialReduxExpr | Generic expression of a partially reduxed matrix |
CPastixBase | |
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 |
CPermutationShape | |
CPermutationStorage | |
CPermutationWrapper | Class to view a vector of integers as a permutation matrix |
►CPlainObjectBase | Dense storage base class for matrices and arrays |
CStridedAlignedMapType | |
CStridedConstAlignedMapType | |
CStridedConstMapType | |
CStridedMapType | |
CProduct | Expression of the product of two arbitrary matrices or vectors |
CProductImpl | |
CProductImpl< Lhs, Rhs, Option, Dense > | |
CProductReturnType | |
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< const SparseMatrix< MatScalar, MatOptions, MatIndex >, Options, StrideType > | |
CRef< const SparseVector< MatScalar, MatOptions, MatIndex >, Options, StrideType > | |
CRef< const TPlainObjectType, Options, StrideType > | |
CRef< SparseMatrixType, Options > | A sparse matrix expression referencing an existing sparse expression |
CRef< SparseVectorType > | A sparse vector expression referencing an existing sparse vector expression |
CRefBase | |
CReplicate | Expression of the multiple replication of a matrix or vector |
CReshaped | Expression of a fixed-size or dynamic-size reshape |
CReshapedImpl | |
CReshapedImpl< XprType, Rows, Cols, Order, Dense > | |
CReturnByValue | |
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 |
►CRunQueue | |
CElem | |
CScalarBinaryOpTraits | Determines whether the given binary operation of two numeric types is allowed and what the scalar return type is |
CScalarBinaryOpTraits< T, T, BinaryOp > | |
CScalarBinaryOpTraits< T, typename NumTraits< std::enable_if_t< NumTraits< T >::IsComplex, T > >::Real, BinaryOp > | |
CScalarBinaryOpTraits< T, void, BinaryOp > | |
CScalarBinaryOpTraits< typename NumTraits< std::enable_if_t< NumTraits< T >::IsComplex, T > >::Real, T, BinaryOp > | |
CScalarBinaryOpTraits< void, T, BinaryOp > | |
CScalarBinaryOpTraits< void, void, BinaryOp > | |
CSelect | Expression of a coefficient wise version of the C++ ternary operator ?: |
Cselfadjoint_product_selector | |
Cselfadjoint_product_selector< MatrixType, OtherType, UpLo, false > | |
Cselfadjoint_product_selector< MatrixType, OtherType, UpLo, true > | |
Cselfadjoint_rank1_update | |
Cselfadjoint_rank1_update< Scalar, Index, ColMajor, UpLo, ConjLhs, ConjRhs > | |
Cselfadjoint_rank1_update< Scalar, Index, RowMajor, UpLo, ConjLhs, ConjRhs > | |
CSelfAdjointEigenSolver | Computes eigenvalues and eigenvectors of selfadjoint matrices |
CSelfAdjointShape | |
CSelfAdjointView | Expression of a selfadjoint matrix from a triangular part of a dense matrix |
CSerializer | |
CSerializer< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
►CSerializer< DenseBase< Derived >, void > | |
CHeader | |
CSerializer< Matrix< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
►CSerializer< SparseMatrix< Scalar, Options, StorageIndex >, void > | |
CHeader | |
►CSerializer< SparseVector< Scalar, Options, StorageIndex >, void > | |
CHeader | |
CSerializer< T, typename std::enable_if_t< std::is_trivial< T >::value &&std::is_standard_layout< T >::value > > | |
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 |
CSkewSymmetricBase | Base class for skew symmetric matrices and expressions |
CSkewSymmetricMatrix3 | Represents a 3x3 skew symmetric matrix with its storage |
CSkewSymmetricShape | |
CSkewSymmetricWrapper | Expression of a skew symmetric matrix |
CSluMatrix | |
CSluMatrixMapHelper | |
CSluMatrixMapHelper< Matrix< Scalar, Rows, Cols, Options, MRows, MCols > > | |
CSluMatrixMapHelper< SparseMatrixBase< Derived > > | |
CSolve | Pseudo expression representing a solving operation |
CSolveImpl | |
CSolveImpl< Decomposition, RhsType, Dense > | |
CSolverBase | A base class for matrix decomposition and solvers |
CSolverShape | |
CSolverStorage | |
CSolveWithGuess | Pseudo expression representing a solving operation |
CSparse | |
CSparseCompressedBase | Common base class for sparse [compressed]-{row|column}-storage format |
CSparseDenseOuterProduct | |
CSparseDenseProductReturnType | |
CSparseDiagonalProduct | |
CSparseLU | Sparse supernodal LU factorization for general matrices |
CSparseLUMatrixLReturnType | |
CSparseLUMatrixUReturnType | |
CSparseLUTransposeView | |
CSparseMapBase | |
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 |
CIndexPosPair | |
CSingletonVector | |
►CSparseMatrixBase | Base class of any sparse matrices or sparse expressions |
CConstSelfAdjointViewReturnType | |
CCwiseProductDenseReturnType | |
CSelfAdjointViewReturnType | |
CSparseQR | Sparse left-looking QR factorization with numerical column pivoting |
CSparseQR_QProduct | |
CSparseQRMatrixQReturnType | |
CSparseQRMatrixQTransposeReturnType | |
CSparseSelfAdjointView | Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix |
CSparseShape | |
CSparseSolverBase | A base class for sparse solvers |
CSparseSparseProduct | |
CSparseSparseProductReturnType | |
CSparseSymmetricPermutationProduct | |
CSparseTimeDenseProduct | |
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 |
CSPQR_QProduct | |
CSPQRMatrixQReturnType | |
CSPQRMatrixQTransposeReturnType | |
►CStlThreadEnvironment | |
CEnvThread | |
CTask | |
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 |
CSwapWrapper | |
►CThreadLocal | |
CThreadIdAndValue | |
CThreadPoolInterface | |
►CThreadPoolTempl | |
CPerThread | |
CThreadData | |
CTransform | Represents an homogeneous transformation in a N dimensional space |
CTranslation | Represents a translation transformation |
CTranspose | Expression of the transpose of a matrix |
CTranspose< TranspositionsBase< TranspositionsDerived > > | |
CTransposeImpl | |
CTransposeImpl< MatrixType, Dense > | |
CTransposeImpl< MatrixType, Sparse > | |
CTranspositions | Represents a sequence of transpositions (row/column interchange) |
CTranspositionsBase | |
CTranspositionsShape | |
CTranspositionsStorage | |
CTranspositionsWrapper | |
CTriangularBase | Base class for triangular part in a matrix |
CTriangularShape | |
CTriangularView | Expression of a triangular part in a matrix |
CTriangularViewImpl | |
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 |
CExtendedType | |
CLpNormReturnType | |
COppositeExtendedType | |
CReduxReturnType | |
CReturnType | |
CWithFormat | Pseudo expression providing matrix output with given format |
►Nstd | |
Cnumeric_limits< const Eigen::bfloat16 > | |
Cnumeric_limits< const Eigen::half > | |
Cnumeric_limits< const volatile Eigen::bfloat16 > | |
Cnumeric_limits< const volatile Eigen::half > | |
Cnumeric_limits< Eigen::bfloat16 > | |
Cnumeric_limits< Eigen::half > | |
Cnumeric_limits< volatile Eigen::bfloat16 > | |
Cnumeric_limits< volatile Eigen::half > | |
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 |
►Calpha_store | |
Cri | |
CBinaryOp | |
CCastXpr | |
CEIGEN_ALIGNED_ALLOCATOR | |
CEvalIterator | |
CLhsIterator | |
CloadColData_impl | |
CloadColData_impl< RhsMapper, true > | |
CScalarBlock | |
CShiftLeftXpr | |
CShiftRightXpr | |
CSparseLUImpl | |
Ctake | |