/external/eigen/blas/ |
D | Rank2Update.h | 18 template<typename Scalar, typename Index, int UpLo> 26 …Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)) += in run() 27 …numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i … in run() 28 … + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)); in run() 36 template<typename Scalar, typename Index, int UpLo> 45 Map<Matrix<Scalar,Dynamic,1> >(mat+offset, UpLo==Lower ? size-i : (i+1)) += in run() 46 …numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i … in run() 47 … + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)); in run() 49 mat[offset+(UpLo==Lower ? 0 : i)] = numext::real(mat[offset+(UpLo==Lower ? 0 : i)]); in run() 50 offset += UpLo==Lower ? size-i : (i+1); in run()
|
D | PackedSelfadjointProduct.h | 18 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjLhs, bool ConjRhs> 21 template<typename Scalar, typename Index, int UpLo, bool ConjLhs, bool ConjRhs> 22 struct selfadjoint_packed_rank1_update<Scalar,Index,ColMajor,UpLo,ConjLhs,ConjRhs> 33 …alar,Dynamic,1> >(mat, UpLo==Lower ? size-i : (i+1)) += alpha * cj(vec[i]) * ConjRhsType(OtherMap(… 35 mat[UpLo==Lower ? 0 : i] = numext::real(mat[UpLo==Lower ? 0 : i]); 36 mat += UpLo==Lower ? size-i : (i+1); 41 template<typename Scalar, typename Index, int UpLo, bool ConjLhs, bool ConjRhs> 42 struct selfadjoint_packed_rank1_update<Scalar,Index,RowMajor,UpLo,ConjLhs,ConjRhs> 47 …selfadjoint_packed_rank1_update<Scalar,Index,ColMajor,UpLo==Lower?Upper:Lower,ConjRhs,ConjLhs>::ru…
|
/external/eigen/Eigen/src/Core/products/ |
D | SelfadjointProduct.h | 22 template<typename Scalar, typename Index, int UpLo, bool ConjLhs, bool ConjRhs> 23 struct selfadjoint_rank1_update<Scalar,Index,ColMajor,UpLo,ConjLhs,ConjRhs> 32 … Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i+(UpLo==Lower ? i : 0), (UpLo==Lower ? size-i : (i+1))) 33 …+= (alpha * cj(vecY[i])) * ConjLhsType(OtherMap(vecX+(UpLo==Lower ? i : 0),UpLo==Lower ? size-i : … 38 template<typename Scalar, typename Index, int UpLo, bool ConjLhs, bool ConjRhs> 39 struct selfadjoint_rank1_update<Scalar,Index,RowMajor,UpLo,ConjLhs,ConjRhs> 43 …selfadjoint_rank1_update<Scalar,Index,ColMajor,UpLo==Lower?Upper:Lower,ConjRhs,ConjLhs>::run(size,… 47 template<typename MatrixType, typename OtherType, int UpLo, bool OtherIsVector = OtherType::IsVecto… 50 template<typename MatrixType, typename OtherType, int UpLo> 51 struct selfadjoint_product_selector<MatrixType,OtherType,UpLo,true> [all …]
|
D | GeneralMatrixMatrixTriangular.h | 15 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjLhs, bool ConjRhs> 28 …hsScalar, typename RhsScalar, typename Index, int mr, int nr, bool ConjLhs, bool ConjRhs, int UpLo> 35 int ResStorageOrder, int UpLo, int Version = Specialized> 40 … typename RhsScalar, int RhsStorageOrder, bool ConjugateRhs, int UpLo, int Version> 41 …hsScalar,LhsStorageOrder,ConjugateLhs,RhsScalar,RhsStorageOrder,ConjugateRhs,RowMajor,UpLo,Version> 51 ColMajor, UpLo==Lower?Upper:Lower> 57 … typename RhsScalar, int RhsStorageOrder, bool ConjugateRhs, int UpLo, int Version> 58 …hsScalar,LhsStorageOrder,ConjugateLhs,RhsScalar,RhsStorageOrder,ConjugateRhs,ColMajor,UpLo,Version> 90 …kernel<LhsScalar, RhsScalar, Index, Traits::mr, Traits::nr, ConjugateLhs, ConjugateRhs, UpLo> sybb; 109 if (UpLo==Lower) [all …]
|
D | GeneralMatrixMatrixTriangular_BLAS.h | 40 …ypename Index, typename Scalar, int AStorageOrder, bool ConjugateA, int ResStorageOrder, int UpLo> 43 …Index,Scalar,AStorageOrder,ConjugateA,Scalar,AStorageOrder,ConjugateA,ResStorageOrder,UpLo,BuiltIn… 49 int RhsStorageOrder, bool ConjugateRhs, int UpLo> \ 51 Scalar,RhsStorageOrder,ConjugateRhs,ColMajor,UpLo,Specialized> { \ 55 if ( lhs==rhs && ((UpLo&(Lower|Upper)==UpLo)) ) { \ 56 general_matrix_matrix_rankupdate<Index,Scalar,LhsStorageOrder,ConjugateLhs,ColMajor,UpLo> \ 62 ColMajor, UpLo, BuiltIn> \ 76 template <typename Index, int AStorageOrder, bool ConjugateA, int UpLo> \ 77 struct general_matrix_matrix_rankupdate<Index,EIGTYPE,AStorageOrder,ConjugateA,ColMajor,UpLo> { \ 79 IsLower = (UpLo&Lower) == Lower, \ [all …]
|
D | SelfadjointMatrixVector_BLAS.h | 46 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool Conju… 48 …selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,BuiltIn… 51 template<typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs> \ 52 struct selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,S… 60 …selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,BuiltIn… 63 …selfadjoint_matrix_vector_product_symv<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs>::… 75 template<typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs> \ 76 struct selfadjoint_matrix_vector_product_symv<EIGTYPE,Index,StorageOrder,UpLo,ConjugateLhs,Conjugat… 86 IsLower = UpLo == Lower ? 1 : 0 \
|
D | SelfadjointRank2Update.h | 21 template<typename Scalar, typename Index, typename UType, typename VType, int UpLo> 58 template<typename MatrixType, unsigned int UpLo> 60 SelfAdjointView<MatrixType,UpLo>& SelfAdjointView<MatrixType,UpLo> 85 (IsRowMajor ? int(UpLo==Upper ? Lower : Upper) : UpLo)>
|
D | SelfadjointMatrixVector.h | 23 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool Conju… 26 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool Conju… 38 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool Conju… 39 EIGEN_DONT_INLINE void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLh… in run() 52 IsLower = UpLo == Lower ? 1 : 0, in run()
|
/external/eigen/Eigen/src/Core/ |
D | SelfAdjointView.h | 32 template<typename MatrixType, unsigned int UpLo> 33 struct traits<SelfAdjointView<MatrixType, UpLo> > : traits<MatrixType> 40 Mode = UpLo | SelfAdjoint, 49 template<typename _MatrixType, unsigned int UpLo> class SelfAdjointView 50 : public TriangularBase<SelfAdjointView<_MatrixType, UpLo> > 134 …const SelfAdjointView<const EIGEN_SCALAR_BINARYOP_EXPR_RETURN_TYPE(Scalar,MatrixType,product),UpLo> 137 return (s*mat.nestedExpression()).template selfadjointView<UpLo>(); 180 typename internal::conditional<(TriMode&(Upper|Lower))==(UpLo&(Upper|Lower)), 185 …typename internal::conditional<(TriMode&(Upper|Lower))==(UpLo&(Upper|Lower)), MatrixType&, typenam… 186 …typename internal::conditional<(TriMode&(Upper|Lower))==(UpLo&(Upper|Lower)), MatrixType&, typenam… [all …]
|
D | MatrixBase.h | 251 …template<unsigned int UpLo> struct SelfAdjointViewReturnType { typedef SelfAdjointView<Derived, Up… 252 …template<unsigned int UpLo> struct ConstSelfAdjointViewReturnType { typedef const SelfAdjointView<… 254 template<unsigned int UpLo> 256 typename SelfAdjointViewReturnType<UpLo>::Type selfadjointView(); 257 template<unsigned int UpLo> 259 typename ConstSelfAdjointViewReturnType<UpLo>::Type selfadjointView() const;
|
/external/eigen/Eigen/src/Eigenvalues/ |
D | MatrixBaseEigenvalues.h | 87 template<typename MatrixType, unsigned int UpLo> 88 inline typename SelfAdjointView<MatrixType, UpLo>::EigenvaluesReturnType 89 SelfAdjointView<MatrixType, UpLo>::eigenvalues() const 91 typedef typename SelfAdjointView<MatrixType, UpLo>::PlainObject PlainObject; 151 template<typename MatrixType, unsigned int UpLo> 152 inline typename SelfAdjointView<MatrixType, UpLo>::RealScalar 153 SelfAdjointView<MatrixType, UpLo>::operatorNorm() const
|
/external/eigen/Eigen/src/SparseCholesky/ |
D | SimplicialCholesky.h | 63 enum { UpLo = internal::traits<Derived>::UpLo }; 213 if(m_P.size()==0 && (UpLo&Upper)==Upper) 220 tmp.template selfadjointView<Upper>() = a.template selfadjointView<UpLo>().twistedBy(m_P); 276 enum { UpLo = _UpLo }; 290 enum { UpLo = _UpLo }; 304 enum { UpLo = _UpLo }; 334 enum { UpLo = _UpLo }; 425 enum { UpLo = _UpLo }; 507 enum { UpLo = _UpLo }; 515 typedef internal::traits<SimplicialLDLT<MatrixType,UpLo> > LDLTTraits; [all …]
|
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
D | ConjugateGradient.h | 172 UpLo = _UpLo 203 && (UpLo==(Lower|Upper)) 208 …EIGEN_STATIC_ASSERT(EIGEN_IMPLIES(MatrixWrapper::MatrixFree,UpLo==(Lower|Upper)),MATRIX_FREE_CONJU… 209 typedef typename internal::conditional<UpLo==(Lower|Upper), 211 … typename MatrixWrapper::template ConstSelfAdjointViewReturnType<UpLo>::Type
|
D | IterativeSolverBase.h | 55 template<int UpLo> struct ConstSelfAdjointViewReturnType { 56 typedef typename ActualMatrixType::template ConstSelfAdjointViewReturnType<UpLo>::Type Type; 104 template<int UpLo> struct ConstSelfAdjointViewReturnType
|
/external/eigen/Eigen/src/Cholesky/ |
D | LLT.h | 16 template<typename MatrixType, int UpLo> struct LLT_Traits; 69 UpLo = _UpLo enumerator 72 typedef internal::LLT_Traits<MatrixType,UpLo> Traits; 226 template<typename Scalar, int UpLo> struct llt_inplace; 462 if(internal::llt_inplace<typename MatrixType::Scalar, UpLo>::rankUpdate(m_matrix,v,sigma)>=0) 525 template<typename MatrixType, unsigned int UpLo> 526 inline const LLT<typename SelfAdjointView<MatrixType, UpLo>::PlainObject, UpLo> 527 SelfAdjointView<MatrixType, UpLo>::llt() const 529 return LLT<PlainObject,UpLo>(m_matrix);
|
D | LDLT.h | 19 template<typename MatrixType, int UpLo> struct LDLT_Traits; 59 UpLo = _UpLo enumerator 70 typedef internal::LDLT_Traits<MatrixType,UpLo> Traits; 289 template<int UpLo> struct ldlt_inplace; 517 …m_info = internal::ldlt_inplace<UpLo>::unblocked(m_matrix, m_transpositions, m_temporary, m_sign) … 550 internal::ldlt_inplace<UpLo>::update(m_matrix, m_transpositions, m_temporary, w, sigma); 649 template<typename MatrixType, unsigned int UpLo> 650 inline const LDLT<typename SelfAdjointView<MatrixType, UpLo>::PlainObject, UpLo> 651 SelfAdjointView<MatrixType, UpLo>::ldlt() const 653 return LDLT<PlainObject,UpLo>(m_matrix);
|
/external/eigen/Eigen/src/SparseCore/ |
D | SparseMatrixBase.h | 335 …template<unsigned int UpLo> struct SelfAdjointViewReturnType { typedef SparseSelfAdjointView<Deriv… 336 …template<unsigned int UpLo> struct ConstSelfAdjointViewReturnType { typedef const SparseSelfAdjoin… 338 template<unsigned int UpLo> inline 339 typename ConstSelfAdjointViewReturnType<UpLo>::Type selfadjointView() const; 340 template<unsigned int UpLo> inline 341 typename SelfAdjointViewReturnType<UpLo>::Type selfadjointView();
|
D | TriangularSolver.h | 18 int UpLo = (Mode & Lower) 201 int UpLo = (Mode & Lower) 210 template<typename Lhs, typename Rhs, int Mode, int UpLo> 211 struct sparse_solve_triangular_sparse_selector<Lhs,Rhs,Mode,UpLo,ColMajor> 218 const bool IsLower = (UpLo==Lower);
|
D | SparseSelfAdjointView.h | 174 template<unsigned int UpLo> 175 typename SparseMatrixBase<Derived>::template ConstSelfAdjointViewReturnType<UpLo>::Type SparseMatri… 177 return SparseSelfAdjointView<const Derived, UpLo>(derived()); 181 template<unsigned int UpLo> 182 typename SparseMatrixBase<Derived>::template SelfAdjointViewReturnType<UpLo>::Type SparseMatrixBase… 184 return SparseSelfAdjointView<Derived, UpLo>(derived());
|
D | SparseUtil.h | 57 template<typename MatrixType, unsigned int UpLo> class SparseSelfAdjointView; 72 template<typename MatrixType,int UpLo> class SparseSymmetricPermutationProduct;
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
D | MINRES.h | 215 enum {UpLo = _UpLo}; 246 && (UpLo==(Lower|Upper)) 251 …EIGEN_STATIC_ASSERT(EIGEN_IMPLIES(MatrixWrapper::MatrixFree,UpLo==(Lower|Upper)),MATRIX_FREE_CONJU… 252 typedef typename internal::conditional<UpLo==(Lower|Upper), 254 … typename MatrixWrapper::template ConstSelfAdjointViewReturnType<UpLo>::Type
|
/external/eigen/Eigen/src/CholmodSupport/ |
D | CholmodSupport.h | 120 template<typename _Scalar, int _Options, typename _Index, unsigned int UpLo> 121 … viewAsCholmod(const SparseSelfAdjointView<const SparseMatrix<_Scalar,_Options,_Index>, UpLo>& mat) 125 if(UpLo==Upper) res.stype = 1; 126 if(UpLo==Lower) res.stype = -1; 181 enum { UpLo = _UpLo }; 252 cholmod_sparse A = viewAsCholmod(matrix.template selfadjointView<UpLo>()); 270 cholmod_sparse A = viewAsCholmod(matrix.template selfadjointView<UpLo>());
|
/external/eigen/Eigen/src/PardisoSupport/ |
D | PardisoSupport.h | 452 enum { UpLo = _UpLo }; 475 …m_matrix.template selfadjointView<Upper>() = matrix.template selfadjointView<UpLo>().twistedBy(p_n… 516 enum { UpLo = Options&(Upper|Lower) }; 536 …m_matrix.template selfadjointView<Upper>() = matrix.template selfadjointView<UpLo>().twistedBy(p_n…
|
/external/eigen/Eigen/src/PaStiXSupport/ |
D | PaStiXSupport.h | 532 enum { UpLo = _UpLo }; 586 out.template selfadjointView<Lower>() = matrix.template selfadjointView<UpLo>(); 616 enum { UpLo = _UpLo }; 671 out.template selfadjointView<Lower>() = matrix.template selfadjointView<UpLo>();
|
/external/eigen/test/ |
D | sparse_solver.h | 229 if(Solver::UpLo==(Lower|Upper)) 232 halfA.template selfadjointView<Solver::UpLo>().rankUpdate(M); 329 if(Solver::UpLo == (Lower|Upper)) 332 …halfA.template selfadjointView<Solver::UpLo>() = A.template triangularView<Eigen::Lower>().twisted…
|