Applies the clock wise 2D rotation j to the set of 2D vectors of cordinates x and y:
typedef __vector unsigned char internal::Packet16uc |
Definition at line 52 of file AltiVec/PacketMath.h.
typedef __m128d internal::Packet2d |
Definition at line 40 of file SSE/PacketMath.h.
typedef __vector __bool int internal::Packet4bi |
Definition at line 50 of file AltiVec/PacketMath.h.
typedef __m128 internal::Packet4f |
Definition at line 47 of file AltiVec/PacketMath.h.
typedef __m128i internal::Packet4i |
Definition at line 48 of file AltiVec/PacketMath.h.
typedef uint32x4_t internal::Packet4ui |
Definition at line 49 of file AltiVec/PacketMath.h.
typedef __vector short int internal::Packet8i |
Definition at line 51 of file AltiVec/PacketMath.h.
anonymous enum |
Definition at line 65 of file SparseDiagonalProduct.h.
anonymous enum |
Definition at line 42 of file JacobiSVD.h.
static internal::_EIGEN_DECLARE_CONST_FAST_Packet4f | ( | ZERO | , |
0 | |||
) | [static] |
static internal::_EIGEN_DECLARE_CONST_FAST_Packet4i | ( | ZERO | , |
0 | |||
) | [static] |
static internal::_EIGEN_DECLARE_CONST_FAST_Packet4i | ( | ONE | , |
1 | |||
) | [static] |
static internal::_EIGEN_DECLARE_CONST_FAST_Packet4i | ( | MINUS16 | , |
- | 16 | ||
) | [static] |
static internal::_EIGEN_DECLARE_CONST_FAST_Packet4i | ( | MINUS1 | , |
- | 1 | ||
) | [static] |
void internal::aligned_delete | ( | T * | ptr, |
size_t | size | ||
) | [inline] |
Definition at line 349 of file Memory.h.
References aligned_free(), and mrpt::math::size().
Referenced by internal::gemm_blocking_space< StorageOrder, _LhsScalar, _RhsScalar, MaxRows, MaxCols, MaxDepth, false >::~gemm_blocking_space().
void internal::aligned_free | ( | void * | p | ) | [inline] |
Frees a memory block reserved by aligned_malloc.
Definition at line 202 of file Memory.h.
References handmade_aligned_free().
Referenced by aligned_delete(), conditional_aligned_free(), aligned_allocator< T >::deallocate(), generic_aligned_realloc(), and mrpt::math::CMatrixTemplate< TPoint3D >::realloc().
void * internal::aligned_malloc | ( | size_t | size | ) | [inline] |
Definition at line 173 of file Memory.h.
References eigen_assert, and handmade_aligned_malloc().
Referenced by aligned_new(), conditional_aligned_malloc(), and generic_aligned_realloc().
T* internal::aligned_new | ( | size_t | size | ) | [inline] |
Definition at line 334 of file Memory.h.
References aligned_malloc(), and construct_elements_of_array().
void* internal::aligned_realloc | ( | void * | old_ptr, |
size_t | bytes, | ||
size_t | alignment | ||
) | [inline] |
Frees a memory block reserved by aligned_malloc.
alignment | The desired alignment, typ. 8 or 16 bytes. 1 means no alignment required. If old_ptr is NULL, a new block will be reserved from scratch. |
Definition at line 224 of file Memory.h.
References EIGEN_UNUSED_VARIABLE, generic_aligned_realloc(), and handmade_aligned_realloc().
Referenced by conditional_aligned_realloc(), and mrpt::math::CMatrixTemplate< TPoint3D >::realloc().
void internal::apply_block_householder_on_the_left | ( | MatrixType & | mat, |
const VectorsType & | vectors, | ||
const CoeffsType & | hCoeffs | ||
) |
Definition at line 59 of file BlockHouseholder.h.
References TriangularView< _MatrixType, _Mode >::adjoint(), and make_block_householder_triangular_factor().
Referenced by householder_qr_inplace_blocked().
void internal::apply_rotation_in_the_plane | ( | VectorX & | _x, |
VectorY & | _y, | ||
const JacobiRotation< OtherScalar > & | j | ||
) |
Definition at line 306 of file Jacobi.h.
References AlignedBit, JacobiRotation< Scalar >::c(), Dynamic, eigen_assert, EIGEN_RESTRICT, first_aligned(), IsComplex, PacketAccessBit, padd(), pmul(), pstore(), pstoreu(), psub(), JacobiRotation< Scalar >::s(), mrpt::math::size(), and y.
Referenced by MatrixBase< Derived >::applyOnTheLeft(), and MatrixBase< Derived >::applyOnTheRight().
const Derived::Scalar internal::bruteforce_det3_helper | ( | const MatrixBase< Derived > & | matrix, |
int | a, | ||
int | b, | ||
int | c | ||
) | [inline] |
Definition at line 32 of file Determinant.h.
Referenced by internal::determinant_impl< Derived, 3 >::run().
const Derived::Scalar internal::bruteforce_det4_helper | ( | const MatrixBase< Derived > & | matrix, |
int | j, | ||
int | k, | ||
int | m, | ||
int | n | ||
) |
Definition at line 40 of file Determinant.h.
Referenced by internal::determinant_impl< Derived, 4 >::run().
NewType internal::cast | ( | const OldType & | x | ) | [inline] |
Definition at line 409 of file Core/MathFunctions.h.
References internal::cast_impl< OldType, NewType >::run().
MatrixType::Scalar internal::cofactor_3x3 | ( | const MatrixType & | m | ) | [inline] |
MatrixType::Scalar internal::cofactor_4x4 | ( | const MatrixType & | matrix | ) | [inline] |
Definition at line 209 of file Inverse.h.
References general_det3_helper().
void internal::compute_inverse_size2_helper | ( | const MatrixType & | matrix, |
const typename ResultType::Scalar & | invdet, | ||
ResultType & | result | ||
) | [inline] |
Definition at line 82 of file Inverse.h.
Referenced by internal::compute_inverse_and_det_with_check< MatrixType, ResultType, 2 >::run(), and internal::compute_inverse< MatrixType, ResultType, 2 >::run().
void internal::compute_inverse_size3_helper | ( | const MatrixType & | matrix, |
const typename ResultType::Scalar & | invdet, | ||
const Matrix< typename ResultType::Scalar, 3, 1 > & | cofactors_col0, | ||
ResultType & | result | ||
) | [inline] |
Definition at line 141 of file Inverse.h.
References PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::coeffRef().
Referenced by internal::compute_inverse_and_det_with_check< MatrixType, ResultType, 3 >::run(), and internal::compute_inverse< MatrixType, ResultType, 3 >::run().
void internal::computeProductBlockingSizes | ( | std::ptrdiff_t & | k, |
std::ptrdiff_t & | m, | ||
std::ptrdiff_t & | n | ||
) |
Computes the blocking parameters for a m x k times k x n matrix product.
[in,out] | k | Input: the third dimension of the product. Output: the blocking size along the same dimension. |
[in,out] | m | Input: the number of rows of the left hand side. Output: the blocking size along the same dimension. |
[in,out] | n | Input: the number of columns of the right hand side. Output: the blocking size along the same dimension. |
Given a m x k times k x n matrix product of scalar types LhsScalar
and RhsScalar
, this function computes the blocking size parameters along the respective dimensions for matrix products and related algorithms. The blocking sizes depends on various parameters:
Definition at line 82 of file GeneralBlockPanelKernel.h.
References GetAction, and manage_caching_sizes().
void internal::computeProductBlockingSizes | ( | std::ptrdiff_t & | k, |
std::ptrdiff_t & | m, | ||
std::ptrdiff_t & | n | ||
) | [inline] |
Definition at line 109 of file GeneralBlockPanelKernel.h.
void internal::conditional_aligned_delete | ( | T * | ptr, |
size_t | size | ||
) | [inline] |
Definition at line 358 of file Memory.h.
References mrpt::math::size().
void internal::conditional_aligned_free | ( | void * | ptr | ) | [inline] |
Definition at line 283 of file Memory.h.
References aligned_free().
void internal::conditional_aligned_free< false > | ( | void * | ptr | ) | [inline] |
void* internal::conditional_aligned_malloc | ( | size_t | size | ) | [inline] |
Definition at line 264 of file Memory.h.
References aligned_malloc().
void* internal::conditional_aligned_malloc< false > | ( | size_t | size | ) | [inline] |
Definition at line 269 of file Memory.h.
References eigen_assert, and mrpt::math::size().
T* internal::conditional_aligned_new | ( | size_t | size | ) | [inline] |
Definition at line 340 of file Memory.h.
References construct_elements_of_array().
void* internal::conditional_aligned_realloc | ( | void * | ptr, |
size_t | new_size, | ||
size_t | old_size | ||
) | [inline] |
Definition at line 293 of file Memory.h.
References aligned_realloc().
void* internal::conditional_aligned_realloc< false > | ( | void * | ptr, |
size_t | new_size, | ||
size_t | |||
) | [inline] |
T* internal::conditional_aligned_realloc_new | ( | T * | pts, |
size_t | new_size, | ||
size_t | old_size | ||
) | [inline] |
Definition at line 364 of file Memory.h.
References construct_elements_of_array().
T* internal::construct_elements_of_array | ( | T * | ptr, |
size_t | size | ||
) | [inline] |
Definition at line 310 of file Memory.h.
References mrpt::math::size().
Referenced by aligned_new(), conditional_aligned_new(), and conditional_aligned_realloc_new().
void internal::destruct_elements_of_array | ( | T * | ptr, |
size_t | size | ||
) | [inline] |
Definition at line 319 of file Memory.h.
References mrpt::math::size().
internal::EIGEN_MATHFUNC_RETVAL | ( | real | , |
Scalar | |||
) | const [inline] |
Definition at line 101 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and real().
internal::EIGEN_MATHFUNC_RETVAL | ( | imag | , |
Scalar | |||
) | const [inline] |
Definition at line 136 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and imag().
internal::EIGEN_MATHFUNC_RETVAL | ( | real_ref | , |
Scalar | |||
) | [inline] |
Definition at line 172 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and real_ref().
internal::EIGEN_MATHFUNC_RETVAL | ( | imag_ref | , |
Scalar | |||
) | [inline] |
Definition at line 224 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and imag_ref().
internal::EIGEN_MATHFUNC_RETVAL | ( | conj | , |
Scalar | |||
) | const [inline] |
Definition at line 258 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL.
internal::EIGEN_MATHFUNC_RETVAL | ( | abs | , |
Scalar | |||
) | const [inline] |
Definition at line 284 of file Core/MathFunctions.h.
References abs(), and EIGEN_MATHFUNC_IMPL.
internal::EIGEN_MATHFUNC_RETVAL | ( | abs2 | , |
Scalar | |||
) | const [inline] |
Definition at line 319 of file Core/MathFunctions.h.
References abs2(), and EIGEN_MATHFUNC_IMPL.
internal::EIGEN_MATHFUNC_RETVAL | ( | norm1 | , |
Scalar | |||
) | const [inline] |
Definition at line 357 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL.
internal::EIGEN_MATHFUNC_RETVAL | ( | hypot | , |
Scalar | |||
) | const [inline] |
internal::EIGEN_MATHFUNC_RETVAL | ( | sqrt | , |
Scalar | |||
) | const [inline] |
Definition at line 447 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and sqrt().
internal::EIGEN_MATHFUNC_RETVAL | ( | exp | , |
Scalar | |||
) | const [inline] |
Definition at line 485 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and exp().
internal::EIGEN_MATHFUNC_RETVAL | ( | cos | , |
Scalar | |||
) | const [inline] |
Definition at line 523 of file Core/MathFunctions.h.
References cos(), and EIGEN_MATHFUNC_IMPL.
internal::EIGEN_MATHFUNC_RETVAL | ( | sin | , |
Scalar | |||
) | const [inline] |
Definition at line 561 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and sin().
internal::EIGEN_MATHFUNC_RETVAL | ( | log | , |
Scalar | |||
) | const [inline] |
Definition at line 599 of file Core/MathFunctions.h.
References EIGEN_MATHFUNC_IMPL, and log().
internal::EIGEN_MATHFUNC_RETVAL | ( | atan2 | , |
Scalar | |||
) | const [inline] |
internal::EIGEN_MATHFUNC_RETVAL | ( | random | , |
Scalar | |||
) | const [inline] |
internal::EIGEN_MATHFUNC_RETVAL | ( | pow | , |
Scalar | |||
) | const [inline] |
internal::EIGEN_MEMBER_FUNCTOR | ( | minCoeff | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | count | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | squaredNorm | , |
Size *NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | norm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | stableNorm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | blueNorm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | hypotNorm | , |
(Size-1)*functor_traits< scalar_hypot_op< Scalar > >::Cost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | sum | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | mean | , |
(Size-1)*NumTraits< Scalar >::AddCost+NumTraits< Scalar >::MulCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | maxCoeff | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | all | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | any | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
internal::EIGEN_MEMBER_FUNCTOR | ( | prod | , |
(Size-1)*NumTraits< Scalar >::MulCost | |||
) |
const T::Scalar* internal::extract_data | ( | const T & | m | ) |
Definition at line 266 of file BlasUtil.h.
References internal::extract_data_selector< T, HasUsableDirectAccess >::run().
Referenced by internal::transposition_matrix_product_retval< TranspositionType, MatrixType, Side, Transposed >::evalTo(), internal::permut_matrix_product_retval< PermutationType, MatrixType, Side, Transposed >::evalTo(), internal::inverse_impl< MatrixType >::evalTo(), HouseholderSequence< VectorsType, CoeffsType, Side >::evalTo(), internal::checkTransposeAliasing_impl< Derived, OtherDerived, MightHaveTransposeAliasing >::run(), internal::check_transpose_aliasing_run_time_selector< Scalar, DestIsTransposed, CwiseBinaryOp< BinOp, DerivedA, DerivedB > >::run(), and internal::check_transpose_aliasing_run_time_selector< Scalar, DestIsTransposed, OtherDerived >::run().
static Derived::Index internal::first_aligned | ( | const Derived & | m | ) | [inline, static] |
Definition at line 722 of file DenseCoeffsBase.h.
References AlignedBit, and DirectAccessBit.
Referenced by apply_rotation_in_the_plane(), product_selfadjoint_vector(), internal::redux_impl< Func, Derived, LinearVectorizedTraversal, NoUnrolling >::run(), internal::general_matrix_vector_product< Index, LhsScalar, RowMajor, ConjugateLhs, RhsScalar, ConjugateRhs >::run(), internal::general_matrix_vector_product< Index, LhsScalar, ColMajor, ConjugateLhs, RhsScalar, ConjugateRhs >::run(), internal::first_aligned_impl< Derived, false >::run(), internal::assign_impl< Derived1, Derived2, SliceVectorizedTraversal, NoUnrolling >::run(), internal::assign_impl< Derived1, Derived2, LinearVectorizedTraversal, NoUnrolling >::run(), and MatrixBase< Derived >::stableNorm().
static Index internal::first_aligned | ( | const Scalar * | array, |
Index | size | ||
) | [inline, static] |
Definition at line 391 of file Memory.h.
References mrpt::math::size().
EIGEN_STRONG_INLINE void internal::gebp_madd | ( | const CJ & | cj, |
A & | a, | ||
B & | b, | ||
C & | c, | ||
T & | t | ||
) |
Definition at line 135 of file GeneralBlockPanelKernel.h.
References internal::gebp_madd_selector< CJ, A, B, C, T >::run().
const Derived::Scalar internal::general_det3_helper | ( | const MatrixBase< Derived > & | matrix, |
int | i1, | ||
int | i2, | ||
int | i3, | ||
int | j1, | ||
int | j2, | ||
int | j3 | ||
) | [inline] |
Definition at line 202 of file Inverse.h.
Referenced by cofactor_4x4().
void* internal::generic_aligned_realloc | ( | void * | ptr, |
size_t | size, | ||
size_t | old_size | ||
) | [inline] |
Definition at line 137 of file Memory.h.
References aligned_free(), aligned_malloc(), and mrpt::system::os::memcpy().
Referenced by aligned_realloc().
void internal::handmade_aligned_free | ( | void * | ptr | ) | [inline] |
Definition at line 104 of file Memory.h.
Referenced by aligned_free().
void* internal::handmade_aligned_malloc | ( | size_t | size | ) | [inline] |
Definition at line 94 of file Memory.h.
Referenced by aligned_malloc(), and handmade_aligned_realloc().
void* internal::handmade_aligned_realloc | ( | void * | ptr, |
size_t | size, | ||
size_t | = 0 |
||
) | [inline] |
Definition at line 114 of file Memory.h.
References handmade_aligned_malloc().
Referenced by aligned_realloc().
void internal::householder_qr_inplace_blocked | ( | MatrixQR & | mat, |
HCoeffs & | hCoeffs, | ||
typename MatrixQR::Index | maxBlockSize = 32 , |
||
typename MatrixQR::Scalar * | tempData = 0 |
||
) |
Definition at line 242 of file HouseholderQR.h.
References apply_block_householder_on_the_left(), householder_qr_inplace_unblocked(), PlainObjectBase< Derived >::resize(), Block< XprType, BlockRows, BlockCols, InnerPanel, HasDirectAccess >::rows(), and mrpt::math::size().
Referenced by HouseholderQR< _MatrixType >::compute().
void internal::householder_qr_inplace_unblocked | ( | MatrixQR & | mat, |
HCoeffs & | hCoeffs, | ||
typename MatrixQR::Scalar * | tempData = 0 |
||
) |
Definition at line 206 of file HouseholderQR.h.
References eigen_assert, PlainObjectBase< Derived >::resize(), and mrpt::math::size().
Referenced by householder_qr_inplace_blocked().
add_const_on_value_type< EIGEN_MATHFUNC_RETVAL(imag_ref, Scalar) >::type internal::imag_ref | ( | const Scalar & | x | ) | [inline] |
Definition at line 218 of file Core/MathFunctions.h.
References internal::imag_ref_default_impl< Scalar, NumTraits< Scalar >::IsComplex >::run().
Referenced by EIGEN_MATHFUNC_RETVAL(), and internal::scalar_imag_ref_op< Scalar >::operator()().
bool internal::isApprox | ( | const Scalar & | x, |
const Scalar & | y, | ||
typename NumTraits< Scalar >::Real | precision = NumTraits<Scalar>::dummy_precision() |
||
) | [inline] |
Definition at line 838 of file Core/MathFunctions.h.
Referenced by internal::scalar_fuzzy_default_impl< Scalar, false, false >::isApproxOrLessThan(), DenseBase< Derived >::isApproxToConstant(), MatrixBase< Derived >::isIdentity(), and MatrixBase< Derived >::isUnitary().
bool internal::isApproxOrLessThan | ( | const Scalar & | x, |
const Scalar & | y, | ||
typename NumTraits< Scalar >::Real | precision = NumTraits<Scalar>::dummy_precision() |
||
) | [inline] |
Definition at line 845 of file Core/MathFunctions.h.
bool internal::isMuchSmallerThan | ( | const Scalar & | x, |
const OtherScalar & | y, | ||
typename NumTraits< Scalar >::Real | precision = NumTraits<Scalar>::dummy_precision() |
||
) | [inline] |
Definition at line 831 of file Core/MathFunctions.h.
References y.
Referenced by SelfAdjointEigenSolver< _MatrixType >::compute(), FullPivHouseholderQR< _MatrixType >::compute(), EigenSolver< _MatrixType >::eigenvectors(), internal::solve_retval< FullPivHouseholderQR< _MatrixType >, Rhs >::evalTo(), SparseView< MatrixType >::InnerIterator::incrementToNonZero(), Hyperplane< _Scalar, _AmbientDim >::intersection(), MatrixBase< Derived >::isDiagonal(), MatrixBase< Derived >::isIdentity(), MatrixBase< Derived >::isUnitary(), DenseBase< Derived >::isZero(), SparseMatrix< _Scalar, _Options, _Index >::default_prunning_func::operator()(), CompressedStorage< Scalar, Index >::prune(), EigenSolver< _MatrixType >::pseudoEigenvalueMatrix(), internal::unitOrthogonal_selector< Derived, 3 >::run(), ComplexSchur< MatrixType >::subdiagonalEntryIsNeglegible(), and umeyama().
void internal::make_block_householder_triangular_factor | ( | TriangularFactorType & | triFactor, |
const VectorsType & | vectors, | ||
const CoeffsType & | hCoeffs | ||
) |
Definition at line 35 of file BlockHouseholder.h.
References eigen_assert.
Referenced by apply_block_householder_on_the_left().
void internal::manage_caching_sizes | ( | Action | action, |
std::ptrdiff_t * | l1 = 0 , |
||
std::ptrdiff_t * | l2 = 0 |
||
) | [inline] |
Definition at line 34 of file GeneralBlockPanelKernel.h.
References eigen_internal_assert, GetAction, queryL1CacheSize(), queryTopLevelCacheSize(), and SetAction.
Referenced by computeProductBlockingSizes(), l1CacheSize(), l2CacheSize(), and setCpuCacheSizes().
void internal::manage_multi_threading | ( | Action | action, |
int * | v | ||
) | [inline] |
Definition at line 31 of file Parallelizer.h.
References eigen_internal_assert, GetAction, and SetAction.
Referenced by nbThreads(), and setNbThreads().
int internal::nbThreads | ( | ) | [inline] |
Definition at line 60 of file Parallelizer.h.
References GetAction, and manage_multi_threading().
Referenced by parallelize_gemm().
EIGEN_STRONG_INLINE Packet2d internal::pabs | ( | const Packet2d & | a | ) |
Definition at line 320 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pabs | ( | const Packet4f & | a | ) |
Definition at line 348 of file AltiVec/PacketMath.h.
Referenced by internal::scalar_abs_op< Scalar >::packetOp(), pcos< Packet4f >(), and psin< Packet4f >().
EIGEN_STRONG_INLINE Packet4i internal::pabs | ( | const Packet4i & | a | ) |
Definition at line 349 of file AltiVec/PacketMath.h.
Packet internal::pabs | ( | const Packet & | a | ) | [inline] |
Definition at line 146 of file GenericPacketMath.h.
References abs().
Packet internal::padd | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 108 of file GenericPacketMath.h.
Referenced by internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::acc(), apply_rotation_in_the_plane(), internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::madd(), internal::gebp_traits< _LhsScalar, _RhsScalar, _ConjLhs, _ConjRhs >::madd(), internal::gebp_traits< RealScalar, std::complex< RealScalar >, false, _ConjRhs >::madd_impl(), internal::gebp_traits< std::complex< RealScalar >, RealScalar, _ConjLhs, false >::madd_impl(), internal::scalar_add_op< Scalar >::packetOp(), internal::linspaced_op_impl< Scalar, true >::packetOp(), internal::linspaced_op_impl< Scalar, false >::packetOp(), internal::scalar_sum_op< Scalar >::packetOp(), pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), pmadd(), internal::conj_helper< Packet1cd, Packet2d, false, false >::pmadd(), internal::conj_helper< Packet2d, Packet1cd, false, false >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, true, true >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, true, false >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, false, true >::pmadd(), internal::conj_helper< Packet2cf, Packet4f, false, false >::pmadd(), internal::conj_helper< Packet4f, Packet2cf, false, false >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, true, true >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, true, false >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, false, true >::pmadd(), internal::conj_helper< RealScalar, std::complex< RealScalar >, false, Conj >::pmadd(), internal::conj_helper< std::complex< RealScalar >, RealScalar, Conj, false >::pmadd(), predux< Packet2cf >(), preduxp< Packet2cf >(), psin< Packet4f >(), internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run(), internal::gebp_madd_selector< CJ, T, T, T, T >::run(), and internal::product_coeff_vectorized_unroller< UnrollingIndex, Lhs, Rhs, Packet >::run().
EIGEN_STRONG_INLINE Packet1cd internal::padd< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 266 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::padd< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 82 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::padd< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 136 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::padd< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 183 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::padd< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 184 of file AltiVec/PacketMath.h.
void internal::palign | ( | PacketType & | first, |
const PacketType & | second | ||
) | [inline] |
Definition at line 296 of file GenericPacketMath.h.
References internal::palign_impl< Offset, PacketType >::run().
Packet internal::pand | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 150 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::pand< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 290 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::pand< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 106 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::pand< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 205 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pand< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 260 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pand< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 261 of file AltiVec/PacketMath.h.
Packet internal::pandnot | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 162 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::pandnot< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 293 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::pandnot< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 109 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::pandnot< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 217 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pandnot< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 269 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pandnot< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 270 of file AltiVec/PacketMath.h.
void internal::parallelize_gemm | ( | const Functor & | func, |
Index | rows, | ||
Index | cols, | ||
bool | transpose | ||
) |
Definition at line 86 of file Parallelizer.h.
References EIGEN_UNUSED_VARIABLE, nbThreads(), internal::GemmParallelInfo< Index >::rhs_length, internal::GemmParallelInfo< Index >::rhs_start, and mrpt::math::size().
void internal::partial_lu_inplace | ( | MatrixType & | lu, |
TranspositionType & | row_transpositions, | ||
typename MatrixType::Index & | nb_transpositions | ||
) |
Definition at line 395 of file PartialPivLU.h.
References ColMajor, eigen_assert, RowMajor, and RowMajorBit.
Referenced by PartialPivLU< _MatrixType >::compute().
Packet internal::pconj | ( | const Packet & | a | ) | [inline] |
Definition at line 122 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::pconj | ( | const Packet1cd & | a | ) |
Definition at line 269 of file SSE/Complex.h.
References internal::Packet1cd::v.
EIGEN_STRONG_INLINE Packet2cf internal::pconj | ( | const Packet2cf & | a | ) |
Definition at line 85 of file AltiVec/Complex.h.
References p4ui_CONJ_XOR, and internal::Packet2cf::v.
Referenced by internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::acc(), internal::scalar_conjugate_op< Scalar >::packetOp(), internal::conj_helper< Packet1cd, Packet1cd, true, true >::pmul(), internal::conj_helper< Packet1cd, Packet1cd, true, false >::pmul(), internal::conj_helper< Packet1cd, Packet1cd, false, true >::pmul(), internal::conj_helper< Packet2cf, Packet2cf, true, true >::pmul(), internal::conj_helper< Packet2cf, Packet2cf, true, false >::pmul(), and internal::conj_helper< Packet2cf, Packet2cf, false, true >::pmul().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet internal::pcos | ( | const Packet & | a | ) |
Definition at line 238 of file GenericPacketMath.h.
References cos().
Referenced by internal::scalar_cos_op< Scalar >::packetOp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f internal::pcos< Packet4f > | ( | const Packet4f & | _x | ) |
Definition at line 292 of file Core/arch/SSE/MathFunctions.h.
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4i, pabs(), padd(), pmadd(), pmul(), psub(), and y.
EIGEN_STRONG_INLINE Packet2cf internal::pcplxflip | ( | const Packet2cf & | a | ) |
Definition at line 147 of file NEON/Complex.h.
Referenced by internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::acc().
EIGEN_STRONG_INLINE Packet1cd internal::pcplxflip | ( | const Packet1cd & | x | ) |
Definition at line 423 of file SSE/Complex.h.
References preverse().
Packet internal::pdiv | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 131 of file GenericPacketMath.h.
Referenced by internal::scalar_inverse_op< Scalar >::packetOp(), internal::scalar_quotient_op< Scalar >::packetOp(), and pdiv< Packet2cf >().
EIGEN_STRONG_INLINE Packet1cd internal::pdiv< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 415 of file SSE/Complex.h.
References pmul(), and internal::Packet1cd::v.
EIGEN_STRONG_INLINE Packet2cf internal::pdiv< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 209 of file AltiVec/Complex.h.
References p16uc_COMPLEX_REV, pdiv(), pmul(), and internal::Packet2cf::v.
EIGEN_STRONG_INLINE Packet2d internal::pdiv< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 177 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pdiv< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 229 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pdiv< Packet4i > | ( | const Packet4i & | , |
const Packet4i & | |||
) |
Definition at line 244 of file AltiVec/PacketMath.h.
References eigen_assert, and pset1< Packet4i >().
void internal::permute_symm_to_fullsymm | ( | const MatrixType & | mat, |
SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > & | _dest, | ||
const typename MatrixType::Index * | perm = 0 |
||
) |
Definition at line 292 of file SparseSelfAdjointView.h.
References EigenBase< SparseMatrix< _Scalar, _Options, _Index > >::derived(), eigen_assert, Lower, mrpt::math::size(), and Upper.
void internal::permute_symm_to_symm | ( | const MatrixType & | mat, |
SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > & | _dest, | ||
const typename MatrixType::Index * | perm = 0 |
||
) |
Definition at line 363 of file SparseSelfAdjointView.h.
References EigenBase< SparseMatrix< _Scalar, _Options, _Index > >::derived(), Lower, mrpt::math::size(), and Upper.
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet internal::pexp | ( | const Packet & | a | ) |
Definition at line 242 of file GenericPacketMath.h.
References exp().
Referenced by internal::scalar_exp_op< Scalar >::packetOp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f internal::pexp< Packet4f > | ( | const Packet4f & | _x | ) |
Definition at line 116 of file Core/arch/SSE/MathFunctions.h.
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4i, padd(), pmadd(), pmax(), pmin(), pmul(), psub(), and y.
unpacket_traits<Packet>::type internal::pfirst | ( | const Packet & | a | ) | [inline] |
Definition at line 201 of file GenericPacketMath.h.
Referenced by predux< Packet1cd >(), predux< Packet2cf >(), predux< Packet2d >(), predux< Packet4f >(), predux< Packet4i >(), predux_max< Packet2d >(), predux_max< Packet4f >(), predux_max< Packet4i >(), predux_min< Packet2d >(), predux_min< Packet4f >(), predux_min< Packet4i >(), predux_mul< Packet1cd >(), predux_mul< Packet2cf >(), predux_mul< Packet2d >(), predux_mul< Packet4f >(), and internal::general_matrix_vector_product< Index, LhsScalar, ColMajor, ConjugateLhs, RhsScalar, ConjugateRhs >::run().
EIGEN_STRONG_INLINE std::complex<double> internal::pfirst< Packet1cd > | ( | const Packet1cd & | a | ) |
Definition at line 309 of file SSE/Complex.h.
References EIGEN_ALIGN16.
EIGEN_STRONG_INLINE std::complex< float > internal::pfirst< Packet2cf > | ( | const Packet2cf & | a | ) |
Definition at line 119 of file AltiVec/Complex.h.
References EIGEN_ALIGN16, and pstore().
EIGEN_STRONG_INLINE double internal::pfirst< Packet2d > | ( | const Packet2d & | a | ) |
Definition at line 303 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE float internal::pfirst< Packet4f > | ( | const Packet4f & | a | ) |
Definition at line 342 of file AltiVec/PacketMath.h.
References EIGEN_ALIGN16.
EIGEN_STRONG_INLINE int internal::pfirst< Packet4i > | ( | const Packet4i & | a | ) |
Definition at line 343 of file AltiVec/PacketMath.h.
References EIGEN_ALIGN16.
Packet internal::pload | ( | const typename unpacket_traits< Packet >::type * | from | ) | [inline] |
Definition at line 166 of file GenericPacketMath.h.
Referenced by pload< std::complex< float > >(), and pset1< Packet2cf >().
EIGEN_STRONG_INLINE Packet1cd internal::pload< Packet1cd > | ( | const std::complex< double > * | from | ) |
Definition at line 296 of file SSE/Complex.h.
References EIGEN_DEBUG_ALIGNED_LOAD, and pload< Packet2d >().
EIGEN_STRONG_INLINE Packet2cf internal::pload< Packet2cf > | ( | const std::complex< float > * | from | ) |
Definition at line 120 of file NEON/Complex.h.
References EIGEN_DEBUG_ALIGNED_LOAD, and pload< Packet4f >().
Definition at line 221 of file SSE/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by pload< Packet1cd >().
Definition at line 272 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by pload< Packet2cf >().
Definition at line 273 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_LOAD.
EIGEN_STRONG_INLINE Packet2cf internal::pload< std::complex< float > > | ( | const std::complex< float > * | from | ) |
Definition at line 111 of file AltiVec/Complex.h.
References EIGEN_DEBUG_ALIGNED_LOAD, and pload().
Packet internal::ploaddup | ( | const typename unpacket_traits< Packet >::type * | from | ) | [inline] |
Definition at line 174 of file GenericPacketMath.h.
Definition at line 265 of file SSE/PacketMath.h.
References pset1< Packet2d >().
Definition at line 186 of file NEON/PacketMath.h.
Definition at line 193 of file NEON/PacketMath.h.
Packet internal::ploadt | ( | const typename unpacket_traits< Packet >::type * | from | ) | [inline] |
Definition at line 266 of file GenericPacketMath.h.
References Aligned.
Packet internal::ploadu | ( | const typename unpacket_traits< Packet >::type * | from | ) | [inline] |
Definition at line 170 of file GenericPacketMath.h.
Referenced by ploadu< std::complex< float > >(), and pset1< Packet2cf >().
EIGEN_STRONG_INLINE Packet1cd internal::ploadu< Packet1cd > | ( | const std::complex< double > * | from | ) |
Definition at line 298 of file SSE/Complex.h.
References EIGEN_DEBUG_UNALIGNED_LOAD, and ploadu< Packet2d >().
Referenced by pset1< Packet1cd >().
EIGEN_STRONG_INLINE Packet2cf internal::ploadu< Packet2cf > | ( | const std::complex< float > * | from | ) |
Definition at line 121 of file NEON/Complex.h.
References EIGEN_DEBUG_UNALIGNED_LOAD, and ploadu< Packet4f >().
Definition at line 243 of file SSE/PacketMath.h.
References EIGEN_DEBUG_UNALIGNED_LOAD.
Referenced by ploadu< Packet1cd >().
Definition at line 275 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by ploadu< Packet2cf >().
Definition at line 287 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_LOAD.
EIGEN_STRONG_INLINE Packet2cf internal::ploadu< std::complex< float > > | ( | const std::complex< float > * | from | ) |
Definition at line 112 of file AltiVec/Complex.h.
References EIGEN_DEBUG_UNALIGNED_LOAD, and ploadu().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet internal::plog | ( | const Packet & | a | ) |
Definition at line 246 of file GenericPacketMath.h.
References log().
Referenced by internal::scalar_log_op< Scalar >::packetOp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f internal::plog< Packet4f > | ( | const Packet4f & | _x | ) |
Definition at line 36 of file Core/arch/SSE/MathFunctions.h.
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4f_FROM_INT, _EIGEN_DECLARE_CONST_Packet4i, padd(), pmadd(), pmax(), pmul(), psub(), and y.
packet_traits<Scalar>::type internal::plset | ( | const Scalar & | a | ) | [inline] |
Definition at line 182 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet2d internal::plset< double > | ( | const double & | a | ) |
Definition at line 132 of file SSE/PacketMath.h.
References pset1< Packet2d >().
EIGEN_STRONG_INLINE Packet4f internal::plset< float > | ( | const float & | a | ) |
Definition at line 180 of file AltiVec/PacketMath.h.
References p4f_COUNTDOWN, and pset1< Packet4f >().
EIGEN_STRONG_INLINE Packet4i internal::plset< int > | ( | const int & | a | ) |
Definition at line 181 of file AltiVec/PacketMath.h.
References p4i_COUNTDOWN, and pset1< Packet4i >().
EIGEN_STRONG_INLINE Packet4f internal::pmadd | ( | const Packet4f & | a, |
const Packet4f & | b, | ||
const Packet4f & | c | ||
) |
Definition at line 250 of file AltiVec/PacketMath.h.
Referenced by internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::acc(), internal::gebp_traits< _LhsScalar, _RhsScalar, _ConjLhs, _ConjRhs >::acc(), pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), internal::conj_helper< Scalar, Scalar, false, false >::pmadd(), psin< Packet4f >(), internal::product_packet_impl< ColMajor, Dynamic, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_packet_impl< RowMajor, Dynamic, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_packet_impl< ColMajor, UnrollingIndex, Lhs, Rhs, Packet, LoadMode >::run(), and internal::product_packet_impl< RowMajor, UnrollingIndex, Lhs, Rhs, Packet, LoadMode >::run().
EIGEN_STRONG_INLINE Packet4i internal::pmadd | ( | const Packet4i & | a, |
const Packet4i & | b, | ||
const Packet4i & | c | ||
) |
Definition at line 251 of file AltiVec/PacketMath.h.
Packet internal::pmadd | ( | const Packet & | a, |
const Packet & | b, | ||
const Packet & | c | ||
) | [inline] |
Definition at line 258 of file GenericPacketMath.h.
Packet internal::pmax | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 141 of file GenericPacketMath.h.
Referenced by internal::scalar_max_op< Scalar >::packetOp(), pexp< Packet4f >(), and plog< Packet4f >().
EIGEN_STRONG_INLINE Packet2d internal::pmax< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 196 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pmax< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 256 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pmax< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 257 of file AltiVec/PacketMath.h.
Packet internal::pmin | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 136 of file GenericPacketMath.h.
Referenced by internal::scalar_min_op< Scalar >::packetOp(), and pexp< Packet4f >().
EIGEN_STRONG_INLINE Packet2d internal::pmin< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 187 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pmin< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 253 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pmin< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 254 of file AltiVec/PacketMath.h.
Packet internal::pmul | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 126 of file GenericPacketMath.h.
Referenced by apply_rotation_in_the_plane(), internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::madd(), internal::gebp_traits< _LhsScalar, _RhsScalar, _ConjLhs, _ConjRhs >::madd(), internal::gebp_traits< RealScalar, std::complex< RealScalar >, false, _ConjRhs >::madd_impl(), internal::gebp_traits< std::complex< RealScalar >, RealScalar, _ConjLhs, false >::madd_impl(), internal::scalar_conj_product_op< Scalar >::operator()(), DiagonalProduct< MatrixType, DiagonalType, ProductOrder >::packet_impl(), internal::scalar_cube_op< Scalar >::packetOp(), internal::scalar_square_op< Scalar >::packetOp(), internal::linspaced_op_impl< Scalar, true >::packetOp(), internal::scalar_quotient1_impl< Scalar, NumTraits< Scalar >::IsInteger >::packetOp(), internal::scalar_multiple_op< Scalar >::packetOp(), internal::scalar_abs2_op< Scalar >::packetOp(), internal::scalar_conj_product_op< Scalar >::packetOp(), internal::scalar_product_op< LhsScalar, RhsScalar >::packetOp(), pcos< Packet4f >(), pdiv< Packet1cd >(), pdiv< Packet2cf >(), pexp< Packet4f >(), plog< Packet4f >(), pmadd(), internal::conj_helper< Packet1cd, Packet2d, false, false >::pmadd(), internal::conj_helper< Packet2d, Packet1cd, false, false >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, true, true >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, true, false >::pmadd(), internal::conj_helper< Packet1cd, Packet1cd, false, true >::pmadd(), internal::conj_helper< Packet2cf, Packet4f, false, false >::pmadd(), internal::conj_helper< Packet4f, Packet2cf, false, false >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, true, true >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, true, false >::pmadd(), internal::conj_helper< Packet2cf, Packet2cf, false, true >::pmadd(), internal::conj_helper< RealScalar, std::complex< RealScalar >, false, Conj >::pmadd(), internal::conj_helper< std::complex< RealScalar >, RealScalar, Conj, false >::pmadd(), internal::conj_helper< std::complex< RealScalar >, std::complex< RealScalar >, true, true >::pmadd(), internal::conj_helper< std::complex< RealScalar >, std::complex< RealScalar >, true, false >::pmadd(), internal::conj_helper< std::complex< RealScalar >, std::complex< RealScalar >, false, true >::pmadd(), internal::conj_helper< Packet1cd, Packet2d, false, false >::pmul(), internal::conj_helper< Packet2d, Packet1cd, false, false >::pmul(), internal::conj_helper< Packet1cd, Packet1cd, true, true >::pmul(), internal::conj_helper< Packet1cd, Packet1cd, true, false >::pmul(), internal::conj_helper< Packet1cd, Packet1cd, false, true >::pmul(), internal::conj_helper< Packet2cf, Packet4f, false, false >::pmul(), internal::conj_helper< Packet4f, Packet2cf, false, false >::pmul(), internal::conj_helper< Packet2cf, Packet2cf, true, true >::pmul(), internal::conj_helper< Packet2cf, Packet2cf, true, false >::pmul(), internal::conj_helper< Packet2cf, Packet2cf, false, true >::pmul(), internal::conj_helper< Scalar, Scalar, false, false >::pmul(), predux_mul< Packet2cf >(), predux_mul< Packet4f >(), psin< Packet4f >(), psqrt< Packet4f >(), internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::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_packet_impl< ColMajor, 0, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_packet_impl< RowMajor, 0, Lhs, Rhs, Packet, LoadMode >::run(), internal::product_coeff_vectorized_unroller< 0, Lhs, Rhs, Packet >::run(), and internal::product_coeff_vectorized_unroller< UnrollingIndex, Lhs, Rhs, Packet >::run().
std::complex<double> internal::pmul | ( | const std::complex< double > & | a, |
const std::complex< double > & | b | ||
) | [inline] |
Definition at line 308 of file GenericPacketMath.h.
std::complex<float> internal::pmul | ( | const std::complex< float > & | a, |
const std::complex< float > & | b | ||
) | [inline] |
Definition at line 305 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::pmul< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 275 of file SSE/Complex.h.
References vec2d_swizzle1.
EIGEN_STRONG_INLINE Packet2cf internal::pmul< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 87 of file AltiVec/Complex.h.
References p16uc_COMPLEX_IM, p16uc_COMPLEX_RE, p16uc_COMPLEX_REV, and p4ui_CONJ_XOR.
EIGEN_STRONG_INLINE Packet2d internal::pmul< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 159 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pmul< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 192 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pmul< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 118 of file NEON/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pnegate | ( | const Packet4f & | a | ) |
Definition at line 189 of file AltiVec/PacketMath.h.
References psub< Packet4f >().
Packet internal::pnegate | ( | const Packet & | a | ) | [inline] |
Definition at line 118 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pnegate | ( | const Packet4i & | a | ) |
Definition at line 190 of file AltiVec/PacketMath.h.
References psub< Packet4i >().
EIGEN_STRONG_INLINE Packet2cf internal::pnegate | ( | const Packet2cf & | a | ) |
Definition at line 84 of file AltiVec/Complex.h.
References psub< Packet4f >(), and internal::Packet2cf::v.
Referenced by internal::scalar_opposite_op< Scalar >::packetOp(), and pnegate().
EIGEN_STRONG_INLINE Packet1cd internal::pnegate | ( | const Packet1cd & | a | ) |
Definition at line 268 of file SSE/Complex.h.
References pnegate(), and internal::Packet1cd::v.
EIGEN_STRONG_INLINE Packet2d internal::pnegate | ( | const Packet2d & | a | ) |
Definition at line 148 of file SSE/PacketMath.h.
Packet internal::por | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 154 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::por< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 291 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::por< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 107 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::por< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 209 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::por< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 263 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::por< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 264 of file AltiVec/PacketMath.h.
unpacket_traits<Packet>::type internal::predux | ( | const Packet & | a | ) | [inline] |
Definition at line 209 of file GenericPacketMath.h.
Referenced by product_selfadjoint_vector(), internal::general_matrix_vector_product< Index, LhsScalar, RowMajor, ConjugateLhs, RhsScalar, ConjugateRhs >::run(), and internal::product_coeff_impl< InnerVectorizedTraversal, UnrollingIndex, Lhs, Rhs, RetScalar >::run().
EIGEN_STRONG_INLINE std::complex<double> internal::predux< Packet1cd > | ( | const Packet1cd & | a | ) |
Definition at line 318 of file SSE/Complex.h.
References pfirst().
EIGEN_STRONG_INLINE std::complex< float > internal::predux< Packet2cf > | ( | const Packet2cf & | a | ) |
Definition at line 134 of file AltiVec/Complex.h.
References padd(), pfirst(), and mrpt::math::sum().
EIGEN_STRONG_INLINE double internal::predux< Packet2d > | ( | const Packet2d & | a | ) |
Definition at line 380 of file SSE/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE float internal::predux< Packet4f > | ( | const Packet4f & | a | ) |
Definition at line 351 of file AltiVec/PacketMath.h.
References pfirst(), and mrpt::math::sum().
EIGEN_STRONG_INLINE int internal::predux< Packet4i > | ( | const Packet4i & | a | ) |
Definition at line 389 of file AltiVec/PacketMath.h.
References pfirst(), and mrpt::math::sum().
unpacket_traits<Packet>::type internal::predux_max | ( | const Packet & | a | ) | [inline] |
Definition at line 221 of file GenericPacketMath.h.
Referenced by internal::scalar_max_op< Scalar >::predux().
EIGEN_STRONG_INLINE double internal::predux_max< Packet2d > | ( | const Packet2d & | a | ) |
Definition at line 474 of file SSE/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE float internal::predux_max< Packet4f > | ( | const Packet4f & | a | ) |
Definition at line 459 of file AltiVec/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE int internal::predux_max< Packet4i > | ( | const Packet4i & | a | ) |
Definition at line 467 of file AltiVec/PacketMath.h.
References pfirst().
unpacket_traits<Packet>::type internal::predux_min | ( | const Packet & | a | ) | [inline] |
Definition at line 217 of file GenericPacketMath.h.
Referenced by internal::scalar_min_op< Scalar >::predux().
EIGEN_STRONG_INLINE double internal::predux_min< Packet2d > | ( | const Packet2d & | a | ) |
Definition at line 453 of file SSE/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE float internal::predux_min< Packet4f > | ( | const Packet4f & | a | ) |
Definition at line 442 of file AltiVec/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE int internal::predux_min< Packet4i > | ( | const Packet4i & | a | ) |
Definition at line 450 of file AltiVec/PacketMath.h.
References pfirst().
unpacket_traits<Packet>::type internal::predux_mul | ( | const Packet & | a | ) | [inline] |
Definition at line 213 of file GenericPacketMath.h.
Referenced by internal::scalar_product_op< LhsScalar, RhsScalar >::predux().
EIGEN_STRONG_INLINE std::complex<double> internal::predux_mul< Packet1cd > | ( | const Packet1cd & | a | ) |
Definition at line 328 of file SSE/Complex.h.
References pfirst().
EIGEN_STRONG_INLINE std::complex< float > internal::predux_mul< Packet2cf > | ( | const Packet2cf & | a | ) |
Definition at line 154 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE double internal::predux_mul< Packet2d > | ( | const Packet2d & | a | ) |
Definition at line 433 of file SSE/PacketMath.h.
References pfirst().
EIGEN_STRONG_INLINE float internal::predux_mul< Packet4f > | ( | const Packet4f & | a | ) |
Definition at line 427 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE int internal::predux_mul< Packet4i > | ( | const Packet4i & | a | ) |
Definition at line 434 of file AltiVec/PacketMath.h.
References EIGEN_ALIGN16, and pstore().
Packet internal::preduxp | ( | const Packet * | vecs | ) | [inline] |
Definition at line 206 of file GenericPacketMath.h.
Definition at line 323 of file SSE/Complex.h.
Definition at line 142 of file AltiVec/Complex.h.
References padd().
Definition at line 399 of file SSE/PacketMath.h.
Definition at line 361 of file AltiVec/PacketMath.h.
References mrpt::math::sum().
Definition at line 397 of file AltiVec/PacketMath.h.
References mrpt::math::sum().
void internal::prefetch | ( | const Scalar * | addr | ) | [inline] |
Definition at line 193 of file GenericPacketMath.h.
Referenced by internal::gebp_kernel< LhsScalar, RhsScalar, Index, mr, nr, ConjugateLhs, ConjugateRhs >::operator()().
EIGEN_STRONG_INLINE void internal::prefetch< double > | ( | const double * | addr | ) |
Definition at line 287 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE void internal::prefetch< float > | ( | const float * | addr | ) |
Definition at line 339 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE void internal::prefetch< int > | ( | const int * | addr | ) |
Definition at line 340 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE void internal::prefetch< std::complex< double > > | ( | const std::complex< double > * | addr | ) |
Definition at line 307 of file SSE/Complex.h.
EIGEN_STRONG_INLINE void internal::prefetch< std::complex< float > > | ( | const std::complex< float > * | addr | ) |
Definition at line 117 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet4f internal::preverse | ( | const Packet4f & | a | ) |
Definition at line 345 of file AltiVec/PacketMath.h.
References p16uc_REVERSE.
EIGEN_STRONG_INLINE Packet4i internal::preverse | ( | const Packet4i & | a | ) |
Definition at line 346 of file AltiVec/PacketMath.h.
References p16uc_REVERSE.
EIGEN_STRONG_INLINE Packet2cf internal::preverse | ( | const Packet2cf & | a | ) |
Definition at line 127 of file AltiVec/Complex.h.
References p16uc_COMPLEX_REV2, and internal::Packet2cf::v.
Referenced by Reverse< MatrixType, Direction >::packet(), pcplxflip(), internal::reverse_packet_cond< PacketScalar, ReversePacket >::run(), internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run(), and Reverse< MatrixType, Direction >::writePacket().
Packet internal::preverse | ( | const Packet & | a | ) | [inline] |
Definition at line 225 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::preverse | ( | const Packet1cd & | a | ) |
Definition at line 316 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::preverse | ( | const Packet2d & | a | ) |
Definition at line 309 of file SSE/PacketMath.h.
std::ostream & internal::print_matrix | ( | std::ostream & | s, |
const Derived & | _m, | ||
const IOFormat & | fmt | ||
) |
Definition at line 165 of file IO.h.
References IOFormat::coeffSeparator, DontAlignCols, IOFormat::flags, FullPrecision, IOFormat::matPrefix, IOFormat::matSuffix, IOFormat::precision, IOFormat::rowPrefix, IOFormat::rowSeparator, IOFormat::rowSpacer, IOFormat::rowSuffix, internal::significant_decimals_default_impl< Scalar, NumTraits< Scalar >::IsInteger >::run(), and StreamPrecision.
Referenced by DenseBase< Derived >::operator<<().
static EIGEN_DONT_INLINE void internal::product_selfadjoint_vector | ( | Index | size, |
const Scalar * | lhs, | ||
Index | lhsStride, | ||
const Scalar * | _rhs, | ||
Index | rhsIncr, | ||
Scalar * | res, | ||
Scalar | alpha | ||
) | [static] |
Definition at line 36 of file SelfadjointMatrixVector.h.
References ei_aligned_stack_delete, ei_aligned_stack_new, EIGEN_LOGICAL_XOR, EIGEN_RESTRICT, first_aligned(), IsComplex, Lower, predux(), pstore(), real(), RowMajor, and mrpt::math::size().
Packet internal::pset1 | ( | const typename unpacket_traits< Packet >::type & | a | ) | [inline] |
Definition at line 178 of file GenericPacketMath.h.
EIGEN_STRONG_INLINE Packet1cd internal::pset1< Packet1cd > | ( | const std::complex< double > & | from | ) |
Definition at line 300 of file SSE/Complex.h.
References ploadu< Packet1cd >().
EIGEN_STRONG_INLINE Packet2cf internal::pset1< Packet2cf > | ( | const std::complex< float > & | from | ) |
Definition at line 68 of file AltiVec/Complex.h.
References p16uc_PSET_HI, p16uc_PSET_LO, pload(), ploadu(), and internal::Packet2cf::v.
Definition at line 127 of file SSE/PacketMath.h.
Referenced by ploaddup< Packet2d >(), plset< double >(), and internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run().
Definition at line 163 of file AltiVec/PacketMath.h.
References EIGEN_ALIGN16.
Referenced by plset< float >(), and psqrt< Packet4f >().
Definition at line 172 of file AltiVec/PacketMath.h.
References EIGEN_ALIGN16.
Referenced by pdiv< Packet4i >(), and plset< int >().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet internal::psin | ( | const Packet & | a | ) |
Definition at line 234 of file GenericPacketMath.h.
References sin().
Referenced by internal::scalar_sin_op< Scalar >::packetOp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f internal::psin< Packet4f > | ( | const Packet4f & | _x | ) |
Definition at line 191 of file Core/arch/SSE/MathFunctions.h.
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4f_FROM_INT, _EIGEN_DECLARE_CONST_Packet4i, pabs(), padd(), pmadd(), pmul(), psub(), and y.
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet internal::psqrt | ( | const Packet & | a | ) |
Definition at line 250 of file GenericPacketMath.h.
References sqrt().
Referenced by internal::scalar_sqrt_op< Scalar >::packetOp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f internal::psqrt< Packet4f > | ( | const Packet4f & | _x | ) |
Definition at line 381 of file Core/arch/SSE/MathFunctions.h.
References pmul(), pset1< Packet4f >(), and psub().
void internal::pstore | ( | Scalar * | to, |
const Packet & | from | ||
) | [inline] |
Definition at line 185 of file GenericPacketMath.h.
Referenced by apply_rotation_in_the_plane(), pfirst< Packet2cf >(), predux_mul< Packet4i >(), product_selfadjoint_vector(), pstore< std::complex< double > >(), pstore< std::complex< float > >(), pstoret(), internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run(), internal::cross3_impl< Architecture::SSE, VectorLhs, VectorRhs, float, true >::run(), internal::quat_product< Architecture::SSE, Derived, OtherDerived, float, Aligned >::run(), internal::general_matrix_vector_product< Index, LhsScalar, ColMajor, ConjugateLhs, RhsScalar, ConjugateRhs >::run(), internal::gebp_traits< RealScalar, std::complex< RealScalar >, false, _ConjRhs >::unpackRhs(), internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::unpackRhs(), internal::gebp_traits< std::complex< RealScalar >, RealScalar, _ConjLhs, false >::unpackRhs(), and internal::gebp_traits< _LhsScalar, _RhsScalar, _ConjLhs, _ConjRhs >::unpackRhs().
EIGEN_STRONG_INLINE void internal::pstore< double > | ( | double * | to, |
const Packet2d & | from | ||
) |
Definition at line 275 of file SSE/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstore< float > | ( | float * | to, |
const Packet4f & | from | ||
) |
Definition at line 299 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstore< int > | ( | int * | to, |
const Packet4i & | from | ||
) |
Definition at line 300 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_ALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstore< std::complex< double > > | ( | std::complex< double > * | to, |
const Packet1cd & | from | ||
) |
Definition at line 304 of file SSE/Complex.h.
References EIGEN_DEBUG_ALIGNED_STORE, and pstore().
EIGEN_STRONG_INLINE void internal::pstore< std::complex< float > > | ( | std::complex< float > * | to, |
const Packet2cf & | from | ||
) |
Definition at line 114 of file AltiVec/Complex.h.
References EIGEN_DEBUG_ALIGNED_STORE, and pstore().
void internal::pstoret | ( | Scalar * | to, |
const Packet & | from | ||
) | [inline] |
Definition at line 277 of file GenericPacketMath.h.
void internal::pstoreu | ( | Scalar * | to, |
const Packet & | from | ||
) | [inline] |
EIGEN_STRONG_INLINE void internal::pstoreu< double > | ( | double * | to, |
const Packet2d & | from | ||
) |
Definition at line 278 of file SSE/PacketMath.h.
References EIGEN_DEBUG_UNALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstoreu< float > | ( | float * | to, |
const Packet4f & | from | ||
) |
Definition at line 302 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_UNALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstoreu< int > | ( | int * | to, |
const Packet4i & | from | ||
) |
Definition at line 320 of file AltiVec/PacketMath.h.
References EIGEN_DEBUG_UNALIGNED_STORE.
EIGEN_STRONG_INLINE void internal::pstoreu< std::complex< double > > | ( | std::complex< double > * | to, |
const Packet1cd & | from | ||
) |
Definition at line 305 of file SSE/Complex.h.
References EIGEN_DEBUG_UNALIGNED_STORE, and pstoreu().
EIGEN_STRONG_INLINE void internal::pstoreu< std::complex< float > > | ( | std::complex< float > * | to, |
const Packet2cf & | from | ||
) |
Definition at line 115 of file AltiVec/Complex.h.
References EIGEN_DEBUG_UNALIGNED_STORE, and pstoreu().
Packet internal::psub | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 113 of file GenericPacketMath.h.
Referenced by internal::gebp_traits< std::complex< RealScalar >, std::complex< RealScalar >, _ConjLhs, _ConjRhs >::acc(), apply_rotation_in_the_plane(), internal::scalar_difference_op< Scalar >::packetOp(), pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), psin< Packet4f >(), psqrt< Packet4f >(), and internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run().
EIGEN_STRONG_INLINE Packet1cd internal::psub< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 267 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::psub< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 83 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::psub< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 140 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::psub< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 186 of file AltiVec/PacketMath.h.
Referenced by pnegate().
EIGEN_STRONG_INLINE Packet4i internal::psub< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 187 of file AltiVec/PacketMath.h.
Referenced by pnegate().
EIGEN_STRONG_INLINE void internal::punpackp | ( | Packet4f * | vecs | ) |
Definition at line 335 of file SSE/PacketMath.h.
Packet internal::pxor | ( | const Packet & | a, |
const Packet & | b | ||
) | [inline] |
Definition at line 158 of file GenericPacketMath.h.
Referenced by internal::quat_product< Architecture::SSE, Derived, OtherDerived, double, Aligned >::run().
EIGEN_STRONG_INLINE Packet1cd internal::pxor< Packet1cd > | ( | const Packet1cd & | a, |
const Packet1cd & | b | ||
) |
Definition at line 292 of file SSE/Complex.h.
EIGEN_STRONG_INLINE Packet2cf internal::pxor< Packet2cf > | ( | const Packet2cf & | a, |
const Packet2cf & | b | ||
) |
Definition at line 108 of file AltiVec/Complex.h.
EIGEN_STRONG_INLINE Packet2d internal::pxor< Packet2d > | ( | const Packet2d & | a, |
const Packet2d & | b | ||
) |
Definition at line 213 of file SSE/PacketMath.h.
EIGEN_STRONG_INLINE Packet4f internal::pxor< Packet4f > | ( | const Packet4f & | a, |
const Packet4f & | b | ||
) |
Definition at line 266 of file AltiVec/PacketMath.h.
EIGEN_STRONG_INLINE Packet4i internal::pxor< Packet4i > | ( | const Packet4i & | a, |
const Packet4i & | b | ||
) |
Definition at line 267 of file AltiVec/PacketMath.h.
void internal::queryCacheSizes | ( | int & | l1, |
int & | l2, | ||
int & | l3 | ||
) | [inline] |
Definition at line 760 of file Memory.h.
Referenced by queryL1CacheSize(), and queryTopLevelCacheSize().
int internal::queryL1CacheSize | ( | ) | [inline] |
Definition at line 794 of file Memory.h.
References queryCacheSizes().
Referenced by manage_caching_sizes().
int internal::queryTopLevelCacheSize | ( | ) | [inline] |
Definition at line 803 of file Memory.h.
References queryCacheSizes().
Referenced by manage_caching_sizes().
void internal::real_2x2_jacobi_svd | ( | const MatrixType & | matrix, |
Index | p, | ||
Index | q, | ||
JacobiRotation< RealScalar > * | j_left, | ||
JacobiRotation< RealScalar > * | j_right | ||
) |
Definition at line 262 of file JacobiSVD.h.
References abs2(), PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::coeff(), JacobiRotation< Scalar >::makeJacobi(), real(), sqrt(), t(), and JacobiRotation< Scalar >::transpose().
Referenced by JacobiSVD< _MatrixType, QRPreconditioner >::compute().
add_const_on_value_type< EIGEN_MATHFUNC_RETVAL(real_ref, Scalar) >::type internal::real_ref | ( | const Scalar & | x | ) | [inline] |
Definition at line 166 of file Core/MathFunctions.h.
References internal::real_ref_impl< Scalar >::run().
Referenced by ComplexEigenSolver< _MatrixType >::doComputeEigenvectors(), EIGEN_MATHFUNC_RETVAL(), and internal::scalar_real_ref_op< Scalar >::operator()().
void internal::setNbThreads | ( | int | v | ) | [inline] |
Sets the max number of threads reserved for Eigen.
Definition at line 69 of file Parallelizer.h.
References manage_multi_threading(), and SetAction.
static void internal::sparse_product_impl | ( | const Lhs & | lhs, |
const Rhs & | rhs, | ||
ResultType & | res | ||
) | [static] |
Definition at line 115 of file SparseSparseProduct.h.
References eigen_assert.
static void internal::sparse_product_impl2 | ( | const Lhs & | lhs, |
const Rhs & | rhs, | ||
ResultType & | res | ||
) | [static] |
Definition at line 31 of file SparseSparseProduct.h.
References eigen_assert, and y.
std::complex<RealScalar> internal::sqrt | ( | const std::complex< RealScalar > & | z | ) |
Computes the principal value of the square root of the complex z.
Definition at line 234 of file ComplexSchur.h.
References abs(), imag(), real(), sqrt(), and t().
Referenced by MatrixBase< Derived >::blueNorm(), EigenSolver< _MatrixType >::compute(), ei_sqrt(), EIGEN_MATHFUNC_RETVAL(), JacobiRotation< Scalar >::makeGivens(), MatrixBase< Derived >::makeHouseholder(), JacobiRotation< Scalar >::makeJacobi(), SparseMatrixBase< Derived >::norm(), MatrixBase< Derived >::norm(), internal::scalar_sqrt_op< Scalar >::operator()(), internal::scalar_hypot_op< Scalar >::operator()(), AngleAxis< _Scalar >::operator=(), MatrixBase< Derived >::operatorNorm(), psqrt(), real_2x2_jacobi_svd(), internal::tridiagonalization_inplace_selector< MatrixType, 3, false >::run(), internal::quaternionbase_assign_impl< Other, 3, 3 >::run(), internal::sqrt_default_impl< Scalar, NumTraits< Scalar >::IsInteger >::run(), internal::hypot_impl< Scalar >::run(), internal::svd_precondition_2x2_block_to_be_real< MatrixType, QRPreconditioner, true >::run(), QuaternionBase< Derived >::setFromTwoVectors(), MatrixBase< Derived >::stableNorm(), tridiagonal_qr_step(), and internal::llt_inplace< Lower >::unblocked().
void internal::stable_norm_kernel | ( | const ExpressionType & | bl, |
Scalar & | ssq, | ||
Scalar & | scale, | ||
Scalar & | invScale | ||
) | [inline] |
Definition at line 30 of file StableNorm.h.
References abs2().
Referenced by MatrixBase< Derived >::stableNorm().
static const MatrixBase<OtherDerived>& internal::toRotationMatrix | ( | const MatrixBase< OtherDerived > & | mat | ) | [inline, static] |
Definition at line 208 of file RotationBase.h.
References EIGEN_STATIC_ASSERT.
static Matrix<Scalar,Dim,Dim> internal::toRotationMatrix | ( | const RotationBase< OtherDerived, Dim > & | r | ) | [inline, static] |
Definition at line 202 of file RotationBase.h.
References RotationBase< Derived, _Dim >::toRotationMatrix().
static Matrix<Scalar,2,2> internal::toRotationMatrix | ( | const Scalar & | s | ) | [inline, static] |
Definition at line 195 of file RotationBase.h.
References EIGEN_STATIC_ASSERT.
static void internal::tridiagonal_qr_step | ( | RealScalar * | diag, |
RealScalar * | subdiag, | ||
Index | start, | ||
Index | end, | ||
Scalar * | matrixQ, | ||
Index | n | ||
) | [static] |
Definition at line 434 of file SelfAdjointEigenSolver.h.
References abs2(), JacobiRotation< Scalar >::c(), end(), JacobiRotation< Scalar >::makeGivens(), JacobiRotation< Scalar >::s(), and sqrt().
void internal::tridiagonalization_inplace | ( | MatrixType & | matA, |
CoeffVectorType & | hCoeffs | ||
) |
Definition at line 359 of file Tridiagonalization.h.
References eigen_assert.
Referenced by Tridiagonalization< _MatrixType >::compute(), SelfAdjointEigenSolver< _MatrixType >::compute(), internal::tridiagonalization_inplace_selector< MatrixType, Size, IsComplex >::run(), and Tridiagonalization< _MatrixType >::Tridiagonalization().
void internal::tridiagonalization_inplace | ( | MatrixType & | mat, |
DiagonalType & | diag, | ||
SubDiagonalType & | subdiag, | ||
bool | extractQ | ||
) |
Performs a full tridiagonalization in place.
[in,out] | mat | On input, the selfadjoint matrix whose tridiagonal decomposition is to be computed. Only the lower triangular part referenced. The rest is left unchanged. On output, the orthogonal matrix Q in the decomposition if extractQ is true. |
[out] | diag | The diagonal of the tridiagonal matrix T in the decomposition. |
[out] | subdiag | The subdiagonal of the tridiagonal matrix T in the decomposition. |
[in] | extractQ | If true, the orthogonal matrix Q in the decomposition is computed and stored in mat . |
Computes the tridiagonal decomposition of the selfadjoint matrix mat
in place such that where
is unitary and
a real symmetric tridiagonal matrix.
The tridiagonal matrix T is passed to the output parameters diag
and subdiag
. If extractQ
is true, then the orthogonal matrix Q is passed to mat
. Otherwise the lower part of the matrix mat
is destroyed.
The vectors diag
and subdiag
are not resized. The function assumes that they are already of the correct size. The length of the vector diag
should equal the number of rows in mat
, and the length of the vector subdiag
should be one left.
This implementation contains an optimized path for 3-by-3 matrices which is especially useful for plane fitting.
Example (this uses the same matrix as the example in Tridiagonalization::Tridiagonalization(const MatrixType&)):
Output:
Definition at line 439 of file Tridiagonalization.h.
References eigen_assert, and internal::tridiagonalization_inplace_selector< MatrixType, Size, IsComplex >::run().
bool internal::IsComplex |
Definition at line 695 of file Core/MathFunctions.h.
Referenced by apply_rotation_in_the_plane(), 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()(), and product_selfadjoint_vector().
Packet16uc internal::p16uc_COMPLEX_IM = vec_sld((Packet16uc) vec_splat((Packet4ui)p16uc_FORWARD, 1), (Packet16uc) vec_splat((Packet4ui)p16uc_FORWARD, 3), 8) [static] |
Definition at line 32 of file AltiVec/Complex.h.
Referenced by pmul< Packet2cf >().
Packet16uc internal::p16uc_COMPLEX_RE = vec_sld((Packet16uc) vec_splat((Packet4ui)p16uc_FORWARD, 0), (Packet16uc) vec_splat((Packet4ui)p16uc_FORWARD, 2), 8) [static] |
Definition at line 31 of file AltiVec/Complex.h.
Referenced by pmul< Packet2cf >().
Packet16uc internal::p16uc_COMPLEX_REV = vec_sld(p16uc_REVERSE, p16uc_REVERSE, 8) [static] |
Definition at line 33 of file AltiVec/Complex.h.
Referenced by pdiv< Packet2cf >(), and pmul< Packet2cf >().
Packet16uc internal::p16uc_COMPLEX_REV2 = vec_sld(p16uc_FORWARD, p16uc_FORWARD, 8) [static] |
Definition at line 34 of file AltiVec/Complex.h.
Referenced by preverse().
Packet16uc internal::p16uc_FORWARD = vec_lvsl(0, (float*)0) [static] |
Definition at line 79 of file AltiVec/PacketMath.h.
Packet16uc internal::p16uc_PSET_HI = (Packet16uc) vec_mergeh((Packet4ui) vec_splat((Packet4ui)p16uc_FORWARD, 0), (Packet4ui) vec_splat((Packet4ui)p16uc_FORWARD, 1)) [static] |
Definition at line 35 of file AltiVec/Complex.h.
Referenced by pset1< Packet2cf >().
Packet16uc internal::p16uc_PSET_LO = (Packet16uc) vec_mergeh((Packet4ui) vec_splat((Packet4ui)p16uc_FORWARD, 2), (Packet4ui) vec_splat((Packet4ui)p16uc_FORWARD, 3)) [static] |
Definition at line 36 of file AltiVec/Complex.h.
Referenced by pset1< Packet2cf >().
Packet16uc internal::p16uc_REVERSE = {12,13,14,15, 8,9,10,11, 4,5,6,7, 0,1,2,3} [static] |
Definition at line 78 of file AltiVec/PacketMath.h.
Referenced by preverse().
uint32x2_t internal::p2ui_CONJ_XOR = { 0x00000000, 0x80000000 } [static] |
Definition at line 31 of file NEON/Complex.h.
Packet4f internal::p4f_COUNTDOWN = { 3.0, 2.0, 1.0, 0.0 } [static] |
Definition at line 76 of file AltiVec/PacketMath.h.
Referenced by plset< float >().
Packet4f internal::p4f_ONE = vec_ctf(p4i_ONE, 0) [static] |
Definition at line 86 of file AltiVec/PacketMath.h.
Referenced by pdiv< Packet4f >().
Packet4f internal::p4f_ZERO_ = (Packet4f) vec_sl((Packet4ui)p4i_MINUS1, (Packet4ui)p4i_MINUS1) [static] |
Definition at line 87 of file AltiVec/PacketMath.h.
Packet4i internal::p4i_COUNTDOWN = { 3, 2, 1, 0 } [static] |
Definition at line 77 of file AltiVec/PacketMath.h.
Referenced by plset< int >().
static uint32x4_t internal::p4ui_CONJ_XOR = vec_mergeh((Packet4ui)p4i_ZERO, (Packet4ui)p4f_ZERO_) [static] |
Definition at line 30 of file AltiVec/Complex.h.
Referenced by pconj(), and pmul< Packet2cf >().
const Scalar& internal::y |
Definition at line 709 of file Core/MathFunctions.h.
Referenced by PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_init2(), apply_rotation_in_the_plane(), MatrixBase< Derived >::applyOnTheLeft(), MatrixBase< Derived >::applyOnTheRight(), Array< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols >::Array(), mrpt::math::TPose3DQuat::asString(), mrpt::math::TPose3D::asString(), mrpt::math::TPoint3D::asString(), mrpt::math::TPose2D::asString(), mrpt::math::TPoint2D::asString(), mrpt::poses::CPose2D::asString(), QuaternionBase< Derived >::conjugate(), mrpt::poses::CPoint2D::CPoint2D(), mrpt::poses::CPoint3D::CPoint3D(), mrpt::poses::CPose3DQuat::CPose3DQuat(), mrpt::opengl::CGridPlaneXZ::Create(), mrpt::math::TPoint3D::distanceTo(), EigenSolver< _MatrixType >::doComputeEigenvectors(), mrpt::poses::CPose2D::fromString(), mrpt::slam::CPointsMap::getAllPoints(), mrpt::poses::CPose2DGridTemplate< double >::getAsMatrix(), mrpt::math::TPose3D::getAsVector(), mrpt::math::TPoint3D::getAsVector(), mrpt::math::TPose2D::getAsVector(), mrpt::math::TPoint2D::getAsVector(), mrpt::opengl::CPointCloudColoured::getPointf(), mrpt::slam::CPointsMap::getPointsBufferRef_y(), internal::scalar_fuzzy_impl< bool >::isApprox(), internal::scalar_fuzzy_default_impl< Scalar, false, true >::isApprox(), internal::scalar_fuzzy_impl< bool >::isApproxOrLessThan(), internal::scalar_fuzzy_default_impl< Scalar, false, true >::isApproxOrLessThan(), isMuchSmallerThan(), mrpt::opengl::CPointCloudColoured::loadFromPointsMap(), Matrix< Scalar, Rows, HDim >::Matrix(), mrpt::math::TPose3DQuat::norm(), mrpt::math::TPose3D::norm(), mrpt::math::TPoint3D::norm(), mrpt::opengl::COctreePointRenderer< CPointCloudColoured >::octree_recursive_render(), mrpt::math::operator!=(), mrpt::math::TPoint3D::operator*(), mrpt::math::TPoint3Df::operator*(), mrpt::math::TPoint3D::operator*=(), mrpt::math::TPoint2D::operator*=(), mrpt::math::TPoint3D::operator+(), mrpt::math::TPoint3D::operator+=(), mrpt::math::TPoint3Df::operator+=(), mrpt::math::TPoint2D::operator+=(), mrpt::math::TPoint3D::operator-(), mrpt::math::TPoint3D::operator-=(), mrpt::math::TPoint2D::operator-=(), mrpt::math::TPoint3D::operator/(), mrpt::math::TPoint2D::operator/=(), mrpt::math::operator<(), mrpt::math::operator<=(), mrpt::math::operator>=(), pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), internal::conj_helper< std::complex< RealScalar >, RealScalar, Conj, false >::pmul(), mrpt::opengl::CRenderizable::TRenderInfo::projectPoint(), mrpt::vision::pinhole::projectPoint_no_distortion(), psin< Packet4f >(), mrpt::utils::CDynamicGrid< TGasConcentrationCell >::resize(), mrpt::opengl::CPointCloud::setAllPoints(), mrpt::slam::CSimplePointsMap::setAllPointsTemplate(), mrpt::slam::CColouredPointsMap::setAllPointsTemplate(), mpMovableObject::SetCoordinateBase(), mrpt::opengl::CRenderizable::setLocation(), mrpt::opengl::CGridPlaneXZ::setPlaneYcoord(), mrpt::opengl::CCamera::setPointingAt(), mrpt::reactivenav::CParameterizedTrajectoryGenerator::setVertex_xy(), mrpt::poses::CPose3D::setYawPitchRoll(), sparse_product_impl2(), mrpt::math::TPoint3D::sqrDistanceTo(), mrpt::reactivenav::CParameterizedTrajectoryGenerator::TCPoint::TCPoint(), QuaternionBase< Derived >::toRotationMatrix(), mrpt::opengl::CSetOfTriangles::TTriangle::TTriangle(), and mpWindow::y2p().
Page generated by Doxygen 1.7.3 for MRPT 0.9.4 SVN: at Sat Mar 26 06:16:28 UTC 2011 |