Typedefs | |
typedef __vector unsigned char | Packet16uc |
typedef __m128d | Packet2d |
typedef __vector __bool int | Packet4bi |
typedef __vector float | Packet4f |
typedef __vector int | Packet4i |
typedef __vector unsigned int | Packet4ui |
typedef __vector short int | Packet8i |
Enumerations | |
enum | { floor_log2_terminate, floor_log2_move_up, floor_log2_move_down, floor_log2_bogus } |
enum | { SDP_IsDiagonal, SDP_IsSparseRowMajor, SDP_IsSparseColMajor } |
enum | { PreconditionIfMoreColsThanRows, PreconditionIfMoreRowsThanCols } |
enum | PermPermProduct_t { PermPermProduct } |
Functions | |
template<typename T > | |
void | aligned_delete (T *ptr, size_t size) |
void | aligned_free (void *ptr) |
void * | aligned_malloc (size_t size) |
template<typename T > | |
T * | aligned_new (size_t size) |
void * | aligned_realloc (void *ptr, size_t new_size, size_t old_size) |
template<typename T > | |
T | amd_flip (const T &i) |
template<typename T0 , typename T1 > | |
void | amd_mark (const T0 *w, const T1 &j) |
template<typename T0 , typename T1 > | |
bool | amd_marked (const T0 *w, const T1 &j) |
template<typename T > | |
T | amd_unflip (const T &i) |
template<typename MatrixType , typename VectorsType , typename CoeffsType > | |
void | apply_block_householder_on_the_left (MatrixType &mat, const VectorsType &vectors, const CoeffsType &hCoeffs) |
template<typename VectorX , typename VectorY , typename OtherScalar > | |
void | apply_rotation_in_the_plane (VectorX &_x, VectorY &_y, const JacobiRotation< OtherScalar > &j) |
template<typename MatrixType > | |
SluMatrix | asSluMatrix (MatrixType &mat) |
template<typename MatrixType , typename Rhs , typename Dest , typename Preconditioner > | |
bool | bicgstab (const MatrixType &mat, const Rhs &rhs, Dest &x, const Preconditioner &precond, int &iters, typename Dest::RealScalar &tol_error) |
template<typename Derived > | |
const Derived::Scalar | bruteforce_det3_helper (const MatrixBase< Derived > &matrix, int a, int b, int c) |
template<typename Derived > | |
const Derived::Scalar | bruteforce_det4_helper (const MatrixBase< Derived > &matrix, int j, int k, int m, int n) |
template<typename OldType , typename NewType > | |
NewType | cast (const OldType &x) |
template<typename Index > | |
EIGEN_ALWAYS_INLINE void | check_rows_cols_for_overflow (Index rows, Index cols) |
template<typename T > | |
EIGEN_ALWAYS_INLINE void | check_size_for_overflow (size_t size) |
void | check_that_malloc_is_allowed () |
template<typename Scalar , typename CholmodType > | |
void | cholmod_configure_matrix (CholmodType &mat) |
template<typename MatrixType , int i, int j> | |
MatrixType::Scalar | cofactor_3x3 (const MatrixType &m) |
template<typename MatrixType , int i, int j> | |
MatrixType::Scalar | cofactor_4x4 (const MatrixType &matrix) |
template<typename MatrixType , typename ResultType > | |
void | compute_inverse_size2_helper (const MatrixType &matrix, const typename ResultType::Scalar &invdet, ResultType &result) |
template<typename MatrixType , typename ResultType > | |
void | compute_inverse_size3_helper (const MatrixType &matrix, const typename ResultType::Scalar &invdet, const Matrix< typename ResultType::Scalar, 3, 1 > &cofactors_col0, ResultType &result) |
template<typename LhsScalar , typename RhsScalar , int KcFactor> | |
void | 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. | |
template<typename LhsScalar , typename RhsScalar > | |
void | computeProductBlockingSizes (std::ptrdiff_t &k, std::ptrdiff_t &m, std::ptrdiff_t &n) |
template<typename T , bool Align> | |
void | conditional_aligned_delete (T *ptr, size_t size) |
template<typename T , bool Align> | |
void | conditional_aligned_delete_auto (T *ptr, size_t size) |
template<bool Align> | |
void | conditional_aligned_free (void *ptr) |
template<> | |
void | conditional_aligned_free< false > (void *ptr) |
template<bool Align> | |
void * | conditional_aligned_malloc (size_t size) |
template<> | |
void * | conditional_aligned_malloc< false > (size_t size) |
template<typename T , bool Align> | |
T * | conditional_aligned_new (size_t size) |
template<typename T , bool Align> | |
T * | conditional_aligned_new_auto (size_t size) |
template<bool Align> | |
void * | conditional_aligned_realloc (void *ptr, size_t new_size, size_t old_size) |
template<> | |
void * | conditional_aligned_realloc< false > (void *ptr, size_t new_size, size_t) |
template<typename T , bool Align> | |
T * | conditional_aligned_realloc_new (T *pts, size_t new_size, size_t old_size) |
template<typename T , bool Align> | |
T * | conditional_aligned_realloc_new_auto (T *pts, size_t new_size, size_t old_size) |
template<typename MatrixType , typename Rhs , typename Dest , typename Preconditioner > | |
EIGEN_DONT_INLINE void | conjugate_gradient (const MatrixType &mat, const Rhs &rhs, Dest &x, const Preconditioner &precond, int &iters, typename Dest::RealScalar &tol_error) |
template<typename T > | |
T * | const_cast_ptr (const T *ptr) |
template<typename T > | |
T * | construct_elements_of_array (T *ptr, size_t size) |
bool | copy_bool (bool b) |
template<typename Index > | |
Index | cs_tdfs (Index j, Index k, Index *head, const Index *next, Index *post, Index *stack) |
template<typename T > | |
void | destruct_elements_of_array (T *ptr, size_t size) |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (real, Scalar) real(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (imag, Scalar) imag(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (real_ref, Scalar) real_ref(Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (imag_ref, Scalar) imag_ref(Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (conj, Scalar) conj(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (abs, Scalar) abs(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (abs2, Scalar) abs2(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (norm1, Scalar) norm1(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (hypot, Scalar) hypot(const Scalar &x | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (sqrt, Scalar) sqrt(const Scalar &x) | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (atan2, Scalar) atan2(const Scalar &x | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (pow, Scalar) pow(const Scalar &x | |
template<typename Scalar > | |
EIGEN_MATHFUNC_RETVAL (random, Scalar) random(const Scalar &x | |
EIGEN_MEMBER_FUNCTOR (squaredNorm, Size *NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (norm,(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (stableNorm,(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (blueNorm,(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (hypotNorm,(Size-1)*functor_traits< scalar_hypot_op< Scalar > >::Cost) | |
EIGEN_MEMBER_FUNCTOR (sum,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (mean,(Size-1)*NumTraits< Scalar >::AddCost+NumTraits< Scalar >::MulCost) | |
EIGEN_MEMBER_FUNCTOR (minCoeff,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (maxCoeff,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (all,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (any,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (count,(Size-1)*NumTraits< Scalar >::AddCost) | |
EIGEN_MEMBER_FUNCTOR (prod,(Size-1)*NumTraits< Scalar >::MulCost) | |
void | eigen_pastix (pastix_data_t **pastix_data, int pastix_comm, int n, int *ptr, int *idx, float *vals, int *perm, int *invp, float *x, int nbrhs, int *iparm, double *dparm) |
void | eigen_pastix (pastix_data_t **pastix_data, int pastix_comm, int n, int *ptr, int *idx, double *vals, int *perm, int *invp, double *x, int nbrhs, int *iparm, double *dparm) |
void | eigen_pastix (pastix_data_t **pastix_data, int pastix_comm, int n, int *ptr, int *idx, std::complex< float > *vals, int *perm, int *invp, std::complex< float > *x, int nbrhs, int *iparm, double *dparm) |
void | eigen_pastix (pastix_data_t **pastix_data, int pastix_comm, int n, int *ptr, int *idx, std::complex< double > *vals, int *perm, int *invp, std::complex< double > *x, int nbrhs, int *iparm, double *dparm) |
template<typename MatrixType > | |
void | EigenSymmetrizeMatrixGraph (const MatrixType &In, MatrixType &Out, MatrixType &StrMatTrans, bool &hasTranspose) |
template<typename MatrixType > | |
void | EigenToCNumbering (MatrixType &mat) |
template<typename MatrixType > | |
void | EigenToFortranNumbering (MatrixType &mat) |
template<typename T > | |
const T::Scalar * | extract_data (const T &m) |
template<typename CJ , typename A , typename B , typename C , typename T > | |
void | gebp_madd (const CJ &cj, A &a, B &b, C &c, T &t) |
template<typename Derived > | |
const Derived::Scalar | general_det3_helper (const MatrixBase< Derived > &matrix, int i1, int i2, int i3, int j1, int j2, int j3) |
void * | generic_aligned_realloc (void *ptr, size_t size, size_t old_size) |
void | handmade_aligned_free (void *ptr) |
void * | handmade_aligned_malloc (size_t size) |
void * | handmade_aligned_realloc (void *ptr, size_t size, size_t=0) |
template<typename MatrixQR , typename HCoeffs > | |
void | householder_qr_inplace_blocked (MatrixQR &mat, HCoeffs &hCoeffs, typename MatrixQR::Index maxBlockSize=32, typename MatrixQR::Scalar *tempData=0) |
template<typename MatrixQR , typename HCoeffs > | |
void | householder_qr_inplace_unblocked (MatrixQR &mat, HCoeffs &hCoeffs, typename MatrixQR::Scalar *tempData=0) |
template<typename Scalar > | |
add_const_on_value_type < EIGEN_MATHFUNC_RETVAL(imag_ref, Scalar) >::type | imag_ref (const Scalar &x) |
template<typename Scalar > | |
bool | isApprox (const Scalar &x, const Scalar &y, typename NumTraits< Scalar >::Real precision=NumTraits< Scalar >::dummy_precision()) |
template<typename Scalar > | |
bool | isApproxOrLessThan (const Scalar &x, const Scalar &y, typename NumTraits< Scalar >::Real precision=NumTraits< Scalar >::dummy_precision()) |
template<typename T > | |
bool | isfinite (const T &x) |
template<typename Scalar , typename OtherScalar > | |
bool | isMuchSmallerThan (const Scalar &x, const OtherScalar &y, typename NumTraits< Scalar >::Real precision=NumTraits< Scalar >::dummy_precision()) |
template<typename TriangularFactorType , typename VectorsType , typename CoeffsType > | |
void | make_block_householder_triangular_factor (TriangularFactorType &triFactor, const VectorsType &vectors, const CoeffsType &hCoeffs) |
void | manage_caching_sizes (Action action, std::ptrdiff_t *l1=0, std::ptrdiff_t *l2=0) |
std::ptrdiff_t | manage_caching_sizes_helper (std::ptrdiff_t a, std::ptrdiff_t b) |
void | manage_multi_threading (Action action, int *v) |
template<typename Scalar , int Flags, typename Index > | |
MappedSparseMatrix< Scalar, Flags, Index > | map_superlu (SluMatrix &sluMat) |
template<typename Scalar , typename Index > | |
void | minimum_degree_ordering (SparseMatrix< Scalar, ColMajor, Index > &C, PermutationMatrix< Dynamic, Dynamic, Index > &perm) |
int | nbThreads () |
template<typename Packet > | |
Packet | pabs (const Packet &a) |
template<> | |
Packet4f | pabs (const Packet4f &a) |
template<> | |
Packet4i | pabs (const Packet4i &a) |
template<> | |
Packet2d | pabs (const Packet2d &a) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | pacos (const Packet &a) |
template<typename Packet > | |
Packet | padd (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | padd< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | padd< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | padd< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | padd< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | padd< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<int Offset, typename PacketType > | |
void | palign (PacketType &first, const PacketType &second) |
template<typename Packet > | |
Packet | pand (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | pand< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | pand< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | pand< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pand< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pand< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<typename Packet > | |
Packet | pandnot (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | pandnot< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | pandnot< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | pandnot< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pandnot< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pandnot< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<bool Condition, typename Functor , typename Index > | |
void | parallelize_gemm (const Functor &func, Index rows, Index cols, bool transpose) |
template<typename MatrixType , typename TranspositionType > | |
void | partial_lu_inplace (MatrixType &lu, TranspositionType &row_transpositions, typename TranspositionType::Index &nb_transpositions) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | pasin (const Packet &a) |
template<> | |
Packet2cf | pconj (const Packet2cf &a) |
template<typename Packet > | |
Packet | pconj (const Packet &a) |
template<> | |
Packet1cd | pconj (const Packet1cd &a) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | pcos (const Packet &a) |
template<> | |
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f | pcos< Packet4f > (const Packet4f &_x) |
template<typename Packet > | |
Packet | pcplxflip (const Packet &a) |
Packet2cf | pcplxflip (const Packet2cf &x) |
Packet1cd | pcplxflip (const Packet1cd &x) |
template<> | |
Packet2cf | pcplxflip< Packet2cf > (const Packet2cf &x) |
template<typename Packet > | |
Packet | pdiv (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | pdiv< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | pdiv< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | pdiv< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pdiv< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pdiv< Packet4i > (const Packet4i &, const Packet4i &) |
template<int UpLo, typename MatrixType , int DestOrder> | |
void | permute_symm_to_fullsymm (const MatrixType &mat, SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > &_dest, const typename MatrixType::Index *perm=0) |
template<int SrcUpLo, int DstUpLo, typename MatrixType , int DestOrder> | |
void | permute_symm_to_symm (const MatrixType &mat, SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > &_dest, const typename MatrixType::Index *perm=0) |
template<int _SrcUpLo, int _DstUpLo, typename MatrixType , int DstOrder> | |
void | permute_symm_to_symm (const MatrixType &mat, SparseMatrix< typename MatrixType::Scalar, DstOrder, typename MatrixType::Index > &_dest, const typename MatrixType::Index *perm) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | pexp (const Packet &a) |
template<> | |
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f | pexp< Packet4f > (const Packet4f &_x) |
template<typename Packet > | |
unpacket_traits< Packet >::type | pfirst (const Packet &a) |
template<> | |
std::complex< double > | pfirst< Packet1cd > (const Packet1cd &a) |
template<> | |
std::complex< float > | pfirst< Packet2cf > (const Packet2cf &a) |
template<> | |
double | pfirst< Packet2d > (const Packet2d &a) |
template<> | |
float | pfirst< Packet4f > (const Packet4f &a) |
template<> | |
int | pfirst< Packet4i > (const Packet4i &a) |
template<typename Packet > | |
Packet | pload (const typename unpacket_traits< Packet >::type *from) |
template<> | |
Packet1cd | pload< Packet1cd > (const std::complex< double > *from) |
template<> | |
Packet2cf | pload< Packet2cf > (const std::complex< float > *from) |
template<> | |
Packet2d | pload< Packet2d > (const double *from) |
template<> | |
Packet4f | pload< Packet4f > (const float *from) |
template<> | |
Packet4i | pload< Packet4i > (const int *from) |
template<typename Packet > | |
Packet | ploaddup (const typename unpacket_traits< Packet >::type *from) |
template<> | |
Packet1cd | ploaddup< Packet1cd > (const std::complex< double > *from) |
template<> | |
Packet2cf | ploaddup< Packet2cf > (const std::complex< float > *from) |
template<> | |
Packet2d | ploaddup< Packet2d > (const double *from) |
template<> | |
Packet4f | ploaddup< Packet4f > (const float *from) |
template<> | |
Packet4i | ploaddup< Packet4i > (const int *from) |
template<typename Packet , int LoadMode> | |
Packet | ploadt (const typename unpacket_traits< Packet >::type *from) |
template<typename Packet > | |
Packet | ploadu (const typename unpacket_traits< Packet >::type *from) |
template<> | |
Packet1cd | ploadu< Packet1cd > (const std::complex< double > *from) |
template<> | |
Packet2cf | ploadu< Packet2cf > (const std::complex< float > *from) |
template<> | |
Packet2d | ploadu< Packet2d > (const double *from) |
template<> | |
Packet4f | ploadu< Packet4f > (const float *from) |
template<> | |
Packet4i | ploadu< Packet4i > (const int *from) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | plog (const Packet &a) |
template<> | |
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f | plog< Packet4f > (const Packet4f &_x) |
template<typename Scalar > | |
packet_traits< Scalar >::type | plset (const Scalar &a) |
template<> | |
Packet2d | plset< double > (const double &a) |
template<> | |
Packet4f | plset< float > (const float &a) |
template<> | |
Packet4i | plset< int > (const int &a) |
template<> | |
Packet4f | pmadd (const Packet4f &a, const Packet4f &b, const Packet4f &c) |
template<> | |
Packet4i | pmadd (const Packet4i &a, const Packet4i &b, const Packet4i &c) |
template<typename Packet > | |
Packet | pmadd (const Packet &a, const Packet &b, const Packet &c) |
template<typename Packet > | |
Packet | pmax (const Packet &a, const Packet &b) |
template<> | |
Packet2d | pmax< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pmax< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pmax< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<typename Packet > | |
Packet | pmin (const Packet &a, const Packet &b) |
template<> | |
Packet2d | pmin< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pmin< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pmin< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<typename Packet > | |
Packet | pmul (const Packet &a, const Packet &b) |
template<> | |
std::complex< float > | pmul (const std::complex< float > &a, const std::complex< float > &b) |
template<> | |
std::complex< double > | pmul (const std::complex< double > &a, const std::complex< double > &b) |
template<> | |
Packet1cd | pmul< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | pmul< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | pmul< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pmul< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pmul< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<> | |
Packet2cf | pnegate (const Packet2cf &a) |
template<typename Packet > | |
Packet | pnegate (const Packet &a) |
template<> | |
Packet2d | pnegate (const Packet2d &a) |
template<> | |
Packet4f | pnegate (const Packet4f &a) |
template<> | |
Packet4i | pnegate (const Packet4i &a) |
template<> | |
Packet1cd | pnegate (const Packet1cd &a) |
template<typename Packet > | |
Packet | por (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | por< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | por< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | por< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | por< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | por< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<typename Packet > | |
unpacket_traits< Packet >::type | predux (const Packet &a) |
template<> | |
std::complex< double > | predux< Packet1cd > (const Packet1cd &a) |
template<> | |
std::complex< float > | predux< Packet2cf > (const Packet2cf &a) |
template<> | |
double | predux< Packet2d > (const Packet2d &a) |
template<> | |
float | predux< Packet4f > (const Packet4f &a) |
template<> | |
int | predux< Packet4i > (const Packet4i &a) |
template<typename Packet > | |
unpacket_traits< Packet >::type | predux_max (const Packet &a) |
template<> | |
double | predux_max< Packet2d > (const Packet2d &a) |
template<> | |
float | predux_max< Packet4f > (const Packet4f &a) |
template<> | |
int | predux_max< Packet4i > (const Packet4i &a) |
template<typename Packet > | |
unpacket_traits< Packet >::type | predux_min (const Packet &a) |
template<> | |
double | predux_min< Packet2d > (const Packet2d &a) |
template<> | |
float | predux_min< Packet4f > (const Packet4f &a) |
template<> | |
int | predux_min< Packet4i > (const Packet4i &a) |
template<typename Packet > | |
unpacket_traits< Packet >::type | predux_mul (const Packet &a) |
template<> | |
std::complex< double > | predux_mul< Packet1cd > (const Packet1cd &a) |
template<> | |
std::complex< float > | predux_mul< Packet2cf > (const Packet2cf &a) |
template<> | |
double | predux_mul< Packet2d > (const Packet2d &a) |
template<> | |
float | predux_mul< Packet4f > (const Packet4f &a) |
template<> | |
int | predux_mul< Packet4i > (const Packet4i &a) |
template<typename Packet > | |
Packet | preduxp (const Packet *vecs) |
template<> | |
Packet1cd | preduxp< Packet1cd > (const Packet1cd *vecs) |
template<> | |
Packet2cf | preduxp< Packet2cf > (const Packet2cf *vecs) |
template<> | |
Packet2d | preduxp< Packet2d > (const Packet2d *vecs) |
template<> | |
Packet4f | preduxp< Packet4f > (const Packet4f *vecs) |
template<> | |
Packet4i | preduxp< Packet4i > (const Packet4i *vecs) |
template<typename Scalar > | |
void | prefetch (const Scalar *addr) |
template<> | |
void | prefetch< double > (const double *addr) |
template<> | |
void | prefetch< float > (const float *addr) |
template<> | |
void | prefetch< int > (const int *addr) |
template<> | |
void | prefetch< std::complex< double > > (const std::complex< double > *addr) |
template<> | |
void | prefetch< std::complex< float > > (const std::complex< float > *addr) |
template<> | |
Packet2cf | preverse (const Packet2cf &a) |
template<typename Packet > | |
Packet | preverse (const Packet &a) |
template<> | |
Packet1cd | preverse (const Packet1cd &a) |
template<> | |
Packet2d | preverse (const Packet2d &a) |
template<> | |
Packet4f | preverse (const Packet4f &a) |
template<> | |
Packet4i | preverse (const Packet4i &a) |
template<typename Derived > | |
std::ostream & | print_matrix (std::ostream &s, const Derived &_m, const IOFormat &fmt) |
template<typename Packet > | |
Packet | pset1 (const typename unpacket_traits< Packet >::type &a) |
template<> | |
Packet1cd | pset1< Packet1cd > (const std::complex< double > &from) |
template<> | |
Packet2cf | pset1< Packet2cf > (const std::complex< float > &from) |
template<> | |
Packet2d | pset1< Packet2d > (const double &from) |
template<> | |
Packet4f | pset1< Packet4f > (const float &from) |
template<> | |
Packet4i | pset1< Packet4i > (const int &from) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | psin (const Packet &a) |
template<> | |
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f | psin< Packet4f > (const Packet4f &_x) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | psqrt (const Packet &a) |
template<> | |
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f | psqrt< Packet4f > (const Packet4f &_x) |
template<typename Scalar , typename Packet > | |
void | pstore (Scalar *to, const Packet &from) |
template<typename Packet > | |
void | pstore1 (typename unpacket_traits< Packet >::type *to, const typename unpacket_traits< Packet >::type &a) |
template<> | |
void | pstore1< Packet2d > (double *to, const double &a) |
template<> | |
void | pstore1< Packet4f > (float *to, const float &a) |
template<> | |
void | pstore< double > (double *to, const Packet2d &from) |
template<> | |
void | pstore< float > (float *to, const Packet4f &from) |
template<> | |
void | pstore< int > (int *to, const Packet4i &from) |
template<> | |
void | pstore< std::complex< double > > (std::complex< double > *to, const Packet1cd &from) |
template<> | |
void | pstore< std::complex< float > > (std::complex< float > *to, const Packet2cf &from) |
template<typename Scalar , typename Packet , int LoadMode> | |
void | pstoret (Scalar *to, const Packet &from) |
template<typename Scalar , typename Packet > | |
void | pstoreu (Scalar *to, const Packet &from) |
template<> | |
void | pstoreu< double > (double *to, const Packet2d &from) |
template<> | |
void | pstoreu< float > (float *to, const Packet4f &from) |
template<> | |
void | pstoreu< int > (int *to, const Packet4i &from) |
template<> | |
void | pstoreu< std::complex< double > > (std::complex< double > *to, const Packet1cd &from) |
template<> | |
void | pstoreu< std::complex< float > > (std::complex< float > *to, const Packet2cf &from) |
template<typename Packet > | |
Packet | psub (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | psub< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | psub< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | psub< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | psub< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | psub< Packet4i > (const Packet4i &a, const Packet4i &b) |
template<typename Packet > | |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet | ptan (const Packet &a) |
void | punpackp (Packet4f *vecs) |
template<typename Packet > | |
Packet | pxor (const Packet &a, const Packet &b) |
template<> | |
Packet1cd | pxor< Packet1cd > (const Packet1cd &a, const Packet1cd &b) |
template<> | |
Packet2cf | pxor< Packet2cf > (const Packet2cf &a, const Packet2cf &b) |
template<> | |
Packet2d | pxor< Packet2d > (const Packet2d &a, const Packet2d &b) |
template<> | |
Packet4f | pxor< Packet4f > (const Packet4f &a, const Packet4f &b) |
template<> | |
Packet4i | pxor< Packet4i > (const Packet4i &a, const Packet4i &b) |
void | queryCacheSizes (int &l1, int &l2, int &l3) |
int | queryL1CacheSize () |
int | queryTopLevelCacheSize () |
template<typename MatrixType , typename RealScalar , typename Index > | |
void | real_2x2_jacobi_svd (const MatrixType &matrix, Index p, Index q, JacobiRotation< RealScalar > *j_left, JacobiRotation< RealScalar > *j_right) |
template<typename Scalar > | |
add_const_on_value_type < EIGEN_MATHFUNC_RETVAL(real_ref, Scalar) >::type | real_ref (const Scalar &x) |
template<typename InputIterator , typename SparseMatrixType > | |
void | set_from_triplets (const InputIterator &begin, const InputIterator &end, SparseMatrixType &mat, int Options=0) |
void | setNbThreads (int v) |
template<typename T > | |
void | smart_copy (const T *start, const T *end, T *target) |
template<typename SparseLhsType , typename DenseRhsType , typename DenseResType , typename AlphaType > | |
void | sparse_time_dense_product (const SparseLhsType &lhs, const DenseRhsType &rhs, DenseResType &res, const AlphaType &alpha) |
template<typename ExpressionType , typename Scalar > | |
void | stable_norm_kernel (const ExpressionType &bl, Scalar &ssq, Scalar &scale, Scalar &invScale) |
void | throw_std_bad_alloc () |
template<typename MatrixType , typename CoeffVectorType > | |
void | tridiagonalization_inplace (MatrixType &matA, CoeffVectorType &hCoeffs) |
template<typename MatrixType , typename DiagonalType , typename SubDiagonalType > | |
void | tridiagonalization_inplace (MatrixType &mat, DiagonalType &diag, SubDiagonalType &subdiag, bool extractQ) |
Performs a full tridiagonalization in place. |
Variables | |
bool | IsComplex |
const Scalar & | y |
This is defined in the Jacobi module.
Applies the clock wise 2D rotation j to the set of 2D vectors of cordinates x and y:
typedef __vector unsigned char Packet16uc |
typedef __m128d Packet2d |
typedef __m128 Packet4f |
typedef __m128i Packet4i |
typedef uint32x4_t Packet4ui |
anonymous enum |
enum PermPermProduct_t |
|
inline |
References aligned_free().
|
inline |
References handmade_aligned_free().
Referenced by aligned_delete(), conditional_aligned_free(), aligned_allocator< T >::deallocate(), generic_aligned_realloc(), qFree(), and qRealloc().
|
inline |
References check_that_malloc_is_allowed(), handmade_aligned_malloc(), and throw_std_bad_alloc().
Referenced by aligned_new(), aligned_allocator< T >::allocate(), conditional_aligned_malloc(), generic_aligned_realloc(), qMalloc(), and qRealloc().
|
inline |
References aligned_malloc(), and construct_elements_of_array().
|
inline |
References EIGEN_UNUSED_VARIABLE, generic_aligned_realloc(), handmade_aligned_realloc(), and throw_std_bad_alloc().
Referenced by conditional_aligned_realloc().
|
inline |
Referenced by amd_mark(), amd_unflip(), and minimum_degree_ordering().
|
inline |
References amd_flip().
|
inline |
|
inline |
References amd_flip().
void Eigen::internal::apply_block_householder_on_the_left | ( | MatrixType & | mat, |
const VectorsType & | vectors, | ||
const CoeffsType & | hCoeffs | ||
) |
void apply_rotation_in_the_plane | ( | VectorX & | _x, |
VectorY & | _y, | ||
const JacobiRotation< OtherScalar > & | j | ||
) |
References Eigen::AlignedBit, JacobiRotation< Scalar >::c(), conj(), Eigen::Dynamic, eigen_assert, EIGEN_RESTRICT, IsComplex, Eigen::PacketAccessBit, padd(), pmul(), pstore(), pstoreu(), psub(), JacobiRotation< Scalar >::s(), and y.
Referenced by MatrixBase< Derived >::applyOnTheLeft(), and MatrixBase< Derived >::applyOnTheRight().
SluMatrix Eigen::internal::asSluMatrix | ( | MatrixType & | mat | ) |
References SluMatrix::Map().
Referenced by SuperLUBase< _MatrixType, SuperILU< _MatrixType > >::initFactorization().
bool Eigen::internal::bicgstab | ( | const MatrixType & | mat, |
const Rhs & | rhs, | ||
Dest & | x, | ||
const Preconditioner & | precond, | ||
int & | iters, | ||
typename Dest::RealScalar & | tol_error | ||
) |
References abs(), p, sqrt(), and y.
Referenced by BiCGSTAB< _MatrixType, _Preconditioner >::_solveWithGuess().
|
inline |
const Derived::Scalar Eigen::internal::bruteforce_det4_helper | ( | const MatrixBase< Derived > & | matrix, |
int | j, | ||
int | k, | ||
int | m, | ||
int | n | ||
) |
|
inline |
EIGEN_ALWAYS_INLINE void Eigen::internal::check_rows_cols_for_overflow | ( | Index | rows, |
Index | cols | ||
) |
References throw_std_bad_alloc().
Referenced by PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_init2(), PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::PlainObjectBase(), PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::resize(), and PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::resizeLike().
EIGEN_ALWAYS_INLINE void Eigen::internal::check_size_for_overflow | ( | size_t | size | ) |
References throw_std_bad_alloc().
|
inline |
Referenced by aligned_malloc(), and conditional_aligned_malloc< false >().
void Eigen::internal::cholmod_configure_matrix | ( | CholmodType & | mat | ) |
References eigen_assert.
|
inline |
|
inline |
References general_det3_helper().
|
inline |
|
inline |
void Eigen::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:
References EIGEN_UNUSED_VARIABLE, Eigen::GetAction, and manage_caching_sizes().
|
inline |
|
inline |
|
inline |
|
inline |
References aligned_free().
|
inline |
|
inline |
References aligned_malloc().
|
inline |
References check_that_malloc_is_allowed(), and throw_std_bad_alloc().
|
inline |
References construct_elements_of_array().
|
inline |
References construct_elements_of_array().
|
inline |
References aligned_realloc().
|
inline |
|
inline |
References construct_elements_of_array(), and destruct_elements_of_array().
|
inline |
References construct_elements_of_array(), and destruct_elements_of_array().
EIGEN_DONT_INLINE void Eigen::internal::conjugate_gradient | ( | const MatrixType & | mat, |
const Rhs & | rhs, | ||
Dest & | x, | ||
const Preconditioner & | precond, | ||
int & | iters, | ||
typename Dest::RealScalar & | tol_error | ||
) |
References abs(), p, real(), and sqrt().
Referenced by ConjugateGradient< _MatrixType, _UpLo, _Preconditioner >::_solveWithGuess().
T* Eigen::internal::const_cast_ptr | ( | const T * | ptr | ) |
|
inline |
Index Eigen::internal::cs_tdfs | ( | Index | j, |
Index | k, | ||
Index * | head, | ||
const Index * | next, | ||
Index * | post, | ||
Index * | stack | ||
) |
References p.
|
inline |
Referenced by conditional_aligned_realloc_new(), and conditional_aligned_realloc_new_auto().
|
inline |
References EIGEN_MATHFUNC_IMPL, and real().
|
inline |
References EIGEN_MATHFUNC_IMPL, and imag().
|
inline |
References EIGEN_MATHFUNC_IMPL, and real_ref().
|
inline |
References EIGEN_MATHFUNC_IMPL, and imag_ref().
|
inline |
References conj(), and EIGEN_MATHFUNC_IMPL.
|
inline |
References abs(), and EIGEN_MATHFUNC_IMPL.
|
inline |
References abs2(), and EIGEN_MATHFUNC_IMPL.
|
inline |
References EIGEN_MATHFUNC_IMPL.
|
inline |
|
inline |
References EIGEN_MATHFUNC_IMPL, and sqrt().
|
inline |
|
inline |
|
inline |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | squaredNorm | , |
Size *NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | norm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | stableNorm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | blueNorm | , |
(Size+5)*NumTraits< Scalar >::MulCost+(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | hypotNorm | , |
(Size-1)*functor_traits< scalar_hypot_op< Scalar > >::Cost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | sum | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | mean | , |
(Size-1)*NumTraits< Scalar >::AddCost+NumTraits< Scalar >::MulCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | minCoeff | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | maxCoeff | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | all | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | any | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | count | , |
(Size-1)*NumTraits< Scalar >::AddCost | |||
) |
Eigen::internal::EIGEN_MEMBER_FUNCTOR | ( | prod | , |
(Size-1)*NumTraits< Scalar >::MulCost | |||
) |
void Eigen::internal::eigen_pastix | ( | pastix_data_t ** | pastix_data, |
int | pastix_comm, | ||
int | n, | ||
int * | ptr, | ||
int * | idx, | ||
double * | vals, | ||
int * | perm, | ||
int * | invp, | ||
double * | x, | ||
int | nbrhs, | ||
int * | iparm, | ||
double * | dparm | ||
) |
void Eigen::internal::eigen_pastix | ( | pastix_data_t ** | pastix_data, |
int | pastix_comm, | ||
int | n, | ||
int * | ptr, | ||
int * | idx, | ||
std::complex< float > * | vals, | ||
int * | perm, | ||
int * | invp, | ||
std::complex< float > * | x, | ||
int | nbrhs, | ||
int * | iparm, | ||
double * | dparm | ||
) |
void Eigen::internal::eigen_pastix | ( | pastix_data_t ** | pastix_data, |
int | pastix_comm, | ||
int | n, | ||
int * | ptr, | ||
int * | idx, | ||
std::complex< double > * | vals, | ||
int * | perm, | ||
int * | invp, | ||
std::complex< double > * | x, | ||
int | nbrhs, | ||
int * | iparm, | ||
double * | dparm | ||
) |
void Eigen::internal::EigenSymmetrizeMatrixGraph | ( | const MatrixType & | In, |
MatrixType & | Out, | ||
MatrixType & | StrMatTrans, | ||
bool & | hasTranspose | ||
) |
References eigen_assert.
void Eigen::internal::EigenToCNumbering | ( | MatrixType & | mat | ) |
Referenced by PastixBase< Derived >::compute().
void Eigen::internal::EigenToFortranNumbering | ( | MatrixType & | mat | ) |
const T::Scalar* Eigen::internal::extract_data | ( | const T & | m | ) |
|
inline |
|
inline |
Referenced by cofactor_4x4().
|
inline |
References aligned_free(), and aligned_malloc().
Referenced by aligned_realloc().
|
inline |
Referenced by aligned_free().
|
inline |
Referenced by aligned_malloc(), and handmade_aligned_realloc().
|
inline |
References handmade_aligned_malloc().
Referenced by aligned_realloc().
void Eigen::internal::householder_qr_inplace_blocked | ( | MatrixQR & | mat, |
HCoeffs & | hCoeffs, | ||
typename MatrixQR::Index | maxBlockSize = 32 , |
||
typename MatrixQR::Scalar * | tempData = 0 |
||
) |
void Eigen::internal::householder_qr_inplace_unblocked | ( | MatrixQR & | mat, |
HCoeffs & | hCoeffs, | ||
typename MatrixQR::Scalar * | tempData = 0 |
||
) |
References eigen_assert, and PlainObjectBase< Derived >::resize().
Referenced by householder_qr_inplace_blocked().
|
inline |
Referenced by EIGEN_MATHFUNC_RETVAL().
|
inline |
|
inline |
bool Eigen::internal::isfinite | ( | const T & | x | ) |
|
inline |
References y.
Referenced by FullPivHouseholderQR< _MatrixType >::compute(), SelfAdjointEigenSolver< _MatrixType >::compute(), EigenSolver< _MatrixType >::eigenvectors(), Hyperplane< _Scalar, _AmbientDim, _Options >::intersection(), MatrixBase< Derived >::isDiagonal(), MatrixBase< Derived >::isIdentity(), MatrixBase< Derived >::isUnitary(), DenseBase< Derived >::isZero(), EigenSolver< _MatrixType >::pseudoEigenvalueMatrix(), and Eigen::umeyama().
void Eigen::internal::make_block_householder_triangular_factor | ( | TriangularFactorType & | triFactor, |
const VectorsType & | vectors, | ||
const CoeffsType & | hCoeffs | ||
) |
References eigen_assert.
Referenced by apply_block_householder_on_the_left().
|
inline |
|
inline |
Referenced by manage_caching_sizes().
|
inline |
References eigen_internal_assert, EIGEN_UNUSED, Eigen::GetAction, and Eigen::SetAction.
Referenced by nbThreads(), and setNbThreads().
MappedSparseMatrix<Scalar,Flags,Index> Eigen::internal::map_superlu | ( | SluMatrix & | sluMat | ) |
View a Super LU matrix as an Eigen expression
References Eigen::ColMajor, eigen_assert, SluMatrix::innerInd, SluMatrix::outerInd, Eigen::RowMajor, SluMatrix::storage, and SluMatrix::values.
void Eigen::internal::minimum_degree_ordering | ( | SparseMatrix< Scalar, ColMajor, Index > & | C, |
PermutationMatrix< Dynamic, Dynamic, Index > & | perm | ||
) |
References amd_flip(), SparseMatrix< _Scalar, _Options, _Index >::cols(), PermutationMatrix< SizeAtCompileTime, MaxSizeAtCompileTime, IndexType >::indices(), SparseMatrix< _Scalar, _Options, _Index >::innerIndexPtr(), SparseMatrix< _Scalar, _Options, _Index >::nonZeros(), SparseMatrix< _Scalar, _Options, _Index >::outerIndexPtr(), p, q, PermutationBase< Derived >::resize(), SparseMatrix< _Scalar, _Options, _Index >::resizeNonZeros(), and sqrt().
Referenced by SimplicialCholeskyBase< Derived >::ordering().
|
inline |
References Eigen::GetAction, and manage_multi_threading().
Referenced by parallelize_gemm().
|
inline |
References abs().
|
inline |
Referenced by pcos< Packet4f >(), and psin< Packet4f >().
|
inline |
|
inline |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::pacos | ( | const Packet & | a | ) |
References acos().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
void Eigen::internal::parallelize_gemm | ( | const Functor & | func, |
Index | rows, | ||
Index | cols, | ||
bool | transpose | ||
) |
References EIGEN_UNUSED_VARIABLE, and nbThreads().
void Eigen::internal::partial_lu_inplace | ( | MatrixType & | lu, |
TranspositionType & | row_transpositions, | ||
typename TranspositionType::Index & | nb_transpositions | ||
) |
References Eigen::ColMajor, eigen_assert, Eigen::RowMajor, and Eigen::RowMajorBit.
Referenced by PartialPivLU< _MatrixType >::compute().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::pasin | ( | const Packet & | a | ) |
References asin().
|
inline |
|
inline |
References conj().
|
inline |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::pcos | ( | const Packet & | a | ) |
References cos().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f Eigen::internal::pcos< Packet4f > | ( | const Packet4f & | _x | ) |
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4i, pabs(), padd(), pmadd(), pmul(), psub(), and y.
|
inline |
References vec4f_swizzle1.
|
inline |
References preverse().
|
inline |
|
inline |
Referenced by pdiv< Packet2cf >().
|
inline |
References pmul().
|
inline |
|
inline |
References eigen_assert, and pset1< Packet4i >().
void permute_symm_to_fullsymm | ( | const MatrixType & | mat, |
SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > & | _dest, | ||
const typename MatrixType::Index * | perm = 0 |
||
) |
void Eigen::internal::permute_symm_to_symm | ( | const MatrixType & | mat, |
SparseMatrix< typename MatrixType::Scalar, DestOrder, typename MatrixType::Index > & | _dest, | ||
const typename MatrixType::Index * | perm = 0 |
||
) |
void Eigen::internal::permute_symm_to_symm | ( | const MatrixType & | mat, |
SparseMatrix< typename MatrixType::Scalar, DstOrder, typename MatrixType::Index > & | _dest, | ||
const typename MatrixType::Index * | perm | ||
) |
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::pexp | ( | const Packet & | a | ) |
References exp().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f Eigen::internal::pexp< Packet4f > | ( | const Packet4f & | _x | ) |
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4i, padd(), pmadd(), pmax(), pmin(), pmul(), psub(), and y.
|
inline |
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 >(), and predux_mul< Packet4f >().
|
inline |
References EIGEN_ALIGN16.
|
inline |
References EIGEN_ALIGN16, and pstore().
|
inline |
References EIGEN_ALIGN16.
References EIGEN_ALIGN16.
|
inline |
|
inline |
References EIGEN_DEBUG_ALIGNED_LOAD, and pload< Packet2d >().
|
inline |
References EIGEN_DEBUG_ALIGNED_LOAD, and pload< Packet4f >().
|
inline |
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by pload< Packet1cd >().
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by pload< Packet2cf >(), ploaddup< Packet4f >(), and pset1< Packet2cf >().
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by ploaddup< Packet4i >().
|
inline |
|
inline |
References pset1< Packet1cd >().
|
inline |
References pset1< Packet2cf >().
|
inline |
References pset1< Packet2d >().
References p, pload< Packet4f >(), and ploadu< Packet4f >().
References p, pload< Packet4i >(), and ploadu< Packet4i >().
|
inline |
References Eigen::Aligned.
|
inline |
|
inline |
References EIGEN_DEBUG_UNALIGNED_LOAD, and ploadu< Packet2d >().
Referenced by pset1< Packet1cd >().
|
inline |
References EIGEN_DEBUG_UNALIGNED_LOAD, and ploadu< Packet4f >().
|
inline |
References EIGEN_DEBUG_UNALIGNED_LOAD.
Referenced by ploadu< Packet1cd >().
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by ploaddup< Packet4f >(), ploadu< Packet2cf >(), and pset1< Packet2cf >().
References EIGEN_DEBUG_ALIGNED_LOAD.
Referenced by ploaddup< Packet4i >().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::plog | ( | const Packet & | a | ) |
References log().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f Eigen::internal::plog< Packet4f > | ( | const Packet4f & | _x | ) |
References _EIGEN_DECLARE_CONST_Packet4f, _EIGEN_DECLARE_CONST_Packet4f_FROM_INT, _EIGEN_DECLARE_CONST_Packet4i, padd(), pmadd(), pmax(), pmul(), psub(), and y.
|
inline |
|
inline |
References pset1< Packet2d >().
References pset1< Packet4f >().
References pset1< Packet4i >().
|
inline |
Referenced by pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), and psin< Packet4f >().
|
inline |
|
inline |
|
inline |
Referenced by pexp< Packet4f >(), and plog< Packet4f >().
|
inline |
|
inline |
Referenced by pexp< Packet4f >().
|
inline |
|
inline |
Referenced by apply_rotation_in_the_plane(), DiagonalProduct< MatrixType, DiagonalType, ProductOrder >::packet_impl(), pcos< Packet4f >(), pdiv< Packet1cd >(), pdiv< Packet2cf >(), pexp< Packet4f >(), plog< Packet4f >(), pmadd(), predux_mul< Packet2cf >(), predux_mul< Packet4f >(), psin< Packet4f >(), and psqrt< Packet4f >().
|
inline |
|
inline |
|
inline |
References vec2d_swizzle1.
|
inline |
|
inline |
|
inline |
Referenced by pnegate().
|
inline |
|
inline |
|
inline |
References psub< Packet4f >().
|
inline |
References psub< Packet4i >().
|
inline |
References pnegate().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
References pfirst().
|
inline |
|
inline |
References pfirst().
|
inline |
|
inline |
References pfirst().
|
inline |
References pfirst().
|
inline |
References pfirst().
|
inline |
|
inline |
References pfirst().
|
inline |
References pfirst().
|
inline |
References pfirst().
|
inline |
|
inline |
References pfirst().
|
inline |
|
inline |
References pfirst().
|
inline |
|
inline |
References EIGEN_ALIGN16, and pstore().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
std::ostream & print_matrix | ( | std::ostream & | s, |
const Derived & | _m, | ||
const IOFormat & | fmt | ||
) |
References IOFormat::coeffSeparator, Eigen::DontAlignCols, IOFormat::flags, Eigen::FullPrecision, IOFormat::matPrefix, IOFormat::matSuffix, IOFormat::precision, IOFormat::rowPrefix, IOFormat::rowSeparator, IOFormat::rowSpacer, IOFormat::rowSuffix, and Eigen::StreamPrecision.
Referenced by DenseBase< Derived >::operator<<().
|
inline |
|
inline |
References ploadu< Packet1cd >().
Referenced by ploaddup< Packet1cd >().
|
inline |
References pload< Packet4f >(), and ploadu< Packet4f >().
Referenced by ploaddup< Packet2cf >().
|
inline |
Referenced by ploaddup< Packet2d >(), and plset< double >().
References EIGEN_ALIGN16.
Referenced by plset< float >(), and psqrt< Packet4f >().
References EIGEN_ALIGN16.
Referenced by pdiv< Packet4i >(), and plset< int >().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::psin | ( | const Packet & | a | ) |
References sin().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f Eigen::internal::psin< Packet4f > | ( | const Packet4f & | _x | ) |
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 Eigen::internal::psqrt | ( | const Packet & | a | ) |
References sqrt().
EIGEN_DEFINE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS EIGEN_UNUSED Packet4f Eigen::internal::psqrt< Packet4f > | ( | const Packet4f & | _x | ) |
References pmul(), pset1< Packet4f >(), and psub().
|
inline |
|
inline |
References pstore().
|
inline |
References pstore(), and vec2d_swizzle1.
|
inline |
References pstore(), and vec4f_swizzle1.
|
inline |
References EIGEN_DEBUG_ALIGNED_STORE.
|
inline |
References EIGEN_DEBUG_ALIGNED_STORE.
References EIGEN_DEBUG_ALIGNED_STORE.
|
inline |
References EIGEN_DEBUG_ALIGNED_STORE, and pstore().
|
inline |
References EIGEN_DEBUG_ALIGNED_STORE, and pstore().
|
inline |
References Eigen::Aligned, pstore(), and pstoreu().
|
inline |
|
inline |
References EIGEN_DEBUG_UNALIGNED_STORE.
|
inline |
References EIGEN_DEBUG_UNALIGNED_STORE.
References EIGEN_DEBUG_UNALIGNED_STORE.
|
inline |
References EIGEN_DEBUG_UNALIGNED_STORE, and pstoreu().
|
inline |
References EIGEN_DEBUG_UNALIGNED_STORE, and pstoreu().
|
inline |
|
inline |
|
inline |
|
inline |
Referenced by pnegate().
Referenced by pnegate().
EIGEN_DECLARE_FUNCTION_ALLOWING_MULTIPLE_DEFINITIONS Packet Eigen::internal::ptan | ( | const Packet & | a | ) |
References tan().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
Referenced by queryL1CacheSize(), and queryTopLevelCacheSize().
|
inline |
References queryCacheSizes().
Referenced by manage_caching_sizes().
|
inline |
References queryCacheSizes().
Referenced by manage_caching_sizes().
void Eigen::internal::real_2x2_jacobi_svd | ( | const MatrixType & | matrix, |
Index | p, | ||
Index | q, | ||
JacobiRotation< RealScalar > * | j_left, | ||
JacobiRotation< RealScalar > * | j_right | ||
) |
References abs2(), MatrixBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::applyOnTheLeft(), PlainObjectBase< Matrix< _Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::coeff(), JacobiRotation< Scalar >::makeJacobi(), real(), sqrt(), and JacobiRotation< Scalar >::transpose().
Referenced by JacobiSVD< _MatrixType, QRPreconditioner >::compute().
|
inline |
void Eigen::internal::set_from_triplets | ( | const InputIterator & | begin, |
const InputIterator & | end, | ||
SparseMatrixType & | mat, | ||
int | Options = 0 |
||
) |
References EIGEN_UNUSED_VARIABLE, and PlainObjectBase< Derived >::setZero().
Referenced by SparseMatrix< _Scalar, _Options, _Index >::setFromTriplets().
|
inline |
Sets the max number of threads reserved for Eigen
References manage_multi_threading(), and Eigen::SetAction.
void Eigen::internal::smart_copy | ( | const T * | start, |
const T * | end, | ||
T * | target | ||
) |
|
inline |
|
inline |
References abs2().
Referenced by MatrixBase< Derived >::stableNorm().
|
inline |
void tridiagonalization_inplace | ( | MatrixType & | matA, |
CoeffVectorType & | hCoeffs | ||
) |
References conj(), and eigen_assert.
Referenced by Tridiagonalization< _MatrixType >::compute(), SelfAdjointEigenSolver< _MatrixType >::compute(), and Tridiagonalization< _MatrixType >::Tridiagonalization().
void Eigen::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:
Here is a random symmetric 5x5 matrix: 1.36 -0.816 0.521 1.43 -0.144 -0.816 -0.659 0.794 -0.173 -0.406 0.521 0.794 -0.541 0.461 0.179 1.43 -0.173 0.461 -1.43 0.822 -0.144 -0.406 0.179 0.822 -1.37 The orthogonal matrix Q is: 1 0 0 0 0 0 -0.471 0.127 -0.671 -0.558 0 0.301 -0.195 0.437 -0.825 0 0.825 0.0459 -0.563 -0.00872 0 -0.0832 -0.971 -0.202 0.0922 The diagonal of the tridiagonal matrix T is: 1.36 -1.2 -1.28 -1.69 0.164 The subdiagonal of the tridiagonal matrix T is: 1.73 -0.966 0.214 0.345
References eigen_assert.
bool IsComplex |
const Scalar& y |
Referenced by PlainObjectBase< Matrix< int, _Rows, _Cols, _Options, _MaxRows, _MaxCols > >::_init2(), apply_rotation_in_the_plane(), MatrixBase< Derived >::applyOnTheLeft(), MatrixBase< Derived >::applyOnTheRight(), Array< Index, 64, 1 >::Array(), bicgstab(), QuaternionBase< Derived >::conjugate(), SimplicialCholeskyBase< Derived >::factorize_preordered(), isMuchSmallerThan(), Matrix< Index, 1, ColsAtCompileTime, RowMajor, 1, MaxColsAtCompileTime >::Matrix(), pcos< Packet4f >(), pexp< Packet4f >(), plog< Packet4f >(), psin< Packet4f >(), and QuaternionBase< Derived >::toRotationMatrix().