Main MRPT website > C++ reference
MRPT logo
Defines

Macros.h File Reference

Go to the source code of this file.

Defines

#define EIGEN_WORLD_VERSION   2
#define EIGEN_MAJOR_VERSION   92
#define EIGEN_MINOR_VERSION   0
#define EIGEN_VERSION_AT_LEAST(x, y, z)
#define EIGEN_GNUC_AT_LEAST(x, y)   0
#define EIGEN_GCC3_OR_OLDER   0
#define EIGEN_GCC_AND_ARCH_DOESNT_WANT_STACK_ALIGNMENT   0
#define EIGEN_ARCH_WANTS_STACK_ALIGNMENT   1
#define EIGEN_ALIGN   1
#define EIGEN_ALIGN_STATICALLY   1
#define EIGEN_DEFAULT_MATRIX_STORAGE_ORDER_OPTION   ColMajor
#define EIGEN_DEFAULT_DENSE_INDEX_TYPE   std::ptrdiff_t
#define EIGEN_FAST_MATH   1
 Allows to disable some optimizations which might affect the accuracy of the result.
#define EIGEN_DEBUG_VAR(x)   std::cerr << #x << " = " << x << std::endl;
#define eigen_assert(x)   assert(x)
#define eigen_internal_assert(x)
#define EIGEN_ONLY_USED_FOR_DEBUG(x)
#define EIGEN_ALWAYS_INLINE_ATTRIB
#define EIGEN_FLATTEN_ATTRIB
#define EIGEN_STRONG_INLINE   inline
#define EIGEN_DONT_INLINE
#define EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS
#define EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS   inline
#define EIGEN_DEPRECATED
#define EIGEN_UNUSED
#define EIGEN_UNUSED_VARIABLE(var)   (void)var;
#define EIGEN_ASM_COMMENT(X)
#define EIGEN_ALIGN16   EIGEN_ALIGN_TO_BOUNDARY(16)
#define EIGEN_RESTRICT   __restrict
#define EIGEN_STACK_ALLOCATION_LIMIT   20000
#define EIGEN_DEFAULT_IO_FORMAT   Eigen::IOFormat()
#define EIGEN_EMPTY
#define EIGEN_CAT2(a, b)   a ## b
#define EIGEN_CAT(a, b)   EIGEN_CAT2(a,b)
#define EIGEN_MAKESTRING2(a)   #a
#define EIGEN_MAKESTRING(a)   EIGEN_MAKESTRING2(a)
#define EIGEN_DOCS_IO_FORMAT   IOFormat(3, 0, " ", "\n", "", "")
#define EIGEN_INHERIT_ASSIGNMENT_EQUAL_OPERATOR(Derived)
#define EIGEN_INHERIT_ASSIGNMENT_OPERATORS(Derived)   EIGEN_INHERIT_ASSIGNMENT_EQUAL_OPERATOR(Derived)
#define EIGEN_GENERIC_PUBLIC_INTERFACE(Derived)
 Just a side note.
#define EIGEN_DENSE_PUBLIC_INTERFACE(Derived)
#define EIGEN_PLAIN_ENUM_MIN(a, b)   (((int)a <= (int)b) ? (int)a : (int)b)
#define EIGEN_PLAIN_ENUM_MAX(a, b)   (((int)a >= (int)b) ? (int)a : (int)b)
#define EIGEN_SIZE_MIN_PREFER_DYNAMIC(a, b)
#define EIGEN_SIZE_MIN_PREFER_FIXED(a, b)
#define EIGEN_SIZE_MAX(a, b)
#define EIGEN_LOGICAL_XOR(a, b)   (((a) || (b)) && !((a) && (b)))
#define EIGEN_IMPLIES(a, b)   (!(a) || (b))
#define EIGEN_MAKE_CWISE_BINARY_OP(METHOD, FUNCTOR)
#define EIGEN_CWISE_PRODUCT_RETURN_TYPE(LHS, RHS)

Define Documentation

#define EIGEN_ALIGN   1

Definition at line 77 of file Macros.h.

#define EIGEN_ALIGN16   EIGEN_ALIGN_TO_BOUNDARY(16)
#define EIGEN_ALIGN_STATICALLY   1

Definition at line 83 of file Macros.h.

#define EIGEN_ALWAYS_INLINE_ATTRIB

Definition at line 147 of file Macros.h.

#define EIGEN_ARCH_WANTS_STACK_ALIGNMENT   1

Definition at line 66 of file Macros.h.

#define EIGEN_ASM_COMMENT (   X)
#define eigen_assert (   x)    assert(x)

Definition at line 122 of file Macros.h.

Referenced by PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_init2(), PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_resize_to_match(), HouseholderQR< _MatrixType >::absDeterminant(), FullPivHouseholderQR< _MatrixType >::absDeterminant(), ColPivHouseholderQR< _MatrixType >::absDeterminant(), internal::aligned_malloc(), JacobiSVD< _MatrixType, QRPreconditioner >::allocate(), internal::apply_rotation_in_the_plane(), PermutationMatrix< RowsAtCompileTime, MaxRowsAtCompileTime >::applyTranspositionOnTheLeft(), PermutationMatrix< RowsAtCompileTime, MaxRowsAtCompileTime >::applyTranspositionOnTheRight(), Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols >::Array(), SparseMatrixBase< DynamicSparseMatrix< _Scalar, _Options, _Index > >::assignGeneric(), Block< XprType, BlockRows, BlockCols, InnerPanel, true >::Block(), Block< VectorType, internal::traits< VectorType >::Flags &RowMajorBit?1:Size, internal::traits< VectorType >::Flags &RowMajorBit?Size:1 >::Block(), internal::llt_inplace< Lower >::blocked(), MatrixBase< Derived >::blueNorm(), TriangularBase< SelfAdjointView< MatrixType, UpLo > >::check_coordinates(), MapBase< Derived, ReadOnlyAccessors >::checkSanity(), SparseVector< _Scalar, _Options, _Index >::coeff(), ProductBase< SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, RhsMode, false >, Lhs, Rhs >::coeff(), AmbiVector< _Scalar, _Index >::coeff(), CoeffBasedProduct< LhsNested, RhsNested, NestingFlags >::CoeffBasedProduct(), SparseVector< _Scalar, _Options, _Index >::coeffRef(), SparseMatrix< _Scalar, _Options, _Index >::coeffRef(), ProductBase< SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, RhsMode, false >, Lhs, Rhs >::coeffRef(), MappedSparseMatrix< _Scalar, _Flags, _Index >::coeffRef(), AmbiVector< _Scalar, _Index >::coeffRef(), FullPivHouseholderQR< _MatrixType >::colsPermutation(), ColPivHouseholderQR< _MatrixType >::colsPermutation(), internal::UpperBidiagonalization< _MatrixType >::compute(), SelfAdjointEigenSolver< _MatrixType >::compute(), PartialPivLU< _MatrixType >::compute(), LDLT< _MatrixType, _UpLo >::compute(), GeneralizedSelfAdjointEigenSolver< _MatrixType >::compute(), ComplexSchur< MatrixType >::compute(), MatrixBase< Derived >::computeInverseAndDetWithCheck(), MatrixBase< Derived >::computeInverseWithCheck(), internal::conditional_aligned_malloc< false >(), VectorwiseOp< ExpressionType, Direction >::cross(), CwiseBinaryOp< BinaryOp, Lhs, Rhs >::CwiseBinaryOp(), CwiseNullaryOp< NullaryOp, PlainObjectType >::CwiseNullaryOp(), PartialPivLU< _MatrixType >::determinant(), FullPivLU< _MatrixType >::determinant(), Tridiagonalization< _MatrixType >::diagonal(), internal::BandMatrix< Scalar, Size, Size, Options &SelfAdjoint?0:1, 1, Options|RowMajor >::diagonal(), DiagonalProduct< MatrixType, DiagonalType, ProductOrder >::DiagonalProduct(), FullPivLU< _MatrixType >::dimensionOfKernel(), FullPivHouseholderQR< _MatrixType >::dimensionOfKernel(), ColPivHouseholderQR< _MatrixType >::dimensionOfKernel(), SparseMatrixBase< Derived >::dot(), MatrixBase< Derived >::dot(), DynamicSparseMatrix< _Scalar, _Options, _Index >::DynamicSparseMatrix(), SelfAdjointEigenSolver< _MatrixType >::eigenvalues(), EigenSolver< _MatrixType >::eigenvalues(), ComplexEigenSolver< _MatrixType >::eigenvalues(), SelfAdjointEigenSolver< _MatrixType >::eigenvectors(), EigenSolver< _MatrixType >::eigenvectors(), ComplexEigenSolver< _MatrixType >::eigenvectors(), HouseholderSequence< VectorsType, CoeffsType, Side >::essentialVector(), internal::solve_retval< PartialPivLU< _MatrixType >, Rhs >::evalTo(), internal::solve_retval< LDLT< _MatrixType, _UpLo >, Rhs >::evalTo(), internal::solve_retval< JacobiSVD< _MatrixType, QRPreconditioner >, Rhs >::evalTo(), internal::inverse_impl< MatrixType >::evalTo(), internal::solve_retval< HouseholderQR< _MatrixType >, Rhs >::evalTo(), internal::solve_retval< FullPivLU< _MatrixType >, Rhs >::evalTo(), internal::solve_retval< FullPivHouseholderQR< _MatrixType >, Rhs >::evalTo(), internal::solve_retval< ColPivHouseholderQR< _MatrixType >, Rhs >::evalTo(), TriangularBase< Derived >::evalToLazy(), SparseVector< _Scalar, _Options, _Index >::fill(), SparseMatrix< _Scalar, _Options, _Index >::fill(), SparseVector< _Scalar, _Options, _Index >::fillrand(), internal::householder_qr_inplace_unblocked(), Tridiagonalization< _MatrixType >::householderCoefficients(), HessenbergDecomposition< MatrixType >::householderCoefficients(), HouseholderQR< _MatrixType >::householderQ(), ColPivHouseholderQR< _MatrixType >::householderQ(), internal::UpperBidiagonalization< _MatrixType >::householderU(), internal::UpperBidiagonalization< _MatrixType >::householderV(), FullPivLU< _MatrixType >::image(), SelfAdjointEigenSolver< _MatrixType >::info(), RealSchur< MatrixType >::info(), LLT< _MatrixType, _UpLo >::info(), EigenSolver< _MatrixType >::info(), ComplexSchur< MatrixType >::info(), ComplexEigenSolver< _MatrixType >::info(), SparseVector< _Scalar, _Options, _Index >::InnerIterator::InnerIterator(), SparseVector< _Scalar, _Options, _Index >::innerNonZeros(), SparseVector< _Scalar, _Options, _Index >::insert(), SparseVector< _Scalar, _Options, _Index >::insertBackByOuterInner(), SparseMatrix< _Scalar, _Options, _Index >::insertBackByOuterInner(), DynamicSparseMatrix< _Scalar, _Options, _Index >::insertBackByOuterInner(), Transform< _Scalar, _Dim, _Mode >::inverse(), PartialPivLU< _MatrixType >::inverse(), MatrixBase< Derived >::inverse(), FullPivLU< _MatrixType >::inverse(), FullPivHouseholderQR< _MatrixType >::inverse(), ColPivHouseholderQR< _MatrixType >::inverse(), FullPivLU< _MatrixType >::isInjective(), FullPivHouseholderQR< _MatrixType >::isInjective(), ColPivHouseholderQR< _MatrixType >::isInjective(), FullPivLU< _MatrixType >::isInvertible(), FullPivHouseholderQR< _MatrixType >::isInvertible(), ColPivHouseholderQR< _MatrixType >::isInvertible(), LDLT< _MatrixType, _UpLo >::isNegative(), LDLT< _MatrixType, _UpLo >::isPositive(), FullPivLU< _MatrixType >::isSurjective(), FullPivHouseholderQR< _MatrixType >::isSurjective(), ColPivHouseholderQR< _MatrixType >::isSurjective(), FullPivLU< _MatrixType >::kernel(), SparseInnerVectorSet< SparseMatrix< _Scalar, _Options, _Index >, Size >::lastCoeff(), SparseInnerVectorSet< DynamicSparseMatrix< _Scalar, _Options >, Size >::lastCoeff(), TriangularView< _MatrixType, _Mode >::lazyAssign(), SelfCwiseBinaryOp< BinaryOp, Lhs, Rhs >::lazyAssign(), HouseholderQR< _MatrixType >::logAbsDeterminant(), FullPivHouseholderQR< _MatrixType >::logAbsDeterminant(), ColPivHouseholderQR< _MatrixType >::logAbsDeterminant(), internal::make_block_householder_triangular_factor(), MapBase< Derived, ReadOnlyAccessors >::MapBase(), Matrix< Scalar, Rows, HDim >::Matrix(), HessenbergDecomposition< MatrixType >::matrixH(), LLT< _MatrixType, _UpLo >::matrixL(), LDLT< _MatrixType, _UpLo >::matrixL(), LDLT< _MatrixType, _UpLo >::matrixLDLT(), LLT< _MatrixType, _UpLo >::matrixLLT(), PartialPivLU< _MatrixType >::matrixLU(), FullPivLU< _MatrixType >::matrixLU(), Tridiagonalization< _MatrixType >::matrixQ(), HessenbergDecomposition< MatrixType >::matrixQ(), FullPivHouseholderQR< _MatrixType >::matrixQ(), HouseholderQR< _MatrixType >::matrixQR(), FullPivHouseholderQR< _MatrixType >::matrixQR(), ColPivHouseholderQR< _MatrixType >::matrixQR(), Tridiagonalization< _MatrixType >::matrixT(), RealSchur< MatrixType >::matrixT(), ComplexSchur< MatrixType >::matrixT(), RealSchur< MatrixType >::matrixU(), LLT< _MatrixType, _UpLo >::matrixU(), LDLT< _MatrixType, _UpLo >::matrixU(), JacobiSVD< _MatrixType, QRPreconditioner >::matrixU(), ComplexSchur< MatrixType >::matrixU(), JacobiSVD< _MatrixType, QRPreconditioner >::matrixV(), Minor< MatrixType >::Minor(), FullPivLU< _MatrixType >::nonzeroPivots(), ColPivHouseholderQR< _MatrixType >::nonzeroPivots(), JacobiSVD< _MatrixType, QRPreconditioner >::nonzeroSingularValues(), Reverse< MatrixType, Direction >::operator()(), internal::gemm_pack_rhs< Scalar, Index, nr, RowMajor, Conjugate, PanelMode >::operator()(), internal::gemm_pack_rhs< Scalar, Index, nr, ColMajor, Conjugate, PanelMode >::operator()(), internal::gemm_pack_lhs< Scalar, Index, Pack1, Pack2, StorageOrder, Conjugate, PanelMode >::operator()(), internal::linspaced_op< Scalar, RandomAccess >::operator()(), DenseCoeffsBase< Derived, WriteAccessors >::operator()(), DenseCoeffsBase< Derived, ReadOnlyAccessors >::operator()(), Homogeneous< MatrixType, _Direction >::operator*(), CommaInitializer< XprType >::operator,(), TriangularView< _MatrixType, _Mode >::operator=(), DenseCoeffsBase< Derived, WriteAccessors >::operator[](), DenseCoeffsBase< Derived, ReadOnlyAccessors >::operator[](), SelfAdjointEigenSolver< _MatrixType >::operatorInverseSqrt(), SelfAdjointEigenSolver< _MatrixType >::operatorSqrt(), Tridiagonalization< _MatrixType >::packedMatrix(), HessenbergDecomposition< MatrixType >::packedMatrix(), internal::linspaced_op< Scalar, RandomAccess >::packetOp(), internal::partial_lu_inplace(), internal::pdiv< Packet4i >(), PartialPivLU< _MatrixType >::permutationP(), FullPivLU< _MatrixType >::permutationP(), FullPivLU< _MatrixType >::permutationQ(), internal::permute_symm_to_fullsymm(), ProductBase< SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, RhsMode, false >, Lhs, Rhs >::ProductBase(), EigenSolver< _MatrixType >::pseudoEigenvalueMatrix(), EigenSolver< _MatrixType >::pseudoEigenvectors(), FullPivLU< _MatrixType >::rank(), FullPivHouseholderQR< _MatrixType >::rank(), ColPivHouseholderQR< _MatrixType >::rank(), PartialPivLU< _MatrixType >::reconstructedMatrix(), LLT< _MatrixType, _UpLo >::reconstructedMatrix(), LDLT< _MatrixType, _UpLo >::reconstructedMatrix(), FullPivLU< _MatrixType >::reconstructedMatrix(), Replicate< MatrixType, RowFactor, ColFactor >::Replicate(), SparseVector< _Scalar, _Options, _Index >::resize(), PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::resize(), DenseBase< TriangularProduct< Mode, true, Lhs, false, Rhs, true > >::resize(), PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::resizeLike(), FullPivHouseholderQR< _MatrixType >::rowsTranspositions(), internal::sparse_solve_triangular_sparse_selector< Lhs, Rhs, Mode, UpLo, ColMajor >::run(), internal::sparse_solve_triangular_selector< Lhs, Rhs, Mode, Lower, ColMajor >::run(), internal::sparse_solve_triangular_selector< Lhs, Rhs, Mode, Upper, RowMajor >::run(), internal::sparse_solve_triangular_selector< Lhs, Rhs, Mode, Lower, RowMajor >::run(), internal::product_triangular_matrix_vector< Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, RowMajor >::run(), internal::product_triangular_matrix_vector< Index, Mode, LhsScalar, ConjLhs, RhsScalar, ConjRhs, ColMajor >::run(), internal::triangular_assignment_selector< Derived1, Derived2, Mode, UnrollCount, ClearOpposite >::run(), internal::checkTransposeAliasing_impl< Derived, OtherDerived, MightHaveTransposeAliasing >::run(), internal::redux_impl< Func, Derived, LinearVectorizedTraversal, CompleteUnrolling >::run(), internal::redux_impl< Func, Derived, SliceVectorizedTraversal, NoUnrolling >::run(), internal::redux_impl< Func, Derived, LinearVectorizedTraversal, NoUnrolling >::run(), internal::redux_impl< Func, Derived, DefaultTraversal, NoUnrolling >::run(), internal::pow_default_impl< Scalar, true >::run(), internal::product_packet_impl< ColMajor, Dynamic, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_packet_impl< RowMajor, Dynamic, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_coeff_impl< DefaultTraversal, Dynamic, Lhs, Rhs, RetScalar >::run(), TriangularProduct< Mode, false, Lhs, true, Rhs, false >::scaleAndAddTo(), TriangularProduct< Mode, true, Lhs, false, Rhs, true >::scaleAndAddTo(), SparseSelfAdjointTimeDenseProduct< Lhs, Rhs, UpLo >::scaleAndAddTo(), SelfadjointProductMatrix< Lhs, 0, true, Rhs, RhsMode, false >::scaleAndAddTo(), SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, 0, true >::scaleAndAddTo(), SelfadjointProductMatrix< Lhs, LhsMode, false, Rhs, RhsMode, false >::scaleAndAddTo(), GeneralProduct< Lhs, Rhs, GemvProduct >::scaleAndAddTo(), GeneralProduct< Lhs, Rhs, GemmProduct >::scaleAndAddTo(), Select< ConditionMatrixType, ThenMatrixType, ElseMatrixType >::Select(), AmbiVector< _Scalar, _Index >::setZero(), JacobiSVD< _MatrixType, QRPreconditioner >::singularValues(), PartialPivLU< _MatrixType >::solve(), LLT< _MatrixType, _UpLo >::solve(), LDLT< _MatrixType, _UpLo >::solve(), JacobiSVD< _MatrixType, QRPreconditioner >::solve(), HouseholderQR< _MatrixType >::solve(), FullPivLU< _MatrixType >::solve(), FullPivHouseholderQR< _MatrixType >::solve(), ColPivHouseholderQR< _MatrixType >::solve(), SparseTriangularView< MatrixType, Mode >::solveInPlace(), TriangularView< _MatrixType, _Mode >::solveInPlace(), LLT< _MatrixType, _UpLo >::solveInPlace(), LDLT< _MatrixType, _UpLo >::solveInPlace(), internal::sparse_product_impl(), internal::sparse_product_impl2(), SparseDiagonalProduct< Lhs, Rhs >::SparseDiagonalProduct(), SparseInnerVectorSet< SparseMatrix< _Scalar, _Options, _Index >, Size >::SparseInnerVectorSet(), SparseInnerVectorSet< DynamicSparseMatrix< _Scalar, _Options >, Size >::SparseInnerVectorSet(), SparseInnerVectorSet< MatrixType, Size >::SparseInnerVectorSet(), SparseSelfAdjointView< MatrixType, UpLo >::SparseSelfAdjointView(), SparseSparseProduct< LhsNested, RhsNested >::SparseSparseProduct(), SparseVector< _Scalar, _Options, _Index >::startVec(), SparseMatrix< _Scalar, _Options, _Index >::startVec(), Stride< 0, Value >::Stride(), Tridiagonalization< _MatrixType >::subDiagonal(), SparseVector< _Scalar, _Options, _Index >::sum(), SparseMatrix< _Scalar, _Options, _Index >::sum(), SparseMatrixBase< Derived >::sum(), FullPivLU< _MatrixType >::threshold(), ColPivHouseholderQR< _MatrixType >::threshold(), Hyperplane< _Scalar, _AmbientDim >::transform(), Translation< _Scalar, _Dim >::Translation(), LDLT< _MatrixType, _UpLo >::transpositionsP(), TriangularBase< SelfAdjointView< MatrixType, UpLo > >::TriangularBase(), internal::tridiagonalization_inplace(), internal::llt_inplace< Lower >::unblocked(), internal::ldlt_inplace< Lower >::unblocked(), LDLT< _MatrixType, _UpLo >::vectorD(), and CommaInitializer< XprType >::~CommaInitializer().

#define EIGEN_CAT (   a,
 
)    EIGEN_CAT2(a,b)

Definition at line 243 of file Macros.h.

#define EIGEN_CAT2 (   a,
 
)    a ## b

Definition at line 242 of file Macros.h.

#define EIGEN_CWISE_PRODUCT_RETURN_TYPE (   LHS,
  RHS 
)
Value:
CwiseBinaryOp< \
      internal::scalar_product_op< \
          typename internal::traits<LHS>::Scalar, \
          typename internal::traits<RHS>::Scalar \
      >, \
      LHS, \
      RHS \
    >

Definition at line 352 of file Macros.h.

Referenced by EIGEN_CWISE_PRODUCT_RETURN_TYPE().

#define EIGEN_DEBUG_VAR (   x)    std::cerr << #x << " = " << x << std::endl;

Definition at line 110 of file Macros.h.

#define EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS

Definition at line 175 of file Macros.h.

#define EIGEN_DEFAULT_DENSE_INDEX_TYPE   std::ptrdiff_t

Definition at line 98 of file Macros.h.

#define EIGEN_DEFAULT_IO_FORMAT   Eigen::IOFormat()

Definition at line 235 of file Macros.h.

Referenced by DenseBase< Derived >::operator<<().

#define EIGEN_DEFAULT_MATRIX_STORAGE_ORDER_OPTION   ColMajor

Definition at line 94 of file Macros.h.

#define EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS   inline

Definition at line 176 of file Macros.h.

#define EIGEN_DENSE_PUBLIC_INTERFACE (   Derived)
Value:
typedef typename Eigen::internal::traits<Derived>::Scalar Scalar; /*!< \brief Numeric type, e.g. float, double, int or std::complex<float>. */ \
  typedef typename Eigen::NumTraits<Scalar>::Real RealScalar; /*!< \brief The underlying numeric type for composed scalar types. \details In cases where Scalar is e.g. std::complex<T>, T were corresponding to RealScalar. */ \
  typedef typename Base::PacketScalar PacketScalar; \
  typedef typename Base::CoeffReturnType CoeffReturnType; /*!< \brief The return type for coefficient access. \details Depending on whether the object allows direct coefficient access (e.g. for a MatrixXd), this type is either 'const Scalar&' or simply 'Scalar' for objects that do not allow direct coefficient access. */ \
  typedef typename Eigen::internal::nested<Derived>::type Nested; \
  typedef typename Eigen::internal::traits<Derived>::StorageKind StorageKind; \
  typedef typename Eigen::internal::traits<Derived>::Index Index; \
  enum { RowsAtCompileTime = Eigen::internal::traits<Derived>::RowsAtCompileTime, \
        ColsAtCompileTime = Eigen::internal::traits<Derived>::ColsAtCompileTime, \
        MaxRowsAtCompileTime = Eigen::internal::traits<Derived>::MaxRowsAtCompileTime, \
        MaxColsAtCompileTime = Eigen::internal::traits<Derived>::MaxColsAtCompileTime, \
        Flags = Eigen::internal::traits<Derived>::Flags, \
        CoeffReadCost = Eigen::internal::traits<Derived>::CoeffReadCost, \
        SizeAtCompileTime = Base::SizeAtCompileTime, \
        MaxSizeAtCompileTime = Base::MaxSizeAtCompileTime, \
        IsVectorAtCompileTime = Base::IsVectorAtCompileTime }; \
  using Base::derived; \
  using Base::const_cast_derived;

Definition at line 293 of file Macros.h.

#define EIGEN_DEPRECATED

Definition at line 183 of file Macros.h.

#define EIGEN_DOCS_IO_FORMAT   IOFormat(3, 0, " ", "\n", "", "")

Definition at line 251 of file Macros.h.

#define EIGEN_DONT_INLINE

Definition at line 168 of file Macros.h.

#define EIGEN_EMPTY

Definition at line 239 of file Macros.h.

#define EIGEN_FAST_MATH   1

Allows to disable some optimizations which might affect the accuracy of the result.

Such optimization are enabled by default, and set EIGEN_FAST_MATH to 0 to disable them. They currently include:

  • single precision Cwise::sin() and Cwise::cos() when SSE vectorization is enabled.

Definition at line 107 of file Macros.h.

#define EIGEN_FLATTEN_ATTRIB

Definition at line 153 of file Macros.h.

#define EIGEN_GCC3_OR_OLDER   0

Definition at line 45 of file Macros.h.

#define EIGEN_GCC_AND_ARCH_DOESNT_WANT_STACK_ALIGNMENT   0

Definition at line 58 of file Macros.h.

#define EIGEN_GENERIC_PUBLIC_INTERFACE (   Derived)
Value:
typedef typename Eigen::internal::traits<Derived>::Scalar Scalar; /*!< \brief Numeric type, e.g. float, double, int or std::complex<float>. */ \
  typedef typename Eigen::NumTraits<Scalar>::Real RealScalar; /*!< \brief The underlying numeric type for composed scalar types. \details In cases where Scalar is e.g. std::complex<T>, T were corresponding to RealScalar. */ \
  typedef typename Base::CoeffReturnType CoeffReturnType; /*!< \brief The return type for coefficient access. \details Depending on whether the object allows direct coefficient access (e.g. for a MatrixXd), this type is either 'const Scalar&' or simply 'Scalar' for objects that do not allow direct coefficient access. */ \
  typedef typename Eigen::internal::nested<Derived>::type Nested; \
  typedef typename Eigen::internal::traits<Derived>::StorageKind StorageKind; \
  typedef typename Eigen::internal::traits<Derived>::Index Index; \
  enum { RowsAtCompileTime = Eigen::internal::traits<Derived>::RowsAtCompileTime, \
        ColsAtCompileTime = Eigen::internal::traits<Derived>::ColsAtCompileTime, \
        Flags = Eigen::internal::traits<Derived>::Flags, \
        CoeffReadCost = Eigen::internal::traits<Derived>::CoeffReadCost, \
        SizeAtCompileTime = Base::SizeAtCompileTime, \
        MaxSizeAtCompileTime = Base::MaxSizeAtCompileTime, \
        IsVectorAtCompileTime = Base::IsVectorAtCompileTime };

Just a side note.

Commenting within defines works only by documenting behind the object (via '!<'). Comments cannot be multi-line and thus we have these extra long lines. What is confusing doxygen over here is that we use '\' and basically have a bunch of typedefs with their documentation in a single line.

Definition at line 277 of file Macros.h.

#define EIGEN_GNUC_AT_LEAST (   x,
 
)    0

Definition at line 39 of file Macros.h.

#define EIGEN_IMPLIES (   a,
 
)    (!(a) || (b))
#define EIGEN_INHERIT_ASSIGNMENT_EQUAL_OPERATOR (   Derived)
Value:
using Base::operator =; \
  EIGEN_STRONG_INLINE Derived& operator=(const Derived& other) \
  { \
    Base::operator=(other); \
    return *this; \
  }

Definition at line 257 of file Macros.h.

#define EIGEN_INHERIT_ASSIGNMENT_OPERATORS (   Derived)    EIGEN_INHERIT_ASSIGNMENT_EQUAL_OPERATOR(Derived)

Definition at line 266 of file Macros.h.

#define eigen_internal_assert (   x)
#define EIGEN_LOGICAL_XOR (   a,
 
)    (((a) || (b)) && !((a) && (b)))
#define EIGEN_MAJOR_VERSION   92

Definition at line 30 of file Macros.h.

#define EIGEN_MAKE_CWISE_BINARY_OP (   METHOD,
  FUNCTOR 
)
Value:
template<typename OtherDerived> \
  EIGEN_STRONG_INLINE const CwiseBinaryOp<FUNCTOR<Scalar>, Derived, OtherDerived> \
  METHOD(const EIGEN_CURRENT_STORAGE_BASE_CLASS<OtherDerived> &other) const \
  { \
    return CwiseBinaryOp<FUNCTOR<Scalar>, Derived, OtherDerived>(derived(), other.derived()); \
  }

Definition at line 343 of file Macros.h.

#define EIGEN_MAKESTRING (   a)    EIGEN_MAKESTRING2(a)

Definition at line 247 of file Macros.h.

#define EIGEN_MAKESTRING2 (   a)    #a

Definition at line 246 of file Macros.h.

#define EIGEN_MINOR_VERSION   0

Definition at line 31 of file Macros.h.

#define EIGEN_ONLY_USED_FOR_DEBUG (   x)
#define EIGEN_PLAIN_ENUM_MAX (   a,
 
)    (((int)a >= (int)b) ? (int)a : (int)b)
#define EIGEN_PLAIN_ENUM_MIN (   a,
 
)    (((int)a <= (int)b) ? (int)a : (int)b)

Definition at line 314 of file Macros.h.

Referenced by internal::inverse_impl< MatrixType >::evalTo().

#define EIGEN_RESTRICT   __restrict
#define EIGEN_SIZE_MAX (   a,
 
)
Value:
(((int)a == Dynamic || (int)b == Dynamic) ? Dynamic \
                           : ((int)a >= (int)b) ? (int)a : (int)b)

Definition at line 336 of file Macros.h.

#define EIGEN_SIZE_MIN_PREFER_DYNAMIC (   a,
 
)
Value:
(((int)a == 0 || (int)b == 0) ? 0 \
                           : ((int)a == 1 || (int)b == 1) ? 1 \
                           : ((int)a == Dynamic || (int)b == Dynamic) ? Dynamic \
                           : ((int)a <= (int)b) ? (int)a : (int)b)

Definition at line 320 of file Macros.h.

Referenced by umeyama().

#define EIGEN_SIZE_MIN_PREFER_FIXED (   a,
 
)
Value:
(((int)a == 0 || (int)b == 0) ? 0 \
                           : ((int)a == 1 || (int)b == 1) ? 1 \
                           : ((int)a == Dynamic && (int)b == Dynamic) ? Dynamic \
                           : ((int)a == Dynamic) ? (int)b \
                           : ((int)b == Dynamic) ? (int)a \
                           : ((int)a <= (int)b) ? (int)a : (int)b)

Definition at line 328 of file Macros.h.

#define EIGEN_STACK_ALLOCATION_LIMIT   20000

Definition at line 231 of file Macros.h.

#define EIGEN_STRONG_INLINE   inline

Definition at line 160 of file Macros.h.

#define EIGEN_UNUSED

Definition at line 189 of file Macros.h.

#define EIGEN_UNUSED_VARIABLE (   var)    (void)var;
#define EIGEN_VERSION_AT_LEAST (   x,
  y,
 
)
Value:

Definition at line 33 of file Macros.h.

#define EIGEN_WORLD_VERSION   2

Definition at line 29 of file Macros.h.




Page generated by Doxygen 1.7.3 for MRPT 0.9.4 SVN: at Sat Mar 26 06:16:28 UTC 2011