|
struct | Eigen::internal::accessors_level< Derived > |
|
class | Eigen::AlignedBox |
| An axis aligned box. More...
|
|
class | Eigen::AngleAxis |
| Represents a 3D rotation as a rotation angle around an arbitrary 3D axis. More...
|
|
class | Eigen::Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > |
| General-purpose arrays with easy API for coefficient-wise operations. More...
|
|
class | Eigen::ArrayBase< Derived > |
| Base class for all 1D and 2D array, and related expressions. More...
|
|
class | Eigen::ArrayWrapper< ExpressionType > |
| Expression of a mathematical vector or matrix as an array object. More...
|
|
class | Eigen::internal::BandMatrix< _Scalar, Rows, Cols, Supers, Subs, Options > |
| Represents a rectangular matrix with a banded storage. More...
|
|
class | Eigen::BDCSVD |
| class Bidiagonal Divide and Conquer SVD More...
|
|
class | Eigen::Block< XprType, BlockRows, BlockCols, InnerPanel > |
| Expression of a fixed-size or dynamic-size block. More...
|
|
class | Eigen::ColPivHouseholderQR |
| Householder rank-revealing QR decomposition of a matrix with column-pivoting. More...
|
|
class | Eigen::CommaInitializer< XprType > |
| Helper class used by the comma initializer operator. More...
|
|
class | Eigen::CompleteOrthogonalDecomposition |
| Complete orthogonal decomposition (COD) of a matrix. More...
|
|
struct | Eigen::internal::conj_helper< LhsType, RhsType, ConjLhs, ConjRhs > |
|
class | Eigen::Conjugate< MatrixType > |
|
class | Eigen::Cross< Lhs, Rhs > |
|
class | Eigen::CwiseBinaryOp< BinaryOp, LhsType, RhsType > |
| Generic expression where a coefficient-wise binary operator is applied to two expressions. More...
|
|
class | Eigen::CwiseNullaryOp< NullaryOp, PlainObjectType > |
| Generic expression of a matrix where all coefficients are defined by a functor. More...
|
|
class | Eigen::CwiseTernaryOp< TernaryOp, Arg1Type, Arg2Type, Arg3Type > |
| Generic expression where a coefficient-wise ternary operator is applied to two expressions. More...
|
|
class | Eigen::CwiseUnaryOp< UnaryOp, XprType > |
| Generic expression where a coefficient-wise unary operator is applied to an expression. More...
|
|
class | Eigen::CwiseUnaryView< ViewOp, MatrixType > |
| Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector. More...
|
|
class | Eigen::DenseBase< Derived > |
| Base class for all dense matrices, vectors, and arrays. More...
|
|
class | Eigen::DenseCoeffsBase< Derived, Level > |
|
class | Eigen::Diagonal< MatrixType, _DiagIndex > |
| Expression of a diagonal/subdiagonal/superdiagonal in a matrix. More...
|
|
class | Eigen::DiagonalBase< Derived > |
|
class | Eigen::DiagonalMatrix< _Scalar, SizeAtCompileTime, MaxSizeAtCompileTime > |
| Represents a diagonal matrix with its storage. More...
|
|
class | Eigen::DiagonalProduct< MatrixType, DiagonalType, ProductOrder > |
|
class | Eigen::DiagonalWrapper< _DiagonalVectorType > |
| Expression of a diagonal matrix. More...
|
|
class | Eigen::EigenBase< Derived > |
|
struct | Eigen::internal::EnableIf< bool > |
|
struct | Eigen::internal::evaluator< T > |
|
struct | Eigen::internal::evaluator_traits< T > |
|
class | Eigen::Flagged< ExpressionType, Added, Removed > |
|
class | Eigen::ForceAlignedAccess< ExpressionType > |
| Enforce aligned packet loads and stores regardless of what is requested. More...
|
|
class | Eigen::FullPivHouseholderQR |
| Householder rank-revealing QR decomposition of a matrix with full pivoting. More...
|
|
class | Eigen::FullPivLU |
| LU decomposition of a matrix with complete pivoting, and related features. More...
|
|
class | Eigen::internal::generic_randaccess_stl_iterator< XprType > |
|
struct | Eigen::internal::has_direct_access< Derived > |
|
class | Eigen::Homogeneous |
| Expression of one (or a set of) homogeneous vector(s) More...
|
|
class | Eigen::HouseholderQR |
| Householder QR decomposition of a matrix. More...
|
|
class | Eigen::HouseholderSequence |
| Sequence of Householder reflections acting on subspaces with decreasing size. More...
|
|
class | Eigen::Hyperplane |
| A hyperplane. More...
|
|
struct | Eigen::internal::image_retval< DecompositionType > |
|
class | Eigen::internal::image_retval_base |
|
class | Eigen::IndexedView< XprType, RowIndices, ColIndices > |
| Expression of a non-sequential sub-matrix defined by arbitrary sequences of row and column indices. More...
|
|
class | Eigen::InnerIterator< XprType > |
| An InnerIterator allows to loop over the element of any matrix expression. More...
|
|
class | Eigen::InnerStride< Value > |
| Convenience specialization of Stride to specify only an inner stride See class Map for some examples. More...
|
|
class | Eigen::Inverse< XprType > |
| Expression of the inverse of another expression. More...
|
|
struct | Eigen::internal::inverse_impl< MatrixType > |
|
class | Eigen::JacobiRotation |
| Rotation given by a cosine-sine pair. More...
|
|
class | Eigen::JacobiSVD |
| Two-sided Jacobi SVD decomposition of a rectangular matrix. More...
|
|
struct | Eigen::internal::kernel_retval< DecompositionType > |
|
class | Eigen::internal::kernel_retval_base |
|
struct | Eigen::LazyProductReturnType< Lhs, Rhs > |
|
class | Eigen::LDLT< _MatrixType, _UpLo > |
| Robust Cholesky decomposition of a matrix with pivoting. More...
|
|
class | Eigen::LLT< _MatrixType, _UpLo > |
| Standard Cholesky decomposition (LL^T) of a matrix and associated features. More...
|
|
class | Eigen::Map< PlainObjectType, MapOptions, StrideType > |
| A matrix or vector expression mapping an existing array of data. More...
|
|
class | Eigen::MapBase< Derived, Level > |
|
class | Eigen::Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > |
| The matrix class, also used for vectors and row-vectors. More...
|
|
class | Eigen::MatrixBase< Derived > |
| Base class for all dense matrices, vectors, and expressions. More...
|
|
class | Eigen::MatrixComplexPowerReturnValue< Derived > |
| Proxy for the matrix power of some matrix (expression). More...
|
|
struct | Eigen::MatrixExponentialReturnValue< Derived > |
| Proxy for the matrix exponential of some matrix (expression). More...
|
|
class | Eigen::MatrixFunctionReturnValue< Derived > |
| Proxy for the matrix function of some matrix (expression). More...
|
|
class | Eigen::MatrixLogarithmReturnValue< Derived > |
| Proxy for the matrix logarithm of some matrix (expression). More...
|
|
class | Eigen::MatrixPowerReturnValue< Derived > |
| Proxy for the matrix power of some matrix (expression). More...
|
|
class | Eigen::MatrixSquareRootReturnValue< Derived > |
| Proxy for the matrix square root of some matrix (expression). More...
|
|
class | Eigen::MatrixWrapper |
| Expression of an array as a mathematical vector or matrix. More...
|
|
class | Eigen::NestByValue< ExpressionType > |
| Expression which must be nested by value. More...
|
|
class | Eigen::NoAlias< ExpressionType, StorageBase > |
| Pseudo expression providing an operator = assuming no aliasing. More...
|
|
class | Eigen::NumTraits< T > |
| Holds information about the various numeric (i.e. scalar) types allowed by Eigen. More...
|
|
class | Eigen::OuterStride< Value > |
| Convenience specialization of Stride to specify only an outer stride See class Map for some examples. More...
|
|
class | Eigen::ParametrizedLine |
| A parametrized line. More...
|
|
class | Eigen::PartialPivLU |
| LU decomposition of a matrix with partial pivoting, and related features. More...
|
|
class | Eigen::PartialReduxExpr |
| Generic expression of a partially reduxed matrix. More...
|
|
class | Eigen::PermutationBase< Derived > |
| Base class for permutations. More...
|
|
class | Eigen::PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, _StorageIndex > |
| Permutation matrix. More...
|
|
class | Eigen::PermutationWrapper< _IndicesType > |
| Class to view a vector of integers as a permutation matrix. More...
|
|
class | Eigen::PlainObjectBase< Derived > |
|
class | Eigen::internal::pointer_based_stl_iterator< XprType > |
|
class | Eigen::Product< _Lhs, _Rhs, Option > |
| Expression of the product of two arbitrary matrices or vectors. More...
|
|
struct | Eigen::internal::product_evaluator< T, ProductTag, LhsShape, RhsShape, LhsScalar, RhsScalar > |
|
struct | Eigen::internal::product_type< Lhs, Rhs > |
|
struct | Eigen::ProductReturnType< Lhs, Rhs, ProductType > |
|
class | Eigen::Quaternion |
| The quaternion class used to represent 3D orientations and rotations. More...
|
|
class | Eigen::QuaternionBase |
| Base class for quaternion expressions. More...
|
|
class | Eigen::Ref< PlainObjectType, Options, StrideType > |
| A matrix or vector expression mapping an existing expression. More...
|
|
class | Eigen::RefBase< Derived > |
|
class | Eigen::Replicate< MatrixType, RowFactor, ColFactor > |
| Expression of the multiple replication of a matrix or vector. More...
|
|
class | Eigen::Reshaped< XprType, Rows, Cols, Order > |
| Expression of a fixed-size or dynamic-size reshape. More...
|
|
class | Eigen::ReturnByValue< Derived > |
|
class | Eigen::Reverse< MatrixType, Direction > |
| Expression of the reverse of a vector or matrix. More...
|
|
class | Eigen::Rotation2D |
| Represents a rotation/orientation in a 2 dimensional space. More...
|
|
class | Eigen::RotationBase |
| Common base class for compact rotation representations. More...
|
|
struct | Eigen::internal::scalar_abs2_op< Scalar > |
|
struct | Eigen::internal::scalar_abs_op< Scalar > |
|
struct | Eigen::internal::scalar_absolute_difference_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_acos_op< Scalar > |
|
struct | Eigen::internal::scalar_asin_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_i0_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_i0e_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_i1_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_i1e_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_j0_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_j1_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_k0_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_k0e_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_k1_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_k1e_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_y0_op< Scalar > |
|
struct | Eigen::internal::scalar_bessel_y1_op< Scalar > |
|
struct | Eigen::internal::scalar_betainc_op< Scalar > |
|
struct | Eigen::internal::scalar_cast_op< Scalar, NewType > |
|
struct | Eigen::internal::scalar_conj_product_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_conjugate_op< Scalar > |
|
struct | Eigen::internal::scalar_constant_op< Scalar > |
|
struct | Eigen::internal::scalar_cos_op< Scalar > |
|
struct | Eigen::internal::scalar_cube_op< Scalar > |
|
struct | Eigen::internal::scalar_difference_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_digamma_op< Scalar > |
|
struct | Eigen::internal::scalar_erf_op< Scalar > |
|
struct | Eigen::internal::scalar_erfc_op< Scalar > |
|
struct | Eigen::internal::scalar_exp_op< Scalar > |
|
struct | Eigen::internal::scalar_hypot_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_identity_op< Scalar > |
|
struct | Eigen::internal::scalar_igamma_op< Scalar > |
|
struct | Eigen::internal::scalar_igammac_op< Scalar > |
|
struct | Eigen::internal::scalar_imag_op< Scalar > |
|
struct | Eigen::internal::scalar_inverse_op< Scalar > |
|
struct | Eigen::internal::scalar_lgamma_op< Scalar > |
|
struct | Eigen::internal::scalar_log_op< Scalar > |
|
struct | Eigen::internal::scalar_max_op< LhsScalar, RhsScalar, NaNPropagation > |
|
struct | Eigen::internal::scalar_min_op< LhsScalar, RhsScalar, NaNPropagation > |
|
struct | Eigen::internal::scalar_ndtri_op< Scalar > |
|
struct | Eigen::internal::scalar_opposite_op< Scalar > |
|
struct | Eigen::internal::scalar_pow_op< Scalar, Exponent > |
|
struct | Eigen::internal::scalar_product_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_quotient_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_random_op< Scalar > |
|
struct | Eigen::internal::scalar_real_op< Scalar > |
|
struct | Eigen::internal::scalar_rsqrt_op< Scalar > |
|
struct | Eigen::internal::scalar_sign_op< Scalar, is_complex, is_integer > |
|
struct | Eigen::internal::scalar_sin_op< Scalar > |
|
struct | Eigen::internal::scalar_sqrt_op< Scalar > |
|
struct | Eigen::internal::scalar_square_op< Scalar > |
|
struct | Eigen::internal::scalar_sum_op< LhsScalar, RhsScalar > |
|
struct | Eigen::internal::scalar_tan_op< Scalar > |
|
struct | Eigen::internal::scalar_zeta_op< Scalar > |
|
class | Eigen::Select< ConditionMatrixType, ThenMatrixType, ElseMatrixType > |
| Expression of a coefficient wise version of the C++ ternary operator ?: More...
|
|
class | Eigen::SelfAdjointView< _MatrixType, UpLo > |
| Expression of a selfadjoint matrix from a triangular part of a dense matrix. More...
|
|
class | Eigen::Solve< Decomposition, RhsType > |
| Pseudo expression representing a solving operation. More...
|
|
class | Eigen::SolverBase< Derived > |
| A base class for matrix decomposition and solvers. More...
|
|
class | Eigen::SparseMatrixBase |
| Base class of any sparse matrices or sparse expressions. More...
|
|
class | Eigen::SparseView |
| Expression of a dense or sparse matrix with zero or too small values removed. More...
|
|
struct | Eigen::internal::stem_function< Scalar > |
|
class | Eigen::Stride< _OuterStrideAtCompileTime, _InnerStrideAtCompileTime > |
| Holds strides information for Map. More...
|
|
class | Eigen::internal::subvector_stl_iterator< XprType, Direction > |
|
class | Eigen::internal::subvector_stl_reverse_iterator< XprType, Direction > |
|
class | Eigen::SVDBase |
| Base class of SVD algorithms. More...
|
|
class | Eigen::SwapWrapper< ExpressionType > |
|
struct | Eigen::internal::traits< T > |
|
struct | Eigen::internal::traits< const T > |
|
class | Eigen::Transform |
| Represents an homogeneous transformation in a N dimensional space. More...
|
|
class | Eigen::Translation |
| Represents a translation transformation. More...
|
|
class | Eigen::Transpose< MatrixType > |
| Expression of the transpose of a matrix. More...
|
|
class | Eigen::Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, _StorageIndex > |
| Represents a sequence of transpositions (row/column interchange) More...
|
|
class | Eigen::TranspositionsBase< Derived > |
|
class | Eigen::TranspositionsWrapper< _IndicesType > |
|
class | Eigen::TriangularBase< Derived > |
| Base class for triangular part in a matrix. More...
|
|
class | Eigen::TriangularView< _MatrixType, _Mode > |
| Expression of a triangular part in a matrix. More...
|
|
class | Eigen::UniformScaling |
| Represents a generic uniform scaling transformation. More...
|
|
class | Eigen::VectorBlock |
| Expression of a fixed-size or dynamic-size sub-vector. More...
|
|
class | Eigen::VectorwiseOp |
| Pseudo expression providing broadcasting and partial reduction operations. More...
|
|
class | Eigen::WithFormat< ExpressionType > |
| Pseudo expression providing matrix output with given format. More...
|
|