Namespaces | Classes | Typedefs | Enumerations | Functions | Variables
Eigen Namespace Reference

Namespace containing all symbols from the Eigen library. More...

Namespaces

namespace  Architecture
namespace  internal

Classes

class  aligned_allocator
 STL compatible allocator to use with with 16 byte aligned types. More...
class  aligned_allocator_indirection
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  AutoDiffScalar
class  BiCGSTAB
 A bi conjugate gradient stabilized solver for sparse square problems. More...
class  Block
 Expression of a fixed-size or dynamic-size block. More...
class  Block< XprType, BlockRows, BlockCols, InnerPanel, true >
class  CholmodBase
 The base class for the direct Cholesky factorization of Cholmod. More...
class  CholmodDecomposition
 A general Cholesky factorization and solver based on Cholmod. More...
class  CholmodSimplicialLDLT
 A simplicial direct Cholesky (LDLT) factorization and solver based on Cholmod. More...
class  CholmodSimplicialLLT
 A simplicial direct Cholesky (LLT) factorization and solver based on Cholmod. More...
class  CholmodSupernodalLLT
 A supernodal Cholesky (LLT) factorization and solver based on Cholmod. More...
class  CoeffBasedProduct
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  ConjugateGradient
 A conjugate gradient solver for sparse self-adjoint problems. More...
class  CwiseBinaryOp
 Generic expression where a coefficient-wise binary operator is applied to two expressions. More...
class  CwiseBinaryOpImpl< BinaryOp, Lhs, Rhs, Dense >
class  CwiseBinaryOpImpl< BinaryOp, Lhs, Rhs, Sparse >
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  CwiseUnaryOpImpl< UnaryOp, MatrixType, Sparse >
class  CwiseUnaryOpImpl< UnaryOp, XprType, Dense >
class  CwiseUnaryView
 Generic lvalue expression of a coefficient-wise unary operator of a matrix or a vector. More...
class  CwiseUnaryViewImpl< ViewOp, MatrixType, Dense >
class  CwiseUnaryViewImpl< ViewOp, MatrixType, Sparse >
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...
struct  DenseSparseProductReturnType
struct  DenseSparseProductReturnType< Lhs, Rhs, 1 >
class  DenseStorage
class  DenseTimeSparseProduct
class  DenseTimeSparseSelfAdjointProduct
class  Diagonal
 Expression of a diagonal/subdiagonal/superdiagonal in a matrix. More...
class  DiagonalMatrix
 Represents a diagonal matrix with its storage. More...
class  DiagonalPreconditioner
 A preconditioner based on the digonal entries. More...
class  DiagonalProduct
class  DiagonalWrapper
 Expression of a diagonal matrix. More...
class  DynamicSparseMatrix
struct  EigenBase
class  EigenSolver
 Computes eigenvalues and eigenvectors of general matrices. 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  GeneralProduct< Lhs, Rhs, GemmProduct >
class  GeneralProduct< Lhs, Rhs, GemvProduct >
class  GeneralProduct< Lhs, Rhs, InnerProduct >
class  GeneralProduct< Lhs, Rhs, OuterProduct >
struct  GenericNumTraits
class  GMRES
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  IdentityPreconditioner
 A naive preconditioner which approximates any matrix as the identity matrix. More...
class  IncompleteLUT
 Incomplete LU factorization with dual-threshold strategy During the numerical factorization, two dropping rules are used : 1) any element whose magnitude is less than some tolerance is dropped. This tolerance is obtained by multiplying the input tolerance droptol by the average magnitude of all the original elements in the current row. 2) After the elimination of the row, only the fill largest elements in the L part and the fill largest elements in the U part are kept (in addition to the diagonal element ). Note that fill is computed from the input parameter fillfactor which is used the ratio to control the fill_in relatively to the initial number of nonzero elements. 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  IterativeSolverBase
 Base class for linear iterative solvers. More...
class  JacobiRotation
 Rotation given by a cosine-sine pair. More...
class  JacobiSVD
 Two-sided Jacobi SVD decomposition of a rectangular matrix. More...
class  KdBVH
struct  LazyProductReturnType
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< PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType >, _PacketAccess >
class  Map< Quaternion< _Scalar >, _Options >
 Expression of a quaternion from a memory buffer. More...
class  Map< Transpositions< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType >, PacketAccess >
class  MapBase< Derived, ReadOnlyAccessors >
class  MapBase< Derived, WriteAccessors >
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  MatrixFunctionAtomic
class  MatrixFunctionReturnValue
class  MatrixLogarithmAtomic
class  MatrixLogarithmReturnValue
class  MatrixMarketIterator
class  MatrixSquareRoot
class  MatrixSquareRootQuasiTriangular
class  MatrixSquareRootReturnValue
class  MatrixSquareRootTriangular
class  MatrixWrapper
 Expression of an array as a mathematical vector or matrix. More...
struct  MatrixXpr
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...
struct  NumTraits< Array< Scalar, Rows, Cols, Options, MaxRows, MaxCols > >
struct  NumTraits< double >
struct  NumTraits< float >
struct  NumTraits< long double >
struct  NumTraits< std::complex< _Real > >
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  PardisoImpl
class  PardisoLDLT
 A sparse direct Cholesky (LDLT) factorization and solver based on the PARDISO library. More...
class  PardisoLLT
 A sparse direct Cholesky (LLT) factorization and solver based on the PARDISO library. More...
class  PardisoLU
 A sparse direct LU factorization and solver based on the PARDISO library. 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  PastixBase
class  PastixLDLT
 A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library. More...
class  PastixLLT
 A sparse direct supernodal Cholesky (LLT) factorization and solver based on the PaStiX library. More...
class  PastixLU
 Sparse direct LU solver based on PaStiX library. More...
class  PermutationBase
 Base class for permutations. More...
class  PermutationMatrix
 Permutation matrix. More...
struct  PermutationStorage
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  PolynomialSolver
class  PolynomialSolverBase
class  ProductBase
class  ProductReturnType
 Helper class to get the correct and optimized returned type of operator*. More...
struct  ProductReturnType< Lhs, Rhs, CoeffBasedProductMode >
struct  ProductReturnType< Lhs, Rhs, LazyCoeffBasedProductMode >
class  Quaternion
 The quaternion class used to represent 3D orientations and rotations. More...
class  QuaternionBase
 Base class for quaternion expressions. 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  ReturnByValue
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  ScaledProduct
class  Select
 Expression of a coefficient wise version of the C++ ternary operator ?: More...
struct  selfadjoint_product_selector< MatrixType, OtherType, UpLo, false >
struct  selfadjoint_product_selector< MatrixType, OtherType, UpLo, true >
struct  selfadjoint_rank1_update< Scalar, Index, ColMajor, UpLo, ConjLhs, ConjRhs >
struct  selfadjoint_rank1_update< Scalar, Index, RowMajor, UpLo, ConjLhs, ConjRhs >
class  SelfAdjointEigenSolver
 Computes eigenvalues and eigenvectors of selfadjoint matrices. More...
struct  SelfadjointProductMatrix< Lhs, 0, true, Rhs, RhsMode, false >
struct  SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, 0, true >
struct  SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, RhsMode, false >
class  SelfAdjointView
 Expression of a selfadjoint matrix from a triangular part of a dense matrix. More...
class  SelfCwiseBinaryOp
class  SimplicialCholesky
class  SimplicialCholeskyBase
 A direct sparse Cholesky factorizations. More...
class  SimplicialLDLT
 A direct sparse LDLT Cholesky factorizations without square root. More...
class  SimplicialLLT
 A direct sparse LLT Cholesky factorizations. More...
class  SkylineInplaceLU
class  SkylineMatrix
class  SkylineMatrixBase
class  SkylineStorage
struct  SluMatrix
struct  SluMatrixMapHelper< Matrix< Scalar, Rows, Cols, Options, MRows, MCols > >
struct  SluMatrixMapHelper< SparseMatrixBase< Derived > >
struct  Sparse
class  SparseDenseOuterProduct
struct  SparseDenseProductReturnType
struct  SparseDenseProductReturnType< Lhs, Rhs, 1 >
class  SparseDiagonalProduct
class  SparseInnerVectorSet
class  SparseInnerVectorSet< SparseMatrix< _Scalar, _Options, _Index >, Size >
class  SparseMatrix
 A versatible sparse matrix representation. More...
class  SparseMatrixBase
 Base class of any sparse matrices or sparse expressions. More...
class  SparseSelfAdjointTimeDenseProduct
class  SparseSelfAdjointView
 Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix. More...
class  SparseSparseProduct
struct  SparseSparseProductReturnType
class  SparseSymmetricPermutationProduct
class  SparseTimeDenseProduct
class  SparseTriangularView
class  SparseVector
 a sparse vector class More...
class  SparseView
class  Spline
struct  SplineFitting
struct  SplineTraits< Spline< _Scalar, _Dim, _Degree >, _DerivativeOrder >
struct  SplineTraits< Spline< _Scalar, _Dim, _Degree >, Dynamic >
struct  StdMapTraits
class  StdStemFunctions
class  Stride
 Holds strides information for Map. More...
class  SuperILU
 A sparse direct incomplete LU factorization and solver based on the SuperLU library. More...
class  SuperLU
 A sparse direct LU factorization and solver based on the SuperLU library. More...
class  SuperLUBase
 The base class for the direct and incomplete LU factorization of SuperLU. More...
class  SwapWrapper
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  Transpose< PermutationBase< Derived > >
class  Transpose< TranspositionsBase< TranspositionsDerived > >
class  TransposeImpl< MatrixType, Dense >
class  TransposeImpl< MatrixType, Sparse >
class  Transpositions
 Represents a sequence of transpositions (row/column interchange) More...
class  TranspositionsBase
class  TranspositionsWrapper
class  TriangularBase
struct  TriangularProduct< Mode, false, Lhs, true, Rhs, false >
struct  TriangularProduct< Mode, LhsIsTriangular, Lhs, false, Rhs, false >
struct  TriangularProduct< Mode, true, Lhs, false, Rhs, true >
class  TriangularView
 Base class for triangular part in a matrix. More...
class  Tridiagonalization
 Tridiagonal decomposition of a selfadjoint matrix. More...
class  Triplet
 A small structure to hold a non zero as a triplet (i,j,value). More...
class  UmfPackLU
 A sparse LU factorization and solver based on UmfPack. More...
class  UniformScaling
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 AlignedBox< double, 1 > AlignedBox1d
typedef AlignedBox< float, 1 > AlignedBox1f
typedef AlignedBox< int, 1 > AlignedBox1i
typedef AlignedBox< double, 2 > AlignedBox2d
typedef AlignedBox< float, 2 > AlignedBox2f
typedef AlignedBox< int, 2 > AlignedBox2i
typedef AlignedBox< double, 3 > AlignedBox3d
typedef AlignedBox< float, 3 > AlignedBox3f
typedef AlignedBox< int, 3 > AlignedBox3i
typedef AlignedBox< double, 4 > AlignedBox4d
typedef AlignedBox< float, 4 > AlignedBox4f
typedef AlignedBox< int, 4 > AlignedBox4i
typedef AlignedBox< double,
Dynamic
AlignedBoxXd
typedef AlignedBox< float,
Dynamic
AlignedBoxXf
typedef AlignedBox< int, DynamicAlignedBoxXi
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
EIGEN_DEFAULT_DENSE_INDEX_TYPE 
DenseIndex
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, DynamicMatrix2Xf
typedef Matrix< int, 2, DynamicMatrix2Xi
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, DynamicMatrix3Xf
typedef Matrix< int, 3, DynamicMatrix3Xi
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, DynamicMatrix4Xf
typedef Matrix< int, 4, DynamicMatrix4Xi
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, DynamicRowVectorXf
typedef Matrix< int, 1, DynamicRowVectorXi
typedef Translation< double, 2 > Translation2d
typedef Translation< float, 2 > Translation2f
typedef Translation< double, 3 > Translation3d
typedef Translation< float, 3 > Translation3f
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  {
  Large,
  Small
}
enum  { DontAlignCols }
enum  {
  StreamPrecision,
  FullPrecision
}
enum  {
  Lower,
  Upper,
  UnitDiag,
  ZeroDiag,
  UnitLower,
  UnitUpper,
  StrictlyLower,
  StrictlyUpper,
  SelfAdjoint,
  Symmetric
}
enum  {
  Unaligned,
  Aligned
}
enum  {
  DefaultTraversal,
  LinearTraversal,
  InnerVectorizedTraversal,
  LinearVectorizedTraversal,
  SliceVectorizedTraversal,
  InvalidTraversal
}
enum  {
  NoUnrolling,
  InnerUnrolling,
  CompleteUnrolling
}
enum  {
  Specialized,
  BuiltIn
}
enum  {
  ColMajor,
  RowMajor,
  AutoAlign,
  DontAlign
}
enum  {
  OnTheLeft,
  OnTheRight
}
enum  {
  IsDense,
  IsSparse
}
enum  {
  CoeffBasedProductMode,
  LazyCoeffBasedProductMode,
  OuterProduct,
  InnerProduct,
  GemvProduct,
  GemmProduct
}
enum  AccessorLevels {
  ReadOnlyAccessors,
  WriteAccessors,
  DirectAccessors,
  DirectWriteAccessors
}
enum  Action {
  GetAction,
  SetAction
}
enum  CholmodMode {
  CholmodAuto,
  CholmodSimplicialLLt,
  CholmodSupernodalLLt,
  CholmodLDLt
}
enum  ComputationInfo {
  Success,
  NumericalIssue,
  NoConvergence,
  InvalidInput
}
enum  CornerType {
  TopLeft,
  TopRight,
  BottomLeft,
  BottomRight
}
enum  DecompositionOptions {
  Pivoting,
  NoPivoting,
  ComputeFullU,
  ComputeThinU,
  ComputeFullV,
  ComputeThinV,
  EigenvaluesOnly,
  ComputeEigenvectors,
  EigVecMask,
  Ax_lBx,
  ABx_lx,
  BAx_lx,
  GenEigMask
}
enum  Default_t { Default }
enum  DirectionType {
  Vertical,
  Horizontal,
  BothDirections
}
enum  NoChange_t { NoChange }
enum  QRPreconditioners {
  NoQRPreconditioner,
  HouseholderQRPreconditioner,
  ColPivHouseholderQRPreconditioner,
  FullPivHouseholderQRPreconditioner
}
enum  Sequential_t { Sequential }
enum  SimplicialCholeskyMode {
  SimplicialCholeskyLLT,
  SimplicialCholeskyLDLT
}
enum  TransformTraits {
  Isometry,
  Affine,
  AffineCompact,
  Projective
}

Functions

template<typename Scalar >
std::complex< Scalar > cdiv (Scalar xr, Scalar xi, Scalar yr, Scalar yi)
template<typename VectorsType , typename CoeffsType >
HouseholderSequence
< VectorsType, CoeffsType > 
householderSequence (const VectorsType &v, const CoeffsType &h)
 Convenience function for constructing a Householder sequence.
void initParallel ()
std::ptrdiff_t l1CacheSize ()
std::ptrdiff_t l2CacheSize ()
int nbThreads ()
template<typename SparseDerived , typename PermDerived >
const
internal::permut_sparsematrix_product_retval
< PermutationBase< PermDerived >
, SparseDerived, OnTheRight,
false > 
operator* (const SparseMatrixBase< SparseDerived > &matrix, const PermutationBase< PermDerived > &perm)
template<typename SparseDerived , typename PermDerived >
const
internal::permut_sparsematrix_product_retval
< PermutationBase< PermDerived >
, SparseDerived, OnTheLeft,
false > 
operator* (const PermutationBase< PermDerived > &perm, const SparseMatrixBase< SparseDerived > &matrix)
template<typename SparseDerived , typename PermDerived >
const
internal::permut_sparsematrix_product_retval
< PermutationBase< PermDerived >
, SparseDerived, OnTheRight,
true > 
operator* (const SparseMatrixBase< SparseDerived > &matrix, const Transpose< PermutationBase< PermDerived > > &tperm)
template<typename SparseDerived , typename PermDerived >
const
internal::permut_sparsematrix_product_retval
< PermutationBase< PermDerived >
, SparseDerived, OnTheLeft,
true > 
operator* (const Transpose< PermutationBase< PermDerived > > &tperm, const SparseMatrixBase< SparseDerived > &matrix)
template<typename Derived , typename Lhs , typename Rhs >
const ScaledProduct< Derived > operator* (const ProductBase< Derived, Lhs, Rhs > &prod, typename Derived::Scalar x)
template<typename Derived , typename Lhs , typename Rhs >
internal::enable_if
<!internal::is_same< typename
Derived::Scalar, typename
Derived::RealScalar >::value,
const ScaledProduct< Derived >
>::type 
operator* (const ProductBase< Derived, Lhs, Rhs > &prod, typename Derived::RealScalar x)
template<typename Derived , typename Lhs , typename Rhs >
const ScaledProduct< Derived > operator* (typename Derived::Scalar x, const ProductBase< Derived, Lhs, Rhs > &prod)
template<typename Derived , typename Lhs , typename Rhs >
internal::enable_if
<!internal::is_same< typename
Derived::Scalar, typename
Derived::RealScalar >::value,
const ScaledProduct< Derived >
>::type 
operator* (typename Derived::RealScalar x, const ProductBase< Derived, Lhs, Rhs > &prod)
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 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 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 Derived >
const Eigen::CwiseUnaryOp
< Eigen::internal::scalar_inverse_mult_op
< typename Derived::Scalar >
, const Derived > 
operator/ (typename Derived::Scalar s, const Eigen::ArrayBase< Derived > &a)
 Component-wise division of a scalar by array elements.
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)
void setNbThreads (int v)
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.
void umfpack_free_numeric (void **Numeric, double)
void umfpack_free_numeric (void **Numeric, std::complex< double >)
void umfpack_free_symbolic (void **Symbolic, double)
void umfpack_free_symbolic (void **Symbolic, std::complex< double >)
int umfpack_get_determinant (double *Mx, double *Ex, void *NumericHandle, double User_Info[UMFPACK_INFO])
int umfpack_get_determinant (std::complex< double > *Mx, double *Ex, void *NumericHandle, double User_Info[UMFPACK_INFO])
int umfpack_get_lunz (int *lnz, int *unz, int *n_row, int *n_col, int *nz_udiag, void *Numeric, double)
int umfpack_get_lunz (int *lnz, int *unz, int *n_row, int *n_col, int *nz_udiag, void *Numeric, std::complex< double >)
int umfpack_get_numeric (int Lp[], int Lj[], double Lx[], int Up[], int Ui[], double Ux[], int P[], int Q[], double Dx[], int *do_recip, double Rs[], void *Numeric)
int umfpack_get_numeric (int Lp[], int Lj[], std::complex< double > Lx[], int Up[], int Ui[], std::complex< double > Ux[], int P[], int Q[], std::complex< double > Dx[], int *do_recip, double Rs[], void *Numeric)
int umfpack_numeric (const int Ap[], const int Ai[], const double Ax[], void *Symbolic, void **Numeric, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
int umfpack_numeric (const int Ap[], const int Ai[], const std::complex< double > Ax[], void *Symbolic, void **Numeric, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
int umfpack_solve (int sys, const int Ap[], const int Ai[], const double Ax[], double X[], const double B[], void *Numeric, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
int umfpack_solve (int sys, const int Ap[], const int Ai[], const std::complex< double > Ax[], std::complex< double > X[], const std::complex< double > B[], void *Numeric, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
int umfpack_symbolic (int n_row, int n_col, const int Ap[], const int Ai[], const double Ax[], void **Symbolic, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
int umfpack_symbolic (int n_row, int n_col, const int Ap[], const int Ai[], const std::complex< double > Ax[], void **Symbolic, const double Control[UMFPACK_CONTROL], double Info[UMFPACK_INFO])
template<typename _Scalar , int _Options, typename _Index >
cholmod_sparse viewAsCholmod (SparseMatrix< _Scalar, _Options, _Index > &mat)
template<typename _Scalar , int _Options, typename _Index >
const cholmod_sparse viewAsCholmod (const SparseMatrix< _Scalar, _Options, _Index > &mat)
template<typename _Scalar , int _Options, typename _Index , unsigned int UpLo>
cholmod_sparse viewAsCholmod (const SparseSelfAdjointView< SparseMatrix< _Scalar, _Options, _Index >, UpLo > &mat)
template<typename Derived >
cholmod_dense viewAsCholmod (MatrixBase< Derived > &mat)
template<typename Scalar , int Flags, typename Index >
MappedSparseMatrix< Scalar,
Flags, Index > 
viewAsEigen (cholmod_sparse &cm)

Variables

const unsigned int ActualPacketAccessBit
const unsigned int AlignedBit
const int CoherentAccessPattern
const unsigned int DirectAccessBit
const int Dynamic
const unsigned int EvalBeforeAssigningBit
const unsigned int EvalBeforeNestingBit
const unsigned int HereditaryBits
const int Infinity
const int InnerRandomAccessPattern
const unsigned int LinearAccessBit
const unsigned int LvalueBit
const unsigned int NestByRefBit
const int OuterRandomAccessPattern
const unsigned int PacketAccessBit
const int RandomAccessPattern
const unsigned int RowMajorBit

Detailed Description

Namespace containing all symbols from the Eigen library.


Typedef Documentation


Enumeration Type Documentation

anonymous enum
Enumerator:
Large 
Small 
anonymous enum
Enumerator:
DontAlignCols 
anonymous enum
Enumerator:
StreamPrecision 
FullPrecision 
anonymous enum
Enumerator:
DefaultTraversal 
LinearTraversal 
InnerVectorizedTraversal 
LinearVectorizedTraversal 
SliceVectorizedTraversal 
InvalidTraversal 
anonymous enum
Enumerator:
NoUnrolling 
InnerUnrolling 
CompleteUnrolling 
anonymous enum
Enumerator:
Specialized 
BuiltIn 
anonymous enum
Enumerator:
IsDense 
IsSparse 
anonymous enum
Enumerator:
CoeffBasedProductMode 
LazyCoeffBasedProductMode 
OuterProduct 
InnerProduct 
GemvProduct 
GemmProduct 
enum Action
Enumerator:
GetAction 
SetAction 
Enumerator:
CholmodAuto 
CholmodSimplicialLLt 
CholmodSupernodalLLt 
CholmodLDLt 
enum Default_t
Enumerator:
Default 
enum NoChange_t
Enumerator:
NoChange 
Enumerator:
Sequential 
Enumerator:
SimplicialCholeskyLLT 
SimplicialCholeskyLDLT 

Function Documentation

std::complex<Scalar> Eigen::cdiv ( Scalar  xr,
Scalar  xi,
Scalar  yr,
Scalar  yi 
)

References abs().

void Eigen::initParallel ( )
inline

Must be call first when calling Eigen from multiple threads

References GetAction, Eigen::internal::manage_caching_sizes(), and Eigen::internal::manage_multi_threading().

Referenced by Eigen::internal::parallelize_gemm().

std::ptrdiff_t Eigen::l1CacheSize ( )
inline
Returns:
the currently set level 1 cpu cache size (in bytes) used to estimate the ideal blocking size parameters.
See also:
setCpuCacheSize

References GetAction, and Eigen::internal::manage_caching_sizes().

std::ptrdiff_t Eigen::l2CacheSize ( )
inline
Returns:
the currently set level 2 cpu cache size (in bytes) used to estimate the ideal blocking size parameters.
See also:
setCpuCacheSize

References GetAction, and Eigen::internal::manage_caching_sizes().

int Eigen::nbThreads ( )
inline
Returns:
the max number of threads reserved for Eigen
See also:
setNbThreads

References GetAction, and Eigen::internal::manage_multi_threading().

Referenced by Eigen::internal::parallelize_gemm().

const internal::permut_sparsematrix_product_retval<PermutationBase<PermDerived>, SparseDerived, OnTheRight, false> Eigen::operator* ( const SparseMatrixBase< SparseDerived > &  matrix,
const PermutationBase< PermDerived > &  perm 
)
inline
Returns:
the matrix with the permutation applied to the columns

References EigenBase< Derived >::derived(), and OnTheRight.

const internal::permut_sparsematrix_product_retval<PermutationBase<PermDerived>, SparseDerived, OnTheLeft, false> Eigen::operator* ( const PermutationBase< PermDerived > &  perm,
const SparseMatrixBase< SparseDerived > &  matrix 
)
inline
Returns:
the matrix with the permutation applied to the rows

References EigenBase< Derived >::derived(), and OnTheLeft.

const internal::permut_sparsematrix_product_retval<PermutationBase<PermDerived>, SparseDerived, OnTheRight, true> Eigen::operator* ( const SparseMatrixBase< SparseDerived > &  matrix,
const Transpose< PermutationBase< PermDerived > > &  tperm 
)
inline
Returns:
the matrix with the inverse permutation applied to the columns.

References EigenBase< Derived >::derived(), and OnTheRight.

const internal::permut_sparsematrix_product_retval<PermutationBase<PermDerived>, SparseDerived, OnTheLeft, true> Eigen::operator* ( const Transpose< PermutationBase< PermDerived > > &  tperm,
const SparseMatrixBase< SparseDerived > &  matrix 
)
inline
Returns:
the matrix with the inverse permutation applied to the rows.

References EigenBase< Derived >::derived(), and OnTheLeft.

const ScaledProduct<Derived> Eigen::operator* ( const ProductBase< Derived, Lhs, Rhs > &  prod,
typename Derived::Scalar  x 
)
internal::enable_if<!internal::is_same<typename Derived::Scalar,typename Derived::RealScalar>::value, const ScaledProduct<Derived> >::type Eigen::operator* ( const ProductBase< Derived, Lhs, Rhs > &  prod,
typename Derived::RealScalar  x 
)
const ScaledProduct<Derived> Eigen::operator* ( typename Derived::Scalar  x,
const ProductBase< Derived, Lhs, Rhs > &  prod 
)
internal::enable_if<!internal::is_same<typename Derived::Scalar,typename Derived::RealScalar>::value, const ScaledProduct<Derived> >::type Eigen::operator* ( typename Derived::RealScalar  x,
const ProductBase< Derived, Lhs, Rhs > &  prod 
)
const internal::transposition_matrix_product_retval<TranspositionsDerived, Derived, OnTheRight> Eigen::operator* ( const MatrixBase< Derived > &  matrix,
const TranspositionsBase< TranspositionsDerived > &  transpositions 
)
inline
Returns:
the matrix with the transpositions applied to the columns.

References TranspositionsBase< Derived >::derived(), and OnTheRight.

const internal::transposition_matrix_product_retval<TranspositionDerived, Derived, OnTheLeft> Eigen::operator* ( const TranspositionsBase< TranspositionDerived > &  transpositions,
const MatrixBase< Derived > &  matrix 
)
inline
Returns:
the matrix with the transpositions applied to the rows.

References TranspositionsBase< Derived >::derived(), and OnTheLeft.

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.

Parameters:
[in]otherMatrix being multiplied.
[in]hHouseholderSequence being multiplied.
Returns:
Expression object representing the product.

This function computes $ MH $ where $ M $ is the matrix other and $ H $ is the Householder sequence represented by h.

References HouseholderSequence< VectorsType, CoeffsType, Side >::applyThisOnTheRight(), and cast().

const internal::permut_matrix_product_retval<PermutationDerived, Derived, OnTheRight> Eigen::operator* ( const MatrixBase< Derived > &  matrix,
const PermutationBase< PermutationDerived > &  permutation 
)
inline
Returns:
the matrix with the permutation applied to the columns.

References EigenBase< Derived >::derived(), and OnTheRight.

const internal::permut_matrix_product_retval<PermutationDerived, Derived, OnTheLeft> Eigen::operator* ( const PermutationBase< PermutationDerived > &  permutation,
const MatrixBase< Derived > &  matrix 
)
inline
Returns:
the matrix with the permutation applied to the rows.

References EigenBase< Derived >::derived(), and OnTheLeft.

const Eigen::CwiseUnaryOp<Eigen::internal::scalar_inverse_mult_op<typename Derived::Scalar>, const Derived> Eigen::operator/ ( typename Derived::Scalar  s,
const Eigen::ArrayBase< Derived > &  a 
)
inline

Component-wise division of a scalar by array elements.

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.

See also:
computeProductBlockingSizes

References Eigen::internal::manage_caching_sizes(), and SetAction.

void Eigen::setNbThreads ( int  v)
inline

Sets the max number of threads reserved for Eigen

See also:
nbThreads

References Eigen::internal::manage_multi_threading(), and SetAction.

void Eigen::umfpack_free_numeric ( void **  Numeric,
double   
)
inline
void Eigen::umfpack_free_numeric ( void **  Numeric,
std::complex< double >   
)
inline
void Eigen::umfpack_free_symbolic ( void **  Symbolic,
double   
)
inline
void Eigen::umfpack_free_symbolic ( void **  Symbolic,
std::complex< double >   
)
inline
int Eigen::umfpack_get_determinant ( double *  Mx,
double *  Ex,
void *  NumericHandle,
double  User_Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_get_determinant ( std::complex< double > *  Mx,
double *  Ex,
void *  NumericHandle,
double  User_Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_get_lunz ( int lnz,
int unz,
int n_row,
int n_col,
int nz_udiag,
void *  Numeric,
double   
)
inline
int Eigen::umfpack_get_lunz ( int lnz,
int unz,
int n_row,
int n_col,
int nz_udiag,
void *  Numeric,
std::complex< double >   
)
inline
int Eigen::umfpack_get_numeric ( int  Lp[],
int  Lj[],
double  Lx[],
int  Up[],
int  Ui[],
double  Ux[],
int  P[],
int  Q[],
double  Dx[],
int do_recip,
double  Rs[],
void *  Numeric 
)
inline
int Eigen::umfpack_get_numeric ( int  Lp[],
int  Lj[],
std::complex< double >  Lx[],
int  Up[],
int  Ui[],
std::complex< double >  Ux[],
int  P[],
int  Q[],
std::complex< double >  Dx[],
int do_recip,
double  Rs[],
void *  Numeric 
)
inline
int Eigen::umfpack_numeric ( const int  Ap[],
const int  Ai[],
const double  Ax[],
void *  Symbolic,
void **  Numeric,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_numeric ( const int  Ap[],
const int  Ai[],
const std::complex< double >  Ax[],
void *  Symbolic,
void **  Numeric,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_solve ( int  sys,
const int  Ap[],
const int  Ai[],
const double  Ax[],
double  X[],
const double  B[],
void *  Numeric,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_solve ( int  sys,
const int  Ap[],
const int  Ai[],
const std::complex< double >  Ax[],
std::complex< double >  X[],
const std::complex< double >  B[],
void *  Numeric,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_symbolic ( int  n_row,
int  n_col,
const int  Ap[],
const int  Ai[],
const double  Ax[],
void **  Symbolic,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
int Eigen::umfpack_symbolic ( int  n_row,
int  n_col,
const int  Ap[],
const int  Ai[],
const std::complex< double >  Ax[],
void **  Symbolic,
const double  Control[UMFPACK_CONTROL],
double  Info[UMFPACK_INFO] 
)
inline
cholmod_sparse Eigen::viewAsCholmod ( SparseMatrix< _Scalar, _Options, _Index > &  mat)
const cholmod_sparse Eigen::viewAsCholmod ( const SparseMatrix< _Scalar, _Options, _Index > &  mat)
cholmod_sparse Eigen::viewAsCholmod ( const SparseSelfAdjointView< SparseMatrix< _Scalar, _Options, _Index >, UpLo > &  mat)

Returns a view of the Eigen sparse matrix mat as Cholmod sparse matrix. The data are not copied but shared.

References Lower, Upper, and viewAsCholmod().

cholmod_dense Eigen::viewAsCholmod ( MatrixBase< Derived > &  mat)

Returns a view of the Eigen dense matrix mat as Cholmod dense matrix. The data are not copied but shared.

References EIGEN_STATIC_ASSERT, and RowMajorBit.

MappedSparseMatrix<Scalar,Flags,Index> Eigen::viewAsEigen ( cholmod_sparse &  cm)

Returns a view of the Cholmod sparse matrix cm as an Eigen sparse matrix. The data are not copied but shared.


Variable Documentation

const int CoherentAccessPattern
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.

Referenced by PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_init2(), PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_swap(), AlignedBox< _Scalar, _AmbientDim >::AlignedBox(), DenseBase< Derived >::all(), DenseBase< Derived >::any(), Eigen::internal::apply_rotation_in_the_plane(), Array< Index, 64, 1 >::Array(), Block< XprType, BlockRows, BlockCols, InnerPanel, HasDirectAccess >::Block(), Block< XprType, BlockRows, BlockCols, InnerPanel, true >::Block(), CwiseBinaryOp< BinaryOp, Lhs, Rhs >::cols(), CwiseNullaryOp< NullaryOp, PlainObjectType >::CwiseNullaryOp(), AlignedBox< _Scalar, _AmbientDim >::dim(), Hyperplane< _Scalar, _AmbientDim, _Options >::dim(), TriangularBase< Derived >::evalToLazy(), SparseSparseProduct< LhsNested, RhsNested >::init(), TriangularView< _MatrixType, _Mode >::lazyAssign(), MatrixBase< Derived >::lazyProduct(), MapBase< Derived, ReadOnlyAccessors >::MapBase(), Matrix< Index, 1, ColsAtCompileTime, RowMajor, 1, MaxColsAtCompileTime >::Matrix(), MatrixBase< Derived >::operator*(), CommaInitializer< XprType >::operator,(), CoeffBasedProduct< LhsNested, RhsNested, NestingFlags >::packet(), DenseBase< Derived >::prod(), Replicate< MatrixType, RowFactor, ColFactor >::Replicate(), PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::resize(), CwiseBinaryOp< BinaryOp, Lhs, Rhs >::rows(), GeneralProduct< Lhs, Rhs, GemmProduct >::scaleAndAddTo(), SparseInnerVectorSet< MatrixType, Size >::SparseInnerVectorSet(), Stride< 0, Value >::Stride(), DenseBase< Derived >::sum(), and DenseBase< Derived >::visit().

const unsigned int HereditaryBits
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.

const int InnerRandomAccessPattern
const unsigned int NestByRefBit
const int OuterRandomAccessPattern
const int RandomAccessPattern