►CEigen::bfloat16_impl::__bfloat16_raw | |
►CEigen::bfloat16_impl::bfloat16_base | |
CEigen::bfloat16 | |
►CEigen::half_impl::__half_raw | |
►CEigen::half_impl::half_base | |
CEigen::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 |
CEigen::AlignedBox< Scalar_, AmbientDim_ > | An axis aligned box |
►Cstd::allocator | |
CEigen::aligned_allocator< T > | STL compatible allocator to use with types requiring a non-standard alignment |
Calpha_store< PResPacket, ResPacket, ResScalar, Scalar > | |
CEigen::AMDOrdering< StorageIndex > | |
CEigen::ArithmeticSequence< FirstType, SizeType, IncrType > | |
CEigen::ArrayXpr | |
CEigen::BandShape | |
►CEigen::Barrier | |
CEigen::Notification | |
CEigen::symbolic::BaseExpr< Derived > | |
►CEigen::symbolic::BaseExpr< AddExpr< Arg0, Arg1 > > | |
CEigen::symbolic::AddExpr< Arg0, Arg1 > | |
►CEigen::symbolic::BaseExpr< NegateExpr< Arg0 > > | |
CEigen::symbolic::NegateExpr< Arg0 > | |
►CEigen::symbolic::BaseExpr< ProductExpr< Arg0, Arg1 > > | |
CEigen::symbolic::ProductExpr< Arg0, Arg1 > | |
►CEigen::symbolic::BaseExpr< QuotientExpr< Arg0, Arg1 > > | |
CEigen::symbolic::QuotientExpr< Arg0, Arg1 > | |
►CEigen::symbolic::BaseExpr< SymbolExpr< tag > > | |
CEigen::symbolic::SymbolExpr< tag > | |
CBinaryOp | |
►CEigen::BlockImpl< XprType, BlockRows, BlockCols, InnerPanel, StorageKind > | |
►CEigen::Block< VectorType, internal::traits< VectorType >::Flags &RowMajorBit ? 1 :Size, internal::traits< VectorType >::Flags &RowMajorBit ? Size :1 > | |
CEigen::VectorBlock< VectorType, Size > | Expression of a fixed-size or dynamic-size sub-vector |
►CEigen::BlockImpl< XprType, BlockRows, BlockCols, InnerPanel, internal::traits< XprType >::StorageKind > | |
CEigen::Block< XprType, BlockRows, BlockCols, InnerPanel > | Expression of a fixed-size or dynamic-size block |
CCastXpr< NewType > | |
CEigen::COLAMDOrdering< StorageIndex > | |
CEigen::CommaInitializer< XprType > | Helper class used by the comma initializer operator |
CEigen::ComplexEigenSolver< MatrixType_ > | Computes eigenvalues and eigenvectors of general complex matrices |
CEigen::ComplexSchur< MatrixType_ > | Performs a complex Schur decomposition of a real or complex square matrix |
CEigen::ComplexSchur< MatrixType > | |
CEigen::Conjugate< MatrixType > | |
CEigen::MatrixBase< Derived >::ConstSelfAdjointViewReturnType< UpLo > | |
CEigen::SparseMatrixBase< Derived >::ConstSelfAdjointViewReturnType< UpLo > | |
CEigen::MatrixBase< Derived >::ConstTriangularViewReturnType< Mode > | |
CEigen::SparseMatrixBase< Derived >::CwiseProductDenseReturnType< OtherDerived > | |
CEigen::Dense | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Derived > | |
►CEigen::PlainObjectBase< Derived > | Dense storage base class for matrices and arrays |
CEigen::Matrix< int, 1, MatrixType::ColsAtCompileTime > | |
CEigen::Matrix< int, MatrixType::RowsAtCompileTime, 1 > | |
CEigen::Matrix< Scalar, RowsAtCompileTime, 1, 0, MaxRowsAtCompileTime, 1 > | |
CEigen::Matrix< RealScalar, Dynamic, 1 > | |
CEigen::Matrix< Scalar, Index(AmbientDimAtCompileTime)==Dynamic ? Dynamic :Index(AmbientDimAtCompileTime)+1, 1, Options > | |
CEigen::Matrix< Scalar, AmbientDimAtCompileTime, 1, Options > | |
CEigen::Matrix< Scalar, 3, 1 > | |
CEigen::Matrix< StorageIndex, MatrixType::RowsAtCompileTime, 1 > | |
CEigen::Matrix< ComplexScalar, ColsAtCompileTime, 1, Options &(~RowMajor), MaxColsAtCompileTime, 1 > | |
CEigen::Matrix< RealScalar, Dynamic, Dynamic, ColMajor > | |
CEigen::Matrix< StorageIndex, Dynamic, 1 > | |
CEigen::Matrix< Scalar, Dynamic, 1 > | |
CEigen::Matrix< Scalar, Dim, 1 > | |
CEigen::Matrix< Scalar, DiagSizeAtCompileTime, DiagSizeAtCompileTime, MatrixOptions, MaxDiagSizeAtCompileTime, MaxDiagSizeAtCompileTime > | |
CEigen::Matrix< Scalar, 1, Size, int(Options)|int(RowMajor), 1, MaxSize > | |
CEigen::Matrix< Scalar, SizeMinusOne, 1, Options &~RowMajor, MaxSizeMinusOne, 1 > | |
CEigen::Matrix< Scalar, Size, Size, ColMajor, MaxColsAtCompileTime, MaxColsAtCompileTime > | |
CEigen::Matrix< Scalar, ColsAtCompileTime, 1, Options &~RowMajor, MaxColsAtCompileTime, 1 > | |
CEigen::Matrix< ComplexScalar, ColsAtCompileTime, 1, Options &~RowMajor, MaxColsAtCompileTime, 1 > | |
CEigen::Matrix< ComplexScalar, RowsAtCompileTime, ColsAtCompileTime, Options, MaxRowsAtCompileTime, MaxColsAtCompileTime > | |
CEigen::Matrix< Scalar, Dynamic, Dynamic, ColMajor > | |
CEigen::Matrix< Scalar, AmbientDimAtCompileTime, 1 > | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< double, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< double, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< double, UMFPACK_CONTROL, 1 > | |
CEigen::Array< double, UMFPACK_INFO, 1 > | |
CEigen::Array< double, DPARM_SIZE, 1 > | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< Index, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< Index, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< Index, 1, Dynamic > | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< int, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< int, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< int, IPARM_SIZE, 1 > | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< RealScalar, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< RealScalar, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< RealScalar, Dynamic, 1 > | |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< StorageIndex, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< StorageIndex, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< StorageIndex, 2, 1 > | |
CEigen::Array< StorageIndex, 64, 1, DontAlign > | |
►CEigen::DenseCoeffsBase< Derived, Level > | |
►CEigen::DenseBase< Homogeneous< MatrixType, Direction_ > > | |
►CEigen::MatrixBase< Homogeneous< MatrixType, Direction_ > > | |
CEigen::Homogeneous< MatrixType, Direction_ > | Expression of one (or a set of) homogeneous vector(s) |
►CEigen::DenseBase< MatrixWrapper< ExpressionType > > | |
►CEigen::MatrixBase< MatrixWrapper< ExpressionType > > | |
CEigen::MatrixWrapper< ExpressionType > | Expression of an array as a mathematical vector or matrix |
►CEigen::DenseBase< Solve< Decomposition, RhsType > > | |
►CEigen::MatrixBase< Solve< Decomposition, RhsType > > | |
CEigen::SolveImpl< Decomposition, RhsType, Dense > | |
CEigen::DenseShape | |
CEigen::DenseSparseProductReturnType< Lhs, Rhs, InnerSize > | |
CEigen::DenseStorage< T, Size, Rows_, Cols_, Options_ > | |
CEigen::DenseTimeSparseProduct< Lhs, Rhs > | |
►CEigen::DiagonalPreconditioner< Scalar_ > | A preconditioner based on the digonal entries |
CEigen::LeastSquareDiagonalPreconditioner< Scalar_ > | Jacobi preconditioner for LeastSquaresConjugateGradient |
CEigen::DiagonalProduct< MatrixType, DiagonalType, ProductOrder > | |
CEigen::DiagonalShape | |
►CEIGEN_ALIGNED_ALLOCATOR | |
CEigen::aligned_allocator_indirection< T > | |
►CEigen::EigenBase< Derived > | |
►CEigen::DiagonalBase< DiagonalWrapper< DiagonalVectorType_ > > | |
CEigen::DiagonalWrapper< DiagonalVectorType_ > | Expression of a diagonal matrix |
►CEigen::DiagonalBase< DiagonalMatrix< Scalar_, SizeAtCompileTime, MaxSizeAtCompileTime > > | |
CEigen::DiagonalMatrix< Scalar_, SizeAtCompileTime, MaxSizeAtCompileTime > | Represents a diagonal matrix with its storage |
►CEigen::PermutationBase< Map< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess_ > > | |
CEigen::Map< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess_ > | |
►CEigen::PermutationBase< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ > > | |
CEigen::PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ > | Permutation matrix |
►CEigen::PermutationBase< PermutationWrapper< IndicesType_ > > | |
CEigen::PermutationWrapper< IndicesType_ > | Class to view a vector of integers as a permutation matrix |
►CEigen::SkewSymmetricBase< SkewSymmetricMatrix3< Scalar_ > > | |
CEigen::SkewSymmetricMatrix3< Scalar_ > | Represents a 3x3 skew symmetric matrix with its storage |
►CEigen::SkewSymmetricBase< SkewSymmetricWrapper< SkewSymmetricVectorType_ > > | |
CEigen::SkewSymmetricWrapper< SkewSymmetricVectorType_ > | Expression of a skew symmetric matrix |
►CEigen::SolverBase< FullPivLU< MatrixType_, PermutationIndex_ > > | |
CEigen::FullPivLU< MatrixType_, PermutationIndex_ > | LU decomposition of a matrix with complete pivoting, and related features |
►CEigen::SolverBase< FullPivHouseholderQR< MatrixType_, PermutationIndex_ > > | |
CEigen::FullPivHouseholderQR< MatrixType_, PermutationIndex_ > | Householder rank-revealing QR decomposition of a matrix with full pivoting |
►CEigen::SolverBase< CompleteOrthogonalDecomposition< MatrixType_, PermutationIndex_ > > | |
CEigen::CompleteOrthogonalDecomposition< MatrixType_, PermutationIndex_ > | Complete orthogonal decomposition (COD) of a matrix |
►CEigen::SolverBase< HouseholderQR< MatrixType_ > > | |
CEigen::HouseholderQR< MatrixType_ > | Householder QR decomposition of a matrix |
►CEigen::SolverBase< ColPivHouseholderQR< MatrixType_, PermutationIndex_ > > | |
CEigen::ColPivHouseholderQR< MatrixType_, PermutationIndex_ > | Householder rank-revealing QR decomposition of a matrix with column-pivoting |
►CEigen::SolverBase< LDLT< MatrixType_, UpLo_ > > | |
CEigen::LDLT< MatrixType_, UpLo_ > | Robust Cholesky decomposition of a matrix with pivoting |
►CEigen::SolverBase< LLT< MatrixType_, UpLo_ > > | |
CEigen::LLT< MatrixType_, UpLo_ > | Standard Cholesky decomposition (LL^T) of a matrix and associated features |
►CEigen::SolverBase< PartialPivLU< MatrixType_, PermutationIndex_ > > | |
CEigen::PartialPivLU< MatrixType_, PermutationIndex_ > | LU decomposition of a matrix with partial pivoting, and related features |
►CEigen::SolverBase< SVDBase< Derived > > | |
►CEigen::SVDBase< Derived > | Base class of SVD algorithms |
CEigen::JacobiSVD< MatrixType, ComputationOptions > | |
►CEigen::TriangularBase< SelfAdjointView< MatrixType_, UpLo > > | |
CEigen::SelfAdjointView< MatrixType_, UpLo > | Expression of a selfadjoint matrix from a triangular part of a dense matrix |
►CEigen::TriangularBase< TriangularView< MatrixType_, Mode_ > > | |
CEigen::TriangularViewImpl< MatrixType_, Mode_, Dense > | Base class for a triangular part in a dense matrix |
►CEigen::DenseCoeffsBase< Derived, ReadOnlyAccessors > | Base class providing read-only coefficient access to matrices and arrays |
CEigen::DenseCoeffsBase< Derived, DirectAccessors > | Base class providing direct read-only coefficient access to matrices and arrays |
►CEigen::DenseCoeffsBase< Derived, WriteAccessors > | Base class providing read/write coefficient access to matrices and arrays |
►CEigen::DenseCoeffsBase< Derived, DirectWriteAccessors > | Base class providing direct read/write coefficient access to matrices and arrays |
►CEigen::DenseBase< Derived > | Base class for all dense matrices, vectors, and arrays |
►CEigen::ArrayBase< ArrayWrapper< ExpressionType > > | |
CEigen::ArrayWrapper< ExpressionType > | Expression of a mathematical vector or matrix as an array object |
►CEigen::ArrayBase< Derived > | Base class for all 1D and 2D array, and related expressions |
►CEigen::doxygen::dense_xpr_base_dispatcher< Array< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Array< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Array< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > | General-purpose arrays with easy API for coefficient-wise operations |
►CEigen::MatrixBase< Derived > | Base class for all dense matrices, vectors, and expressions |
►CEigen::doxygen::dense_xpr_base_dispatcher< Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
►CEigen::PlainObjectBase< Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > > | |
CEigen::Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ > | The matrix class, also used for vectors and row-vectors |
CEigen::DiagonalBase< Derived > | Base class for diagonal matrices and expressions |
►CEigen::PermutationBase< Derived > | Base class for permutations |
CEigen::PermutationMatrix< ColsAtCompileTime, MaxColsAtCompileTime, PermutationIndex > | |
CEigen::PermutationMatrix< Dynamic, Dynamic, StorageIndex > | |
CEigen::PermutationMatrix< RowsAtCompileTime, MaxRowsAtCompileTime, PermutationIndex > | |
CEigen::SkewSymmetricBase< Derived > | Base class for skew symmetric matrices and expressions |
►CEigen::SolverBase< Derived > | A base class for matrix decomposition and solvers |
CEigen::ColPivHouseholderQR< MatrixType, PermutationIndex > | |
CEigen::HouseholderQR< Eigen::Matrix > | |
►CEigen::SVDBase< JacobiSVD< MatrixType_, Options_ > > | |
CEigen::JacobiSVD< MatrixType_, Options_ > | Two-sided Jacobi SVD decomposition of a rectangular matrix |
►CEigen::SVDBase< BDCSVD< MatrixType_, Options_ > > | |
CEigen::BDCSVD< MatrixType_, Options > | |
CEigen::BDCSVD< MatrixType_, Options_ > | Class Bidiagonal Divide and Conquer SVD |
►CEigen::SparseMatrixBase< Derived > | Base class of any sparse matrices or sparse expressions |
►CEigen::SparseCompressedBase< Derived > | Common base class for sparse [compressed]-{row|column}-storage format |
►CEigen::internal::sparse_matrix_block_impl< const SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols > | |
CEigen::BlockImpl< const SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols, true, Sparse > | |
►CEigen::internal::sparse_matrix_block_impl< SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols > | |
CEigen::BlockImpl< SparseMatrix< Scalar_, Options_, StorageIndex_ >, BlockRows, BlockCols, true, Sparse > | |
►CEigen::SparseMapBase< Derived, ReadOnlyAccessors > | Common base class for Map and Ref instance of sparse matrix and vector |
►CEigen::SparseMapBase< Derived, WriteAccessors > | Common base class for writable Map and Ref instance of sparse matrix and vector |
CEigen::Map< SparseMatrixType > | Specialization of class Map for SparseMatrix-like storage |
CEigen::Ref< SparseMatrixType, Options > | A sparse matrix expression referencing an existing sparse expression |
CEigen::Ref< SparseVectorType > | A sparse vector expression referencing an existing sparse vector expression |
CEigen::TriangularBase< Derived > | Base class for triangular part in a matrix |
CEigen::EigenBase< BandMatrix< Scalar_, Rows, Cols, Supers, Subs, Options > > | |
CEigen::EigenBase< BandMatrixWrapper< CoefficientsType_, Rows_, Cols_, Supers_, Subs_, Options_ > > | |
►CEigen::EigenBase< Block< SparseMatrixType, BlockRows, BlockCols, true > > | |
►CEigen::SparseMatrixBase< Block< SparseMatrixType, BlockRows, BlockCols, true > > | |
CEigen::SparseCompressedBase< Block< SparseMatrixType, BlockRows, BlockCols, true > > | |
►CEigen::EigenBase< Block< XprType, BlockRows, BlockCols, InnerPanel > > | |
►CEigen::SparseMatrixBase< Block< XprType, BlockRows, BlockCols, InnerPanel > > | |
CEigen::BlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Sparse > | |
►CEigen::EigenBase< Block< XprType, BlockRows, BlockCols, true > > | |
►CEigen::SparseMatrixBase< Block< XprType, BlockRows, BlockCols, true > > | |
CEigen::BlockImpl< XprType, BlockRows, BlockCols, true, Sparse > | |
►CEigen::EigenBase< CwiseBinaryOp< BinaryOp, Lhs, Rhs > > | |
►CEigen::SparseMatrixBase< CwiseBinaryOp< BinaryOp, Lhs, Rhs > > | |
CEigen::CwiseBinaryOpImpl< BinaryOp, Lhs, Rhs, Sparse > | |
►CEigen::EigenBase< HouseholderSequence< VectorsType, CoeffsType, Side > > | |
CEigen::HouseholderSequence< VectorsType, CoeffsType, Side > | Sequence of Householder reflections acting on subspaces with decreasing size |
►CEigen::EigenBase< Inverse< PermutationType > > | |
CEigen::InverseImpl< PermutationType, PermutationStorage > | |
CEigen::EigenBase< MatrixReplacement > | |
►CEigen::EigenBase< SparseMatrix< double, Options_, StorageIndex_ > > | |
►CEigen::SparseMatrixBase< SparseMatrix< double, Options_, StorageIndex_ > > | |
►CEigen::SparseCompressedBase< SparseMatrix< double, Options_, StorageIndex_ > > | |
CEigen::SparseMatrix< double > | |
►CEigen::EigenBase< SparseMatrix< Scalar, Options_, int > > | |
►CEigen::SparseMatrixBase< SparseMatrix< Scalar, Options_, int > > | |
►CEigen::SparseCompressedBase< SparseMatrix< Scalar, Options_, int > > | |
CEigen::SparseMatrix< Scalar, ColMajor, int > | |
►CEigen::EigenBase< SparseMatrix< Scalar, Options_, StorageIndex > > | |
►CEigen::SparseMatrixBase< SparseMatrix< Scalar, Options_, StorageIndex > > | |
►CEigen::SparseCompressedBase< SparseMatrix< Scalar, Options_, StorageIndex > > | |
CEigen::SparseMatrix< Scalar, ColMajor, StorageIndex > | |
CEigen::SparseMatrix< Scalar, RowMajor, StorageIndex > | |
►CEigen::EigenBase< SparseMatrix< Scalar, Options_, StorageIndex_ > > | |
►CEigen::SparseMatrixBase< SparseMatrix< Scalar, Options_, StorageIndex_ > > | |
►CEigen::SparseCompressedBase< SparseMatrix< Scalar, Options_, StorageIndex_ > > | |
CEigen::SparseMatrix< Scalar > | |
►CEigen::EigenBase< SparseMatrix< Scalar_, Options_, StorageIndex_ > > | |
►CEigen::SparseMatrixBase< SparseMatrix< Scalar_, Options_, StorageIndex_ > > | |
►CEigen::SparseCompressedBase< SparseMatrix< Scalar_, Options_, StorageIndex_ > > | |
CEigen::SparseMatrix< Scalar_, Options_, StorageIndex_ > | A versatible sparse matrix representation |
►CEigen::EigenBase< SparseQRMatrixQReturnType< SparseQRType > > | |
CEigen::SparseQRMatrixQReturnType< SparseQRType > | |
►CEigen::EigenBase< SparseSelfAdjointView< MatrixType, Mode_ > > | |
CEigen::SparseSelfAdjointView< MatrixType, Mode_ > | Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix |
►CEigen::EigenBase< SparseSymmetricPermutationProduct< MatrixType, Mode > > | |
CEigen::SparseSymmetricPermutationProduct< MatrixType, Mode > | |
►CEigen::EigenBase< SparseVector< Scalar_, Options_, StorageIndex_ > > | |
►CEigen::SparseMatrixBase< SparseVector< Scalar_, Options_, StorageIndex_ > > | |
►CEigen::SparseCompressedBase< SparseVector< Scalar_, Options_, StorageIndex_ > > | |
CEigen::SparseVector< Scalar_, Options_, StorageIndex_ > | Sparse vector class |
►CEigen::EigenBase< SparseView< MatrixType > > | |
►CEigen::SparseMatrixBase< SparseView< MatrixType > > | |
CEigen::SparseView< MatrixType > | Expression of a dense or sparse matrix with zero or too small values removed |
►CEigen::EigenBase< Transpose< MatrixType > > | |
►CEigen::SparseMatrixBase< Transpose< MatrixType > > | |
CEigen::SparseCompressedBase< Transpose< MatrixType > > | |
►CEigen::internal::SparseTransposeImpl< MatrixType, CompressedAccess > | |
CEigen::TransposeImpl< MatrixType, Sparse > | |
►CEigen::EigenBase< TriangularView< MatrixType, Mode > > | |
►CEigen::SparseMatrixBase< TriangularView< MatrixType, Mode > > | |
CEigen::TriangularViewImpl< MatrixType, Mode, Sparse > | Base class for a triangular part in a sparse matrix |
CEigen::EigenSolver< MatrixType_ > | Computes eigenvalues and eigenvectors of general matrices |
CEigen::RunQueue< Work, kSize >::Elem | |
CEigen::StlThreadEnvironment::EnvThread | |
CEigen::numext::equal_strict_impl< X, Y, XIsInteger, XIsSigned, YIsInteger, YIsSigned > | |
CEigen::numext::equal_strict_impl< X, Y, true, false, true, true > | |
CEigen::numext::equal_strict_impl< X, Y, true, true, true, false > | |
CEvalIterator | |
CEigen::EventCount | |
CEigen::VectorwiseOp< ExpressionType, Direction >::ExtendedType< OtherDerived > | |
CEigen::half_impl::float32_bits | |
CEigen::general_product_to_triangular_selector< MatrixType, ProductType, UpLo, IsOuterProduct > | |
CEigen::general_product_to_triangular_selector< MatrixType, ProductType, UpLo, false > | |
CEigen::general_product_to_triangular_selector< MatrixType, ProductType, UpLo, true > | |
CEigen::GeneralizedEigenSolver< MatrixType_ > | Computes the generalized eigenvalues and eigenvectors of a pair of general matrices |
►CEigen::GenericNumTraits< T > | |
CEigen::NumTraits< Scalar > | |
CEigen::NumTraits< typename MatrixType::Scalar > | |
CEigen::NumTraits< T > | Holds information about the various numeric (i.e. scalar) types allowed by Eigen |
►CEigen::GenericNumTraits< bool > | |
CEigen::NumTraits< bool > | |
►CEigen::GenericNumTraits< double > | |
CEigen::NumTraits< double > | |
►CEigen::GenericNumTraits< Eigen::bfloat16 > | |
CEigen::NumTraits< Eigen::bfloat16 > | |
►CEigen::GenericNumTraits< Eigen::half > | |
CEigen::NumTraits< Eigen::half > | |
►CEigen::GenericNumTraits< float > | |
CEigen::NumTraits< float > | |
►CEigen::GenericNumTraits< long double > | |
CEigen::NumTraits< long double > | |
►CEigen::GenericNumTraits< std::complex< Real_ > > | |
CEigen::NumTraits< std::complex< Real_ > > | |
►CEigen::GenericNumTraits< std::string > | |
CEigen::NumTraits< std::string > | |
CEigen::numext::get_integer_by_size< Size > | |
CEigen::numext::get_integer_by_size< 1 > | |
CEigen::numext::get_integer_by_size< 2 > | |
CEigen::numext::get_integer_by_size< 4 > | |
CEigen::numext::get_integer_by_size< 8 > | |
CEigen::Serializer< DenseBase< Derived >, void >::Header | |
CEigen::Serializer< SparseMatrix< Scalar, Options, StorageIndex >, void >::Header | |
CEigen::Serializer< SparseVector< Scalar, Options, StorageIndex >, void >::Header | |
CEigen::HessenbergDecomposition< MatrixType_ > | Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation |
CEigen::HessenbergDecomposition< MatrixType > | |
CEigen::HomogeneousShape | |
CEigen::Hyperplane< Scalar_, AmbientDim_, Options_ > | A hyperplane |
CEigen::IdentityPreconditioner | A naive preconditioner which approximates any matrix as the identity matrix |
CEigen::SparseMatrix< Scalar_, Options_, StorageIndex_ >::IndexPosPair | |
CEigen::IOFormat | Stores a set of parameters controlling the way matrices are printed |
CEigen::symbolic::is_symbolic< T > | |
CEigen::JacobiRotation< Scalar > | Rotation given by a cosine-sine pair |
CEigen::IncompleteLUT< Scalar_, StorageIndex_ >::keep_diag | |
CEigen::SimplicialCholeskyBase< Derived >::keep_diag | |
CEigen::LazyProductReturnType< Lhs, Rhs > | |
CLhsIterator | |
CloadColData_impl< RhsMapper, linear > | |
CloadColData_impl< RhsMapper, true > | |
CEigen::VectorwiseOp< ExpressionType, Direction >::LpNormReturnType< p > | |
►CEigen::MapBase< Derived, Level > | |
CEigen::Map< Eigen::SparseMatrix< Scalar, ColMajor, StorageIndex > > | |
►CEigen::RefBase< Ref< const TPlainObjectType, Options, StrideType > > | |
CEigen::Ref< const TPlainObjectType, Options, StrideType > | |
►CEigen::RefBase< Ref< PlainObjectType, Options, StrideType > > | |
CEigen::Ref< PlainObjectType, Options, StrideType > | A matrix or vector expression mapping an existing expression |
►CEigen::RefBase< Derived > | |
CEigen::Ref< const KLUMatrixType, StandardCompressedFormat > | |
CEigen::Ref< const UmfpackMatrixType, StandardCompressedFormat > | |
CEigen::MapBase< Block< XprType, BlockRows, BlockCols, InnerPanel > > | |
►CEigen::MapBase< Map< PlainObjectType, MapOptions, StrideType > > | |
CEigen::Map< PlainObjectType, MapOptions, StrideType > | A matrix or vector expression mapping an existing array of data |
CEigen::MapBase< Reshaped< XprType, Rows, Cols, Order > > | |
CEigen::MatrixComplexPowerReturnValue< Derived > | |
CEigen::MatrixExponentialReturnValue< Derived > | |
CEigen::MatrixFunctionReturnValue< Derived > | |
CEigen::MatrixLogarithmReturnValue< Derived > | |
CEigen::MatrixPowerReturnValue< Derived > | |
CEigen::MatrixSquareRootReturnValue< Derived > | |
CEigen::MatrixXpr | |
CEigen::MaxSizeVector< T > | The MaxSizeVector class |
CEigen::MaxSizeVector< Eigen::EventCount::Waiter > | |
CEigen::MaxSizeVector< Eigen::MaxSizeVector< unsigned > > | |
CEigen::MaxSizeVector< Eigen::ThreadLocal::ThreadIdAndValue > | |
CEigen::MaxSizeVector< Eigen::ThreadPoolTempl::ThreadData > | |
CEigen::MaxSizeVector< std::atomic< Eigen::ThreadLocal::ThreadIdAndValue * > > | |
CEigen::MetisOrdering< StorageIndex > | |
CEigen::NaturalOrdering< StorageIndex > | |
►CEigen::internal::no_assignment_operator | |
CEigen::ReturnByValue< triangular_solve_retval< Side, TriangularType, Rhs > > | |
►CEigen::ReturnByValue< SparseQR_QProduct< SparseQRType, Derived > > | |
CEigen::SparseQR_QProduct< SparseQRType, Derived > | |
CEigen::ReturnByValue< homogeneous_right_product_impl< Homogeneous< MatrixType, Horizontal >, Rhs > > | |
CEigen::ReturnByValue< TridiagonalizationMatrixTReturnType< MatrixType > > | |
CEigen::ReturnByValue< HessenbergDecompositionMatrixHReturnType< MatrixType > > | |
CEigen::ReturnByValue< FullPivHouseholderQRMatrixQReturnType< MatrixType, PermutationIndex > > | |
►CEigen::ReturnByValue< SPQR_QProduct< SPQRType, Derived > > | |
CEigen::SPQR_QProduct< SPQRType, Derived > | |
CEigen::ReturnByValue< image_retval_base< DecompositionType_ > > | |
CEigen::ReturnByValue< kernel_retval_base< DecompositionType_ > > | |
CEigen::ReturnByValue< homogeneous_left_product_impl< Homogeneous< MatrixType, Vertical >, Lhs > > | |
CEigen::BlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Sparse > | |
CEigen::CwiseBinaryOp< BinaryOp, LhsType, RhsType > | Generic expression where a coefficient-wise binary operator is applied to two expressions |
CEigen::CwiseNullaryOp< NullaryOp, PlainObjectType > | Generic expression of a matrix where all coefficients are defined by a functor |
CEigen::CwiseTernaryOp< TernaryOp, Arg1Type, Arg2Type, Arg3Type > | Generic expression where a coefficient-wise ternary operator is applied to two expressions |
CEigen::CwiseUnaryOp< UnaryOp, XprType > | Generic expression where a coefficient-wise unary operator is applied to an expression |
CEigen::DiagonalWrapper< DiagonalVectorType_ > | Expression of a diagonal matrix |
CEigen::Homogeneous< MatrixType, Direction_ > | Expression of one (or a set of) homogeneous vector(s) |
CEigen::PartialReduxExpr< MatrixType, MemberOp, Direction > | Generic expression of a partially reduxed matrix |
CEigen::ReturnByValue< Derived > | |
CEigen::Select< ConditionMatrixType, ThenMatrixType, ElseMatrixType > | Expression of a coefficient wise version of the C++ ternary operator ?: |
CEigen::SkewSymmetricWrapper< SkewSymmetricVectorType_ > | Expression of a skew symmetric matrix |
CEigen::SparseLUMatrixLReturnType< MappedSupernodalType > | |
CEigen::SparseLUMatrixUReturnType< MatrixLType, MatrixUType > | |
CEigen::NoAlias< ExpressionType, StorageBase > | Pseudo expression providing an operator = assuming no aliasing |
►CEigen::internal::noncopyable | |
►CEigen::SparseSolverBase< SimplicialLLT< MatrixType_, UpLo_, Ordering_ > > | |
►CEigen::SimplicialCholeskyBase< SimplicialLLT< MatrixType_, UpLo_, Ordering_ > > | |
CEigen::SimplicialLLT< MatrixType_, UpLo_, Ordering_ > | A direct sparse LLT Cholesky factorizations |
►CEigen::SparseSolverBase< UmfPackLU< MatrixType_ > > | |
CEigen::UmfPackLU< MatrixType_ > | A sparse LU factorization and solver based on UmfPack |
►CEigen::SparseSolverBase< IncompleteCholesky< Scalar, Lower, AMDOrdering< int > > > | |
CEigen::IncompleteCholesky< Scalar, UpLo_, OrderingType_ > | Modified Incomplete Cholesky with dual threshold |
►CEigen::SparseSolverBase< SimplicialCholesky< MatrixType_, UpLo_, Ordering_ > > | |
►CEigen::SimplicialCholeskyBase< SimplicialCholesky< MatrixType_, UpLo_, Ordering_ > > | |
CEigen::SimplicialCholesky< MatrixType_, UpLo_, Ordering_ > | |
►CEigen::SparseSolverBase< KLU< MatrixType_ > > | |
CEigen::KLU< MatrixType_ > | |
►CEigen::SparseSolverBase< SparseLUTransposeView< Conjugate, SparseLUType > > | |
CEigen::SparseLUTransposeView< Conjugate, SparseLUType > | |
►CEigen::SparseSolverBase< IncompleteLUT< Scalar_, int > > | |
CEigen::IncompleteLUT< Scalar_, StorageIndex_ > | Incomplete LU factorization with dual-threshold strategy |
►CEigen::SparseSolverBase< SparseQR< MatrixType_, OrderingType_ > > | |
CEigen::SparseQR< MatrixType_, OrderingType_ > | Sparse left-looking QR factorization with numerical column pivoting |
►CEigen::SparseSolverBase< SPQR< MatrixType_ > > | |
CEigen::SPQR< MatrixType_ > | Sparse QR factorization based on SuiteSparseQR library |
►CEigen::SparseSolverBase< SparseLU< MatrixType_, OrderingType_ > > | |
CEigen::SparseLU< MatrixType_, OrderingType_ > | Sparse supernodal LU factorization for general matrices |
►CEigen::SparseSolverBase< AccelerateImpl< MatrixType_, UpLo_, Solver_, EnforceSquare_ > > | |
CEigen::AccelerateImpl< MatrixType_, UpLo_, Solver_, EnforceSquare_ > | |
►CEigen::SparseSolverBase< SimplicialLDLT< MatrixType_, UpLo_, Ordering_ > > | |
►CEigen::SimplicialCholeskyBase< SimplicialLDLT< MatrixType_, UpLo_, Ordering_ > > | |
CEigen::SimplicialLDLT< MatrixType_, UpLo_, Ordering_ > | A direct sparse LDLT Cholesky factorizations without square root |
►CEigen::SparseSolverBase< Derived > | A base class for sparse solvers |
►CEigen::CholmodBase< MatrixType_, Lower, CholmodSimplicialLLT< MatrixType_, Lower > > | |
CEigen::CholmodSimplicialLLT< MatrixType_, UpLo_ > | A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod |
►CEigen::CholmodBase< MatrixType_, Lower, CholmodDecomposition< MatrixType_, Lower > > | |
CEigen::CholmodDecomposition< MatrixType_, UpLo_ > | A general Cholesky factorization and solver based on Cholmod |
►CEigen::CholmodBase< MatrixType_, Lower, CholmodSimplicialLDLT< MatrixType_, Lower > > | |
CEigen::CholmodSimplicialLDLT< MatrixType_, UpLo_ > | A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod |
►CEigen::CholmodBase< MatrixType_, Lower, CholmodSupernodalLLT< MatrixType_, Lower > > | |
CEigen::CholmodSupernodalLLT< MatrixType_, UpLo_ > | A supernodal Cholesky (LLT) factorization and solver based on Cholmod |
►CEigen::IterativeSolverBase< ConjugateGradient< MatrixType_, UpLo_, Preconditioner_ > > | |
CEigen::ConjugateGradient< MatrixType_, UpLo_, Preconditioner_ > | A conjugate gradient solver for sparse (or dense) self-adjoint problems |
►CEigen::IterativeSolverBase< BiCGSTAB< MatrixType_, Preconditioner_ > > | |
CEigen::BiCGSTAB< MatrixType_, Preconditioner_ > | A bi conjugate gradient stabilized solver for sparse square problems |
►CEigen::IterativeSolverBase< LeastSquaresConjugateGradient< MatrixType_, Preconditioner_ > > | |
CEigen::LeastSquaresConjugateGradient< MatrixType_, Preconditioner_ > | A conjugate gradient solver for sparse (or dense) least-square problems |
►CEigen::PardisoImpl< PardisoLDLT< MatrixType, Options > > | |
CEigen::PardisoLDLT< MatrixType, Options > | A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library |
►CEigen::PardisoImpl< PardisoLLT< MatrixType, UpLo_ > > | |
CEigen::PardisoLLT< MatrixType, UpLo_ > | A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library |
►CEigen::PardisoImpl< PardisoLU< MatrixType > > | |
CEigen::PardisoLU< MatrixType > | A sparse direct LU factorization and solver based on the PARDISO library |
►CEigen::PastixBase< PastixLLT< MatrixType_, UpLo_ > > | |
CEigen::PastixLLT< MatrixType_, UpLo_ > | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
►CEigen::PastixBase< PastixLDLT< MatrixType_, UpLo_ > > | |
CEigen::PastixLDLT< MatrixType_, UpLo_ > | A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library |
►CEigen::PastixBase< PastixLU< MatrixType_ > > | |
CEigen::PastixLU< MatrixType_, IsStrSym > | Interface to the PaStix solver |
►CEigen::SuperLUBase< MatrixType_, SuperILU< MatrixType_ > > | |
CEigen::SuperILU< MatrixType_ > | A sparse direct incomplete LU factorization and solver based on the SuperLU library |
►CEigen::SuperLUBase< MatrixType_, SuperLU< MatrixType_ > > | |
CEigen::SuperLU< MatrixType_ > | A sparse direct LU factorization and solver based on the SuperLU library |
CEigen::CholmodBase< MatrixType_, UpLo_, Derived > | The base class for the direct Cholesky factorization of Cholmod |
CEigen::IterativeSolverBase< Derived > | Base class for linear iterative solvers |
CEigen::PardisoImpl< Derived > | |
CEigen::PastixBase< Derived > | |
CEigen::SimplicialCholeskyBase< Derived > | A base class for direct sparse Cholesky factorizations |
CEigen::SuperLUBase< MatrixType_, Derived > | The base class for the direct and incomplete LU factorization of SuperLU |
►CEigen::bfloat16_impl::numeric_limits_bfloat16_impl< typename > | |
►Cstd::numeric_limits< Eigen::bfloat16 > | |
Cstd::numeric_limits< const Eigen::bfloat16 > | |
Cstd::numeric_limits< const volatile Eigen::bfloat16 > | |
Cstd::numeric_limits< volatile Eigen::bfloat16 > | |
►CEigen::half_impl::numeric_limits_half_impl< typename > | |
►Cstd::numeric_limits< Eigen::half > | |
Cstd::numeric_limits< const Eigen::half > | |
Cstd::numeric_limits< const volatile Eigen::half > | |
Cstd::numeric_limits< volatile Eigen::half > | |
CEigen::NumTraits< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
CEigen::NumTraits< void > | |
CEigen::VectorwiseOp< ExpressionType, Direction >::OppositeExtendedType< OtherDerived > | |
CEigen::ParametrizedLine< Scalar_, AmbientDim_, Options_ > | A parametrized line |
CEigen::partial_redux_dummy_func< A, B > | |
CEigen::PermutationShape | |
CEigen::PermutationStorage | |
CEigen::ThreadPoolTempl< Environment >::PerThread | |
CEigen::Array< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ >::PrivateType | |
CEigen::ProductReturnType< Lhs, Rhs, ProductType > | |
CEigen::RealQZ< MatrixType_ > | Performs a real QZ decomposition of a pair of square matrices |
CEigen::RealQZ< MatrixType > | |
CEigen::RealSchur< MatrixType_ > | Performs a real Schur decomposition of a square matrix |
CEigen::RealSchur< MatrixType > | |
CEigen::aligned_allocator< T >::rebind< U > | |
CEigen::aligned_allocator_indirection< T >::rebind< U > | |
CEigen::VectorwiseOp< ExpressionType, Direction >::ReduxReturnType< BinaryOp > | |
CEigen::ReshapedImpl< XprType, Rows, Cols, Order, StorageKind > | |
►CEigen::ReshapedImpl< XprType, Rows, Cols, Order, internal::traits< XprType >::StorageKind > | |
CEigen::Reshaped< XprType, Rows, Cols, Order > | Expression of a fixed-size or dynamic-size reshape |
►CEigen::internal::ReshapedImpl_dense< XprType, Rows, Cols, Order, internal::traits< Reshaped< XprType, Rows, Cols, Order > >::HasDirectAccess > | |
CEigen::ReshapedImpl< XprType, Rows, Cols, Order, Dense > | |
CEigen::VectorwiseOp< ExpressionType, Direction >::ReturnType< Functor, ReturnScalar > | |
Calpha_store< PResPacket, ResPacket, ResScalar, Scalar >::ri | |
►CEigen::RotationBase< Derived, Dim_ > | Common base class for compact rotation representations |
►CEigen::QuaternionBase< Quaternion< Scalar_, Options_ > > | |
CEigen::Quaternion< Scalar_, Options_ > | The quaternion class used to represent 3D orientations and rotations |
►CEigen::QuaternionBase< Map< const Quaternion< Scalar_ >, Options_ > > | |
CEigen::Map< const Quaternion< Scalar_ >, Options_ > | Quaternion expression mapping a constant memory buffer |
►CEigen::QuaternionBase< Map< Quaternion< Scalar_ >, Options_ > > | |
CEigen::Map< Quaternion< Scalar_ >, Options_ > | Expression of a quaternion from a memory buffer |
►CEigen::RotationBase< AngleAxis< Scalar_ >, 3 > | |
CEigen::AngleAxis< Scalar_ > | Represents a 3D rotation as a rotation angle around an arbitrary 3D axis |
►CEigen::RotationBase< Derived, 3 > | |
CEigen::QuaternionBase< Derived > | Base class for quaternion expressions |
►CEigen::RotationBase< Rotation2D< Scalar_ >, 2 > | |
CEigen::Rotation2D< Scalar_ > | Represents a rotation/orientation in a 2 dimensional space |
CEigen::RunQueue< Work, kSize > | |
CEigen::RunQueue< Task, 1024 > | |
CEigen::ScalarBinaryOpTraits< ScalarA, ScalarB, BinaryOp > | Determines whether the given binary operation of two numeric types is allowed and what the scalar return type is |
CEigen::ScalarBinaryOpTraits< T, T, BinaryOp > | |
CEigen::ScalarBinaryOpTraits< T, typename NumTraits< std::enable_if_t< NumTraits< T >::IsComplex, T > >::Real, BinaryOp > | |
CEigen::ScalarBinaryOpTraits< T, void, BinaryOp > | |
CEigen::ScalarBinaryOpTraits< typename NumTraits< std::enable_if_t< NumTraits< T >::IsComplex, T > >::Real, T, BinaryOp > | |
CEigen::ScalarBinaryOpTraits< void, T, BinaryOp > | |
CEigen::ScalarBinaryOpTraits< void, void, BinaryOp > | |
CScalarBlock< Scalar, N > | |
CEigen::selfadjoint_product_selector< MatrixType, OtherType, UpLo, OtherIsVector > | |
CEigen::selfadjoint_product_selector< MatrixType, OtherType, UpLo, false > | |
CEigen::selfadjoint_product_selector< MatrixType, OtherType, UpLo, true > | |
CEigen::selfadjoint_rank1_update< Scalar, Index, StorageOrder, UpLo, ConjLhs, ConjRhs > | |
CEigen::selfadjoint_rank1_update< Scalar, Index, ColMajor, UpLo, ConjLhs, ConjRhs > | |
CEigen::selfadjoint_rank1_update< Scalar, Index, RowMajor, UpLo, ConjLhs, ConjRhs > | |
►CEigen::SelfAdjointEigenSolver< MatrixType_ > | Computes eigenvalues and eigenvectors of selfadjoint matrices |
CEigen::GeneralizedSelfAdjointEigenSolver< MatrixType_ > | Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem |
CEigen::SelfAdjointShape | |
CEigen::MatrixBase< Derived >::SelfAdjointViewReturnType< UpLo > | |
CEigen::SparseMatrixBase< Derived >::SelfAdjointViewReturnType< UpLo > | |
CEigen::Serializer< T, EnableIf > | |
►CEigen::Serializer< DenseBase< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > > | |
CEigen::Serializer< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
CEigen::Serializer< DenseBase< Derived >, void > | |
►CEigen::Serializer< DenseBase< Matrix< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > > | |
CEigen::Serializer< Matrix< Scalar, Rows, Cols, Options, MaxRows, MaxCols > > | |
CEigen::Serializer< SparseMatrix< Scalar, Options, StorageIndex >, void > | |
CEigen::Serializer< SparseVector< Scalar, Options, StorageIndex >, void > | |
CEigen::Serializer< T, typename std::enable_if_t< std::is_trivial< T >::value &&std::is_standard_layout< T >::value > > | |
CShiftLeftXpr< N > | |
CShiftRightXpr< N > | |
CEigen::numext::signbit_impl< Scalar, IsInteger, IsSigned > | |
CEigen::numext::signbit_impl< Scalar, false, true > | |
CEigen::numext::signbit_impl< Scalar, true, false > | |
CEigen::numext::signbit_impl< Scalar, true, true > | |
CEigen::SparseMatrix< Scalar_, Options_, StorageIndex_ >::SingletonVector | |
CEigen::SkewSymmetricShape | |
CEigen::SluMatrixMapHelper< MatrixType > | |
CEigen::SluMatrixMapHelper< Matrix< Scalar, Rows, Cols, Options, MRows, MCols > > | |
CEigen::SluMatrixMapHelper< SparseMatrixBase< Derived > > | |
CEigen::SolverShape | |
CEigen::SolverStorage | |
CEigen::Sparse | |
CEigen::SparseDenseOuterProduct< Lhs, Rhs, Transpose > | |
CEigen::SparseDenseProductReturnType< Lhs, Rhs, InnerSize > | |
CEigen::SparseDiagonalProduct< Lhs, Rhs > | |
CSparseLUImpl< Scalar, StorageIndex > | |
►CEigen::internal::SparseLUImpl< MatrixType_::Scalar, MatrixType_::StorageIndex > | |
CEigen::SparseLU< MatrixType_, OrderingType_ > | Sparse supernodal LU factorization for general matrices |
►CEigen::SparseMapBase< Derived, Level > | |
►CEigen::internal::SparseRefBase< Ref< const SparseMatrix< MatScalar, MatOptions, MatIndex >, Options, StrideType > > | |
CEigen::Ref< const SparseMatrix< MatScalar, MatOptions, MatIndex >, Options, StrideType > | |
►CEigen::internal::SparseRefBase< Ref< const SparseVector< MatScalar, MatOptions, MatIndex >, Options, StrideType > > | |
CEigen::Ref< const SparseVector< MatScalar, MatOptions, MatIndex >, Options, StrideType > | |
CEigen::SparseQRMatrixQTransposeReturnType< SparseQRType > | |
CEigen::SparseShape | |
CEigen::SparseSparseProduct< Lhs, Rhs > | |
CEigen::SparseSparseProductReturnType< Lhs, Rhs > | |
CEigen::SparseTimeDenseProduct< Lhs, Rhs > | |
CEigen::SPQRMatrixQReturnType< SPQRType > | |
CEigen::SPQRMatrixQTransposeReturnType< SPQRType > | |
CEigen::StlThreadEnvironment | |
CEigen::Stride< OuterStrideAtCompileTime_, InnerStrideAtCompileTime_ > | Holds strides information for Map |
►CEigen::Stride< 0, Value > | |
CEigen::InnerStride< Value > | Convenience specialization of Stride to specify only an inner stride See class Map for some examples |
CEigen::Stride< StrideType::OuterStrideAtCompileTime, StrideType::InnerStrideAtCompileTime > | |
►CEigen::Stride< Value, 0 > | |
CEigen::OuterStride< Value > | Convenience specialization of Stride to specify only an outer stride See class Map for some examples |
CEigen::PlainObjectBase< Derived >::StridedAlignedMapType< StrideType > | |
CEigen::PlainObjectBase< Derived >::StridedConstAlignedMapType< StrideType > | |
CEigen::PlainObjectBase< Derived >::StridedConstMapType< StrideType > | |
CEigen::PlainObjectBase< Derived >::StridedMapType< StrideType > | |
CEigen::SwapWrapper< ExpressionType > | |
CEigen::symbolic::Symbol< Tag > | |
CEigen::symbolic::SymbolValue< Tag > | |
Ctake | |
CEigen::StlThreadEnvironment::Task | |
CEigen::ThreadPoolTempl< Environment >::ThreadData | |
CEigen::ThreadLocal< T, Initialize, Release >::ThreadIdAndValue | |
CEigen::ThreadLocal< T, Initialize, Release > | |
►CEigen::ThreadPoolInterface | |
CEigen::ThreadPoolTempl< Environment > | |
CEigen::Transform< Scalar_, Dim_, Mode_, Options_ > | Represents an homogeneous transformation in a N dimensional space |
CEigen::Translation< Scalar_, Dim_ > | Represents a translation transformation |
CEigen::Transpose< TranspositionsBase< TranspositionsDerived > > | |
►CEigen::TranspositionsBase< Derived > | |
CEigen::Transpositions< RowsAtCompileTime, MaxRowsAtCompileTime, PermutationIndex > | |
►CEigen::TranspositionsBase< Map< Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess > > | |
CEigen::Map< Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ >, PacketAccess > | |
►CEigen::TranspositionsBase< Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ > > | |
CEigen::Transpositions< RowsAtCompileTime, MaxRowsAtCompileTime > | |
CEigen::Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, StorageIndex_ > | Represents a sequence of transpositions (row/column interchange) |
►CEigen::TranspositionsBase< TranspositionsWrapper< IndicesType_ > > | |
CEigen::TranspositionsWrapper< IndicesType_ > | |
CEigen::TranspositionsShape | |
CEigen::TranspositionsStorage | |
CEigen::TriangularShape | |
CEigen::TriangularViewImpl< MatrixType_, Mode_, StorageKind > | |
►CEigen::TriangularViewImpl< MatrixType_, Mode_, internal::traits< MatrixType_ >::StorageKind > | |
CEigen::TriangularView< MatrixType_, Mode_ > | Expression of a triangular part in a matrix |
CEigen::MatrixBase< Derived >::TriangularViewReturnType< Mode > | |
CEigen::Tridiagonalization< MatrixType_ > | Tridiagonal decomposition of a selfadjoint matrix |
CEigen::Triplet< Scalar, StorageIndex > | A small structure to hold a non zero as a triplet (i,j,value) |
CEigen::Triplet< double > | |
►Cinternal::dense_xpr_base::type | |
►CEigen::internal::BlockImpl_dense< XprType, BlockRows, BlockCols, InnerPanel > | |
CEigen::BlockImpl< XprType, BlockRows, BlockCols, InnerPanel, Dense > | |
►Cinternal::dense_xpr_base::type | |
CEigen::CwiseNullaryOp< NullaryOp, PlainObjectType > | Generic expression of a matrix where all coefficients are defined by a functor |
►Cinternal::dense_xpr_base::type | |
CEigen::CwiseUnaryViewImpl< ViewOp, MatrixType, StrideType, Dense > | |
►Cinternal::dense_xpr_base::type | |
►CEigen::MapBase< Derived, ReadOnlyAccessors > | Base class for dense Map and Block expression with direct access |
CEigen::MapBase< Derived, WriteAccessors > | Base class for non-const dense Map and Block expression with direct access |
►Cinternal::dense_xpr_base::type | |
CEigen::Diagonal< MatrixType, DiagIndex_ > | Expression of a diagonal/subdiagonal/superdiagonal in a matrix |
►Cinternal::dense_xpr_base::type | |
CEigen::ForceAlignedAccess< ExpressionType > | Enforce aligned packet loads and stores regardless of what is requested |
►Cinternal::dense_xpr_base::type | |
CEigen::NestByValue< ExpressionType > | Expression which must be nested by value |
►Cinternal::dense_xpr_base::type | |
CEigen::PartialReduxExpr< MatrixType, MemberOp, Direction > | Generic expression of a partially reduxed matrix |
►Cinternal::dense_xpr_base::type | |
►CEigen::internal::dense_product_base< Lhs, Rhs, Option, ProductTag > | |
CEigen::ProductImpl< Lhs, Rhs, Option, Dense > | |
►Cinternal::dense_xpr_base::type | |
CEigen::Replicate< MatrixType, RowFactor, ColFactor > | Expression of the multiple replication of a matrix or vector |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< Derived > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< FullPivHouseholderQRMatrixQReturnType< MatrixType, PermutationIndex > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< HessenbergDecompositionMatrixHReturnType< MatrixType > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< homogeneous_left_product_impl< Homogeneous< MatrixType, Vertical >, Lhs > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< homogeneous_right_product_impl< Homogeneous< MatrixType, Horizontal >, Rhs > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< image_retval_base< DecompositionType_ > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< kernel_retval_base< DecompositionType_ > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< SparseQR_QProduct< SparseQRType, Derived > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< SPQR_QProduct< SPQRType, Derived > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< triangular_solve_retval< Side, TriangularType, Rhs > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::ReturnByValue< TridiagonalizationMatrixTReturnType< MatrixType > > | |
►Cinternal::dense_xpr_base::type | |
CEigen::Reverse< MatrixType, Direction > | Expression of the reverse of a vector or matrix |
►Cinternal::dense_xpr_base::type | |
CEigen::Select< ConditionMatrixType, ThenMatrixType, ElseMatrixType > | Expression of a coefficient wise version of the C++ ternary operator ?: |
►Cinternal::generic_xpr_base::type | |
CEigen::CwiseBinaryOpImpl< BinaryOp, Lhs, Rhs, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::CwiseBinaryOpImpl< BinaryOp, LhsType, RhsType, internal::cwise_promote_storage_type< internal::traits< LhsType >::StorageKind, internal::traits< RhsType >::StorageKind, BinaryOp >::ret > | |
CEigen::CwiseBinaryOp< BinaryOp, LhsType, RhsType > | Generic expression where a coefficient-wise binary operator is applied to two expressions |
►Cinternal::generic_xpr_base::type | |
CEigen::CwiseTernaryOpImpl< TernaryOp, Arg1, Arg2, Arg3, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::CwiseTernaryOpImpl< TernaryOp, Arg1Type, Arg2Type, Arg3Type, internal::traits< Arg1Type >::StorageKind > | |
CEigen::CwiseTernaryOp< TernaryOp, Arg1Type, Arg2Type, Arg3Type > | Generic expression where a coefficient-wise ternary operator is applied to two expressions |
►Cinternal::generic_xpr_base::type | |
►CEigen::CwiseUnaryOpImpl< UnaryOp, XprType, internal::traits< XprType >::StorageKind > | |
CEigen::CwiseUnaryOp< UnaryOp, XprType > | Generic expression where a coefficient-wise unary operator is applied to an expression |
CEigen::CwiseUnaryOpImpl< UnaryOp, XprType, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::CwiseUnaryViewImpl< ViewOp, MatrixType, StrideType, internal::traits< MatrixType >::StorageKind > | |
CEigen::CwiseUnaryView< ViewOp, MatrixType, StrideType > | Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector |
►Cinternal::generic_xpr_base::type | |
CEigen::CwiseUnaryViewImpl< ViewOp, XprType, StrideType, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::IndexedViewImpl< XprType, RowIndices, ColIndices, internal::traits< XprType >::StorageKind > | |
CEigen::IndexedView< XprType, RowIndices, ColIndices > | Expression of a non-sequential sub-matrix defined by arbitrary sequences of row and column indices |
CEigen::IndexedViewImpl< XprType, RowIndices, ColIndices, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::InverseImpl< XprType, internal::traits< XprType >::StorageKind > | |
CEigen::Inverse< XprType > | Expression of the inverse of another expression |
CEigen::InverseImpl< XprType, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
CEigen::ProductImpl< Lhs, Rhs, Option, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
►CEigen::ProductImpl< Lhs_, Rhs_, Option, internal::product_promote_storage_type< internal::traits< Lhs_ >::StorageKind, internal::traits< Rhs_ >::StorageKind, internal::product_type< Lhs_, Rhs_ >::ret >::ret > | |
CEigen::Product< Lhs_, Rhs_, Option > | Expression of the product of two arbitrary matrices or vectors |
►Cinternal::generic_xpr_base::type | |
►CEigen::SolveImpl< Decomposition, RhsType, internal::traits< RhsType >::StorageKind > | |
CEigen::Solve< Decomposition, RhsType > | Pseudo expression representing a solving operation |
►Cinternal::generic_xpr_base::type | |
CEigen::SolveImpl< Decomposition, RhsType, StorageKind > | |
►Cinternal::generic_xpr_base::type | |
CEigen::SolveWithGuess< Decomposition, RhsType, GuessType > | Pseudo expression representing a solving operation |
►Cinternal::generic_xpr_base::type | |
►CEigen::TransposeImpl< MatrixType, internal::traits< MatrixType >::StorageKind > | |
CEigen::Transpose< MatrixType > | Expression of the transpose of a matrix |
►Cinternal::generic_xpr_base::type | |
CEigen::TransposeImpl< XprType, StorageKind > | |
►Cinternal::TransposeImpl_base::type | |
CEigen::TransposeImpl< MatrixType, Dense > | |
CEigen::UniformScaling< Scalar_ > | Represents a generic uniform scaling transformation |
CEigen::symbolic::ValueExpr< IndexType > | |
CEigen::VectorwiseOp< ExpressionType, Direction > | Pseudo expression providing broadcasting and partial reduction operations |
CEigen::EventCount::Waiter | |
CEigen::WithFormat< ExpressionType > | Pseudo expression providing matrix output with given format |
Cbool | |
►CSuperMatrix | |
CEigen::SluMatrix | |