Namespace containing all symbols from the Eigen library. More...
Namespaces | |
namespace | internal |
Classes | |
class | aligned_allocator |
STL compatible allocator to use with with 16 byte aligned types. More... | |
class | AlignedBox |
An axis aligned box. More... | |
class | AlignedVector3 |
class | AngleAxis |
Represents a 3D rotation as a rotation angle around an arbitrary 3D axis. More... | |
class | Array |
General-purpose arrays with easy API for coefficient-wise operations. More... | |
class | ArrayBase |
Base class for all 1D and 2D array, and related expressions. More... | |
class | ArrayWrapper |
Expression of a mathematical vector or matrix as an array object. More... | |
struct | ArrayXpr |
class | Block |
Expression of a fixed-size or dynamic-size block. More... | |
class | CholmodDecomposition |
class | ColPivHouseholderQR |
Householder rank-revealing QR decomposition of a matrix with column-pivoting. More... | |
class | CommaInitializer |
Helper class used by the comma initializer operator. More... | |
class | ComplexEigenSolver |
Computes eigenvalues and eigenvectors of general complex matrices. More... | |
class | ComplexSchur |
Performs a complex Schur decomposition of a real or complex square matrix. More... | |
class | CompressedStorage |
class | Cwise |
Pseudo expression providing additional coefficient-wise operations. More... | |
class | CwiseBinaryOp |
Generic expression where a coefficient-wise binary operator is applied to two expressions. More... | |
class | CwiseNullaryOp |
Generic expression of a matrix where all coefficients are defined by a functor. More... | |
class | CwiseUnaryOp |
Generic expression where a coefficient-wise unary operator is applied to an expression. More... | |
class | CwiseUnaryView |
Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector. More... | |
struct | Dense |
class | DenseBase |
Base class for all dense matrices, vectors, and arrays. More... | |
class | DenseCoeffsBase< Derived, DirectAccessors > |
Base class providing direct read-only coefficient access to matrices and arrays. More... | |
class | DenseCoeffsBase< Derived, DirectWriteAccessors > |
Base class providing direct read/write coefficient access to matrices and arrays. More... | |
class | DenseCoeffsBase< Derived, ReadOnlyAccessors > |
Base class providing read-only coefficient access to matrices and arrays. More... | |
class | DenseCoeffsBase< Derived, WriteAccessors > |
Base class providing read/write coefficient access to matrices and arrays. More... | |
class | Diagonal |
Expression of a diagonal/subdiagonal/superdiagonal in a matrix. More... | |
class | DiagonalMatrix |
Represents a diagonal matrix with its storage. More... | |
class | DiagonalWrapper |
Expression of a diagonal matrix. More... | |
class | DynamicSparseMatrix |
A sparse matrix class designed for matrix assembly purpose. More... | |
struct | EigenBase |
class | EigenSolver |
Computes eigenvalues and eigenvectors of general matrices. More... | |
class | Flagged |
Expression with modified flags. More... | |
class | ForceAlignedAccess |
Enforce aligned packet loads and stores regardless of what is requested. More... | |
class | FullPivHouseholderQR |
Householder rank-revealing QR decomposition of a matrix with full pivoting. More... | |
class | FullPivLU |
LU decomposition of a matrix with complete pivoting, and related features. More... | |
class | GeneralizedSelfAdjointEigenSolver |
Computes eigenvalues and eigenvectors of the generalized selfadjoint eigen problem. More... | |
class | HessenbergDecomposition |
Reduces a square matrix to Hessenberg form by an orthogonal similarity transformation. More... | |
class | Homogeneous |
Expression of one (or a set of) homogeneous vector(s) More... | |
class | HouseholderQR |
Householder QR decomposition of a matrix. More... | |
class | HouseholderSequence |
Sequence of Householder reflections acting on subspaces with decreasing size. More... | |
class | HybridNonLinearSolver |
class | Hyperplane |
A hyperplane. More... | |
class | InnerStride |
Convenience specialization of Stride to specify only an inner stride See class Map for some examples. More... | |
class | IOFormat |
Stores a set of parameters controlling the way matrices are printed. More... | |
class | IterationController |
class | JacobiRotation |
Rotation given by a cosine-sine pair. More... | |
class | JacobiSVD |
Two-sided Jacobi SVD decomposition of a rectangular matrix. More... | |
class | KdBVH |
class | LDLT |
Robust Cholesky decomposition of a matrix with pivoting. More... | |
class | LevenbergMarquardt |
class | LLT |
Standard Cholesky decomposition (LL^T) of a matrix and associated features. More... | |
class | Map |
A matrix or vector expression mapping an existing array of data. More... | |
class | Map< const Quaternion< _Scalar >, _Options > |
Quaternion expression mapping a constant memory buffer. More... | |
class | Map< Quaternion< _Scalar >, _Options > |
Expression of a quaternion from a memory buffer. More... | |
class | MappedSparseMatrix |
Sparse matrix. More... | |
class | Matrix |
The matrix class, also used for vectors and row-vectors. More... | |
class | MatrixBase |
Base class for all dense matrices, vectors, and expressions. More... | |
class | MatrixExponential |
struct | MatrixExponentialReturnValue |
class | MatrixFunction |
class | MatrixFunction< MatrixType, 0 > |
class | MatrixFunction< MatrixType, 1 > |
class | MatrixFunctionAtomic |
class | MatrixFunctionReturnValue |
class | MatrixWrapper |
Expression of an array as a mathematical vector or matrix. More... | |
struct | MatrixXpr |
class | Minor |
Expression of a minor. More... | |
class | NestByValue |
Expression which must be nested by value. More... | |
class | NoAlias |
Pseudo expression providing an operator = assuming no aliasing. More... | |
class | NumericalDiff |
class | NumTraits |
Holds information about the various numeric (i.e. scalar) types allowed by Eigen. More... | |
class | OuterStride |
Convenience specialization of Stride to specify only an outer stride See class Map for some examples. More... | |
class | ParametrizedLine |
A parametrized line. More... | |
class | PartialPivLU |
LU decomposition of a matrix with partial pivoting, and related features. More... | |
class | PartialReduxExpr |
Generic expression of a partially reduxed matrix. More... | |
class | PermutationBase |
Base class for permutations. More... | |
class | PermutationMatrix |
Permutation matrix. More... | |
class | PermutationWrapper |
Class to view a vector of integers as a permutation matrix. More... | |
class | PlainObjectBase |
Dense storage base class for matrices and arrays. More... | |
class | ProductReturnType |
Helper class to get the correct and optimized returned type of operator*. More... | |
class | Quaternion |
The quaternion class used to represent 3D orientations and rotations. More... | |
class | RandomSetter |
class | RealSchur |
Performs a real Schur decomposition of a square matrix. More... | |
class | Replicate |
Expression of the multiple replication of a matrix or vector. More... | |
class | Reverse |
Expression of the reverse of a vector or matrix. More... | |
class | Rotation2D |
Represents a rotation/orientation in a 2 dimensional space. More... | |
class | RotationBase |
Common base class for compact rotation representations. More... | |
class | Select |
Expression of a coefficient wise version of the C++ ternary operator ?: More... | |
class | SelfAdjointEigenSolver |
Computes eigenvalues and eigenvectors of selfadjoint matrices. More... | |
class | SelfAdjointView |
Expression of a selfadjoint matrix from a triangular part of a dense matrix. More... | |
class | SimplicialCholesky |
class | SkylineInplaceLU |
class | SkylineMatrix |
class | SkylineMatrixBase |
class | SkylineStorage |
struct | Sparse |
class | SparseLDLT |
class | SparseLLT |
class | SparseLU |
class | SparseMatrix |
The main sparse matrix class. More... | |
class | SparseMatrixBase |
Base class of any sparse matrices or sparse expressions. More... | |
class | SparseSelfAdjointView |
Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix. More... | |
class | SparseVector |
a sparse vector class More... | |
struct | StdMapTraits |
class | StdStemFunctions |
class | Stride |
Holds strides information for Map. More... | |
class | Transform |
Represents an homogeneous transformation in a N dimensional space. More... | |
class | Translation |
Represents a translation transformation. More... | |
class | Transpose |
Expression of the transpose of a matrix. More... | |
class | Transpositions |
Represents a sequence of transpositions (row/column interchange) More... | |
class | TriangularView |
Base class for triangular part in a matrix. More... | |
class | Tridiagonalization |
Tridiagonal decomposition of a selfadjoint matrix. More... | |
class | VectorBlock |
Expression of a fixed-size or dynamic-size sub-vector. More... | |
class | VectorwiseOp |
Pseudo expression providing partial reduction operations. More... | |
class | WithFormat |
Pseudo expression providing matrix output with given format. More... | |
Typedefs | |
typedef Transform< double, 2, Affine > | Affine2d |
typedef Transform< float, 2, Affine > | Affine2f |
typedef Transform< double, 3, Affine > | Affine3d |
typedef Transform< float, 3, Affine > | Affine3f |
typedef Transform< double, 2, AffineCompact > | AffineCompact2d |
typedef Transform< float, 2, AffineCompact > | AffineCompact2f |
typedef Transform< double, 3, AffineCompact > | AffineCompact3d |
typedef Transform< float, 3, AffineCompact > | AffineCompact3f |
typedef DiagonalMatrix< double, 2 > | AlignedScaling2d |
typedef DiagonalMatrix< float, 2 > | AlignedScaling2f |
typedef DiagonalMatrix< double, 3 > | AlignedScaling3d |
typedef DiagonalMatrix< float, 3 > | AlignedScaling3f |
typedef AngleAxis< double > | AngleAxisd |
typedef AngleAxis< float > | AngleAxisf |
typedef Transform< double, 2, Isometry > | Isometry2d |
typedef Transform< float, 2, Isometry > | Isometry2f |
typedef Transform< double, 3, Isometry > | Isometry3d |
typedef Transform< float, 3, Isometry > | Isometry3f |
typedef Matrix< std::complex < double >, 2, 2 > | Matrix2cd |
typedef Matrix< std::complex < float >, 2, 2 > | Matrix2cf |
typedef Matrix< double, 2, 2 > | Matrix2d |
typedef Matrix< float, 2, 2 > | Matrix2f |
typedef Matrix< int, 2, 2 > | Matrix2i |
typedef Matrix< std::complex < double >, 2, Dynamic > | Matrix2Xcd |
typedef Matrix< std::complex < float >, 2, Dynamic > | Matrix2Xcf |
typedef Matrix< double, 2, Dynamic > | Matrix2Xd |
typedef Matrix< float, 2, Dynamic > | Matrix2Xf |
typedef Matrix< int, 2, Dynamic > | Matrix2Xi |
typedef Matrix< std::complex < double >, 3, 3 > | Matrix3cd |
typedef Matrix< std::complex < float >, 3, 3 > | Matrix3cf |
typedef Matrix< double, 3, 3 > | Matrix3d |
typedef Matrix< float, 3, 3 > | Matrix3f |
typedef Matrix< int, 3, 3 > | Matrix3i |
typedef Matrix< std::complex < double >, 3, Dynamic > | Matrix3Xcd |
typedef Matrix< std::complex < float >, 3, Dynamic > | Matrix3Xcf |
typedef Matrix< double, 3, Dynamic > | Matrix3Xd |
typedef Matrix< float, 3, Dynamic > | Matrix3Xf |
typedef Matrix< int, 3, Dynamic > | Matrix3Xi |
typedef Matrix< std::complex < double >, 4, 4 > | Matrix4cd |
typedef Matrix< std::complex < float >, 4, 4 > | Matrix4cf |
typedef Matrix< double, 4, 4 > | Matrix4d |
typedef Matrix< float, 4, 4 > | Matrix4f |
typedef Matrix< int, 4, 4 > | Matrix4i |
typedef Matrix< std::complex < double >, 4, Dynamic > | Matrix4Xcd |
typedef Matrix< std::complex < float >, 4, Dynamic > | Matrix4Xcf |
typedef Matrix< double, 4, Dynamic > | Matrix4Xd |
typedef Matrix< float, 4, Dynamic > | Matrix4Xf |
typedef Matrix< int, 4, Dynamic > | Matrix4Xi |
typedef Matrix< std::complex < double >, Dynamic, 2 > | MatrixX2cd |
typedef Matrix< std::complex < float >, Dynamic, 2 > | MatrixX2cf |
typedef Matrix< double, Dynamic, 2 > | MatrixX2d |
typedef Matrix< float, Dynamic, 2 > | MatrixX2f |
typedef Matrix< int, Dynamic, 2 > | MatrixX2i |
typedef Matrix< std::complex < double >, Dynamic, 3 > | MatrixX3cd |
typedef Matrix< std::complex < float >, Dynamic, 3 > | MatrixX3cf |
typedef Matrix< double, Dynamic, 3 > | MatrixX3d |
typedef Matrix< float, Dynamic, 3 > | MatrixX3f |
typedef Matrix< int, Dynamic, 3 > | MatrixX3i |
typedef Matrix< std::complex < double >, Dynamic, 4 > | MatrixX4cd |
typedef Matrix< std::complex < float >, Dynamic, 4 > | MatrixX4cf |
typedef Matrix< double, Dynamic, 4 > | MatrixX4d |
typedef Matrix< float, Dynamic, 4 > | MatrixX4f |
typedef Matrix< int, Dynamic, 4 > | MatrixX4i |
typedef Matrix< std::complex < double >, Dynamic, Dynamic > | MatrixXcd |
typedef Matrix< std::complex < float >, Dynamic, Dynamic > | MatrixXcf |
typedef Matrix< double, Dynamic, Dynamic > | MatrixXd |
typedef Matrix< float, Dynamic, Dynamic > | MatrixXf |
typedef Matrix< int, Dynamic, Dynamic > | MatrixXi |
typedef Transform< double, 2, Projective > | Projective2d |
typedef Transform< float, 2, Projective > | Projective2f |
typedef Transform< double, 3, Projective > | Projective3d |
typedef Transform< float, 3, Projective > | Projective3f |
typedef Quaternion< double > | Quaterniond |
typedef Quaternion< float > | Quaternionf |
typedef Map< Quaternion < double >, Aligned > | QuaternionMapAlignedd |
typedef Map< Quaternion< float > , Aligned > | QuaternionMapAlignedf |
typedef Map< Quaternion < double >, 0 > | QuaternionMapd |
typedef Map< Quaternion< float >, 0 > | QuaternionMapf |
typedef Rotation2D< double > | Rotation2Dd |
typedef Rotation2D< float > | Rotation2Df |
typedef Matrix< std::complex < double >, 1, 2 > | RowVector2cd |
typedef Matrix< std::complex < float >, 1, 2 > | RowVector2cf |
typedef Matrix< double, 1, 2 > | RowVector2d |
typedef Matrix< float, 1, 2 > | RowVector2f |
typedef Matrix< int, 1, 2 > | RowVector2i |
typedef Matrix< std::complex < double >, 1, 3 > | RowVector3cd |
typedef Matrix< std::complex < float >, 1, 3 > | RowVector3cf |
typedef Matrix< double, 1, 3 > | RowVector3d |
typedef Matrix< float, 1, 3 > | RowVector3f |
typedef Matrix< int, 1, 3 > | RowVector3i |
typedef Matrix< std::complex < double >, 1, 4 > | RowVector4cd |
typedef Matrix< std::complex < float >, 1, 4 > | RowVector4cf |
typedef Matrix< double, 1, 4 > | RowVector4d |
typedef Matrix< float, 1, 4 > | RowVector4f |
typedef Matrix< int, 1, 4 > | RowVector4i |
typedef Matrix< std::complex < double >, 1, Dynamic > | RowVectorXcd |
typedef Matrix< std::complex < float >, 1, Dynamic > | RowVectorXcf |
typedef Matrix< double, 1, Dynamic > | RowVectorXd |
typedef Matrix< float, 1, Dynamic > | RowVectorXf |
typedef Matrix< int, 1, Dynamic > | RowVectorXi |
typedef Matrix< std::complex < double >, 2, 1 > | Vector2cd |
typedef Matrix< std::complex < float >, 2, 1 > | Vector2cf |
typedef Matrix< double, 2, 1 > | Vector2d |
typedef Matrix< float, 2, 1 > | Vector2f |
typedef Matrix< int, 2, 1 > | Vector2i |
typedef Matrix< std::complex < double >, 3, 1 > | Vector3cd |
typedef Matrix< std::complex < float >, 3, 1 > | Vector3cf |
typedef Matrix< double, 3, 1 > | Vector3d |
typedef Matrix< float, 3, 1 > | Vector3f |
typedef Matrix< int, 3, 1 > | Vector3i |
typedef Matrix< std::complex < double >, 4, 1 > | Vector4cd |
typedef Matrix< std::complex < float >, 4, 1 > | Vector4cf |
typedef Matrix< double, 4, 1 > | Vector4d |
typedef Matrix< float, 4, 1 > | Vector4f |
typedef Matrix< int, 4, 1 > | Vector4i |
typedef Matrix< std::complex < double >, Dynamic, 1 > | VectorXcd |
typedef Matrix< std::complex < float >, Dynamic, 1 > | VectorXcf |
typedef Matrix< double, Dynamic, 1 > | VectorXd |
typedef Matrix< float, Dynamic, 1 > | VectorXf |
typedef Matrix< int, Dynamic, 1 > | VectorXi |
Enumerations | |
enum | { Lower, Upper, UnitDiag, ZeroDiag, UnitLower, UnitUpper, StrictlyLower, StrictlyUpper, SelfAdjoint } |
enum | { Unaligned, Aligned } |
enum | { ColMajor, RowMajor } |
enum | { OnTheLeft, OnTheRight } |
enum | AccessorLevels { ReadOnlyAccessors, WriteAccessors, DirectAccessors, DirectWriteAccessors } |
enum | ComputationInfo { Success, NumericalIssue, NoConvergence } |
enum | CornerType |
enum | DecompositionOptions { , ComputeFullU, ComputeThinU, ComputeFullV, ComputeThinV, EigenvaluesOnly, ComputeEigenvectors , Ax_lBx, ABx_lx, BAx_lx } |
enum | DirectionType { Vertical, Horizontal, BothDirections } |
enum | QRPreconditioners { NoQRPreconditioner, HouseholderQRPreconditioner, ColPivHouseholderQRPreconditioner, FullPivHouseholderQRPreconditioner } |
enum | TransformTraits { Isometry, Affine, AffineCompact, Projective } |
Functions | |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::less) Cwise< ExpressionType > |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::less_equal) Cwise< ExpressionType > |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::greater) Cwise< ExpressionType > |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::greater_equal) Cwise< ExpressionType > |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::equal_to) Cwise< ExpressionType > |
template<typename ExpressionType > | |
const | EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE (std::not_equal_to) Cwise< ExpressionType > |
template<typename VectorsType , typename CoeffsType > | |
HouseholderSequence < VectorsType, CoeffsType > | householderSequence (const VectorsType &v, const CoeffsType &h) |
Convenience function for constructing a Householder sequence. | |
std::ptrdiff_t | l1CacheSize () |
std::ptrdiff_t | l2CacheSize () |
template<typename OtherDerived , typename VectorsType , typename CoeffsType , int Side> | |
internal::matrix_type_times_scalar_type < typename VectorsType::Scalar, OtherDerived >::Type | operator* (const MatrixBase< OtherDerived > &other, const HouseholderSequence< VectorsType, CoeffsType, Side > &h) |
Computes the product of a matrix with a Householder sequence. | |
template<typename Derived , typename TranspositionsDerived > | |
const internal::transposition_matrix_product_retval < TranspositionsDerived, Derived, OnTheRight > | operator* (const MatrixBase< Derived > &matrix, const TranspositionsBase< TranspositionsDerived > &transpositions) |
template<typename Derived , typename TranspositionDerived > | |
const internal::transposition_matrix_product_retval < TranspositionDerived, Derived, OnTheLeft > | operator* (const TranspositionsBase< TranspositionDerived > &transpositions, const MatrixBase< Derived > &matrix) |
template<typename Derived , typename PermutationDerived > | |
const internal::permut_matrix_product_retval < PermutationDerived, Derived, OnTheRight > | operator* (const MatrixBase< Derived > &matrix, const PermutationBase< PermutationDerived > &permutation) |
template<typename Derived , typename PermutationDerived > | |
const internal::permut_matrix_product_retval < PermutationDerived, Derived, OnTheLeft > | operator* (const PermutationBase< PermutationDerived > &permutation, const MatrixBase< Derived > &matrix) |
template<typename VectorsType , typename CoeffsType > | |
HouseholderSequence < VectorsType, CoeffsType, OnTheRight > | rightHouseholderSequence (const VectorsType &v, const CoeffsType &h) |
Convenience function for constructing a Householder sequence. | |
void | setCpuCacheSizes (std::ptrdiff_t l1, std::ptrdiff_t l2) |
template<typename Derived , typename OtherDerived > | |
internal::umeyama_transform_matrix_type < Derived, OtherDerived > ::type | umeyama (const MatrixBase< Derived > &src, const MatrixBase< OtherDerived > &dst, bool with_scaling=true) |
Returns the transformation between two point sets. | |
Variables | |
const unsigned int | ActualPacketAccessBit |
const unsigned int | AlignedBit |
const unsigned int | DirectAccessBit |
const int | Dynamic |
const unsigned int | EvalBeforeAssigningBit |
const unsigned int | EvalBeforeNestingBit |
const int | Infinity |
const unsigned int | LinearAccessBit |
const unsigned int | LvalueBit |
const unsigned int | PacketAccessBit |
const unsigned int | RowMajorBit |
Namespace containing all symbols from the Eigen library.
enum ComputationInfo |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::less | ) | [inline] |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::less_equal | ) | [inline] |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::greater | ) | [inline] |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::greater_equal | ) | [inline] |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::equal_to | ) | [inline] |
const Eigen::EIGEN_CWISE_COMP_TO_SCALAR_RETURN_TYPE | ( | std::not_equal_to | ) | [inline] |
std::ptrdiff_t Eigen::l1CacheSize | ( | ) | [inline] |
std::ptrdiff_t Eigen::l2CacheSize | ( | ) | [inline] |
internal::matrix_type_times_scalar_type<typename VectorsType::Scalar,OtherDerived>::Type Eigen::operator* | ( | const MatrixBase< OtherDerived > & | other, |
const HouseholderSequence< VectorsType, CoeffsType, Side > & | h | ||
) |
Computes the product of a matrix with a Householder sequence.
[in] | other | Matrix being multiplied. |
[in] | h | HouseholderSequence being multiplied. |
This function computes where
is the matrix
other
and is the Householder sequence represented by
h
.
const internal::transposition_matrix_product_retval<TranspositionsDerived, Derived, OnTheRight> Eigen::operator* | ( | const MatrixBase< Derived > & | matrix, |
const TranspositionsBase< TranspositionsDerived > & | transpositions | ||
) | [inline] |
const internal::transposition_matrix_product_retval<TranspositionDerived, Derived, OnTheLeft> Eigen::operator* | ( | const TranspositionsBase< TranspositionDerived > & | transpositions, |
const MatrixBase< Derived > & | matrix | ||
) | [inline] |
const internal::permut_matrix_product_retval<PermutationDerived, Derived, OnTheRight> Eigen::operator* | ( | const MatrixBase< Derived > & | matrix, |
const PermutationBase< PermutationDerived > & | permutation | ||
) | [inline] |
const internal::permut_matrix_product_retval<PermutationDerived, Derived, OnTheLeft> Eigen::operator* | ( | const PermutationBase< PermutationDerived > & | permutation, |
const MatrixBase< Derived > & | matrix | ||
) | [inline] |
void Eigen::setCpuCacheSizes | ( | std::ptrdiff_t | l1, |
std::ptrdiff_t | l2 | ||
) | [inline] |
Set the cpu L1 and L2 cache sizes (in bytes). These values are use to adjust the size of the blocks for the algorithms working per blocks.
const int Dynamic |
This value means that a quantity is not known at compile-time, and that instead the value is stored in some runtime variable.
Changing the value of Dynamic breaks the ABI, as Dynamic is often used as a template parameter for Matrix.
const int Infinity |
This value means +Infinity; it is currently used only as the p parameter to MatrixBase::lpNorm<int>(). The value Infinity there means the L-infinity norm.