Searched refs:UpLo (Results 1 - 25 of 30) sorted by relevance

12

/external/eigen/blas/
H A DPackedSelfadjointProduct.h18 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 Map<Matrix<Scalar,Dynamic,1> >(mat, UpLo==Lower ? size-i : (i+1)) += alpha * cj(vec[i]) * ConjRhsType(OtherMap(vec+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)));
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, boo
[all...]
H A DRank2Update.h18 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)) +=
27 numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1))
28 + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1));
36 template<typename Scalar, typename Index, int UpLo>
45 Map<Matrix<Scalar,Dynamic,1> >(mat+offset, UpLo==Lower ? size-i : (i+1)) +=
46 numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DMatrixBaseEigenvalues.h87 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/Core/products/
H A DSelfadjointMatrixVector_BLAS.h46 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs>
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,Specialized> { \
60 selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,BuiltIn>::run( \
63 selfadjoint_matrix_vector_product_symv<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs>::run( \
75 template<typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs> \
76 struct selfadjoint_matrix_vector_product_symv<EIGTYPE,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs> \
86 IsLower = UpLo == Lower ? 1 : 0 \
H A DSelfadjointProduct.h22 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 : (i+1)));
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,mat,stride,vecY,vecX,alpha);
47 template<typename MatrixType, typename OtherType, int UpLo, boo
[all...]
H A DGeneralMatrixMatrixTriangular_BLAS.h40 template <typename 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> { \
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, \
97 template <typename Index, int AStorageOrder, bool ConjugateA, int UpLo> \
[all...]
H A DGeneralMatrixMatrixTriangular.h15 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjLhs, bool ConjRhs>
28 template<typename LhsScalar, 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 struct general_matrix_matrix_triangular_product<Index,LhsScalar,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 struct general_matrix_matrix_triangular_product<Index,LhsScalar,LhsStorageOrder,ConjugateLhs,RhsScalar,RhsStorageOrder,ConjugateRhs,ColMajor,UpLo,Version>
90 tribb_kernel<LhsScalar, RhsScalar, Index, Traits::mr, Traits::nr, ConjugateLhs, ConjugateRhs, UpLo> sybb;
109 if (UpLo
[all...]
H A DSelfadjointRank2Update.h21 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)>
H A DSelfadjointMatrixVector.h23 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs, int Version=Specialized>
26 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs, int Version>
38 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjugateLhs, bool ConjugateRhs, int Version>
39 EIGEN_DONT_INLINE void selfadjoint_matrix_vector_product<Scalar,Index,StorageOrder,UpLo,ConjugateLhs,ConjugateRhs,Version>::run(
52 IsLower = UpLo == Lower ? 1 : 0,
/external/eigen/Eigen/src/Core/
H A DSelfAdjointView.h32 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&, typename MatrixType::ConstTransposeReturnType>::type tmp1(m_matrix);
186 typename internal::conditional<(TriMode&(Upper|Lower))==(UpLo
[all...]
H A DMatrixBase.h251 template<unsigned int UpLo> struct SelfAdjointViewReturnType { typedef SelfAdjointView<Derived, UpLo> Type; };
252 template<unsigned int UpLo> struct ConstSelfAdjointViewReturnType { typedef const SelfAdjointView<const Derived, UpLo> Type; };
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/SparseCholesky/
H A DSimplicialCholesky.h63 enum { UpLo = internal::traits<Derived>::UpLo }; enumerator in enum:Eigen::SimplicialCholeskyBase::__anon5676
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 }; enumerator in enum:Eigen::internal::traits::__anon5678
290 enum { UpLo = _UpLo }; enumerator in enum:Eigen::internal::traits::__anon5679
304 enum { UpLo = _UpLo }; enumerator in enum:Eigen::internal::traits::__anon5680
334 enum { UpLo = _UpLo }; enumerator in enum:Eigen::SimplicialLLT::__anon5681
425 enum { UpLo = _UpLo }; enumerator in enum:Eigen::SimplicialLDLT::__anon5682
507 enum { UpLo enumerator in enum:Eigen::SimplicialCholesky::__anon5683
[all...]
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DConjugateGradient.h172 UpLo = _UpLo enumerator in enum:Eigen::ConjugateGradient::__anon5626
203 && (UpLo==(Lower|Upper))
208 EIGEN_STATIC_ASSERT(EIGEN_IMPLIES(MatrixWrapper::MatrixFree,UpLo==(Lower|Upper)),MATRIX_FREE_CONJUGATE_GRADIENT_IS_COMPATIBLE_WITH_UPPER_UNION_LOWER_MODE_ONLY);
209 typedef typename internal::conditional<UpLo==(Lower|Upper),
211 typename MatrixWrapper::template ConstSelfAdjointViewReturnType<UpLo>::Type
H A DIterativeSolverBase.h55 template<int UpLo> struct ConstSelfAdjointViewReturnType {
56 typedef typename ActualMatrixType::template ConstSelfAdjointViewReturnType<UpLo>::Type Type;
104 template<int UpLo> struct ConstSelfAdjointViewReturnType
H A DIncompleteCholesky.h66 enum { UpLo = _UpLo }; enumerator in enum:Eigen::IncompleteCholesky::__anon5628
121 ord(mat.template selfadjointView<UpLo>(), pinv);
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DMINRES.h215 enum {UpLo = _UpLo}; enumerator in enum:Eigen::MINRES::__anon5944
246 && (UpLo==(Lower|Upper))
251 EIGEN_STATIC_ASSERT(EIGEN_IMPLIES(MatrixWrapper::MatrixFree,UpLo==(Lower|Upper)),MATRIX_FREE_CONJUGATE_GRADIENT_IS_COMPATIBLE_WITH_UPPER_UNION_LOWER_MODE_ONLY);
252 typedef typename internal::conditional<UpLo==(Lower|Upper),
254 typename MatrixWrapper::template ConstSelfAdjointViewReturnType<UpLo>::Type
/external/eigen/Eigen/src/SparseCore/
H A DSparseMatrixBase.h335 template<unsigned int UpLo> struct SelfAdjointViewReturnType { typedef SparseSelfAdjointView<Derived, UpLo> Type; };
336 template<unsigned int UpLo> struct ConstSelfAdjointViewReturnType { typedef const SparseSelfAdjointView<const Derived, UpLo> Type; };
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();
H A DTriangularSolver.h18 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);
H A DSparseUtil.h57 template<typename MatrixType, unsigned int UpLo> class SparseSelfAdjointView;
72 template<typename MatrixType,int UpLo> class SparseSymmetricPermutationProduct;
H A DSparseSelfAdjointView.h173 template<unsigned int UpLo>
174 typename SparseMatrixBase<Derived>::template ConstSelfAdjointViewReturnType<UpLo>::Type SparseMatrixBase<Derived>::selfadjointView() const
176 return SparseSelfAdjointView<const Derived, UpLo>(derived());
180 template<unsigned int UpLo>
181 typename SparseMatrixBase<Derived>::template SelfAdjointViewReturnType<UpLo>::Type SparseMatrixBase<Derived>::selfadjointView()
183 return SparseSelfAdjointView<Derived, UpLo>(derived());
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h19 template<typename MatrixType, int UpLo> struct LDLT_Traits;
59 UpLo = _UpLo enumerator in enum:Eigen::LDLT::__anon5033
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) ? Success : NumericalIssue;
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>
[all...]
H A DLLT.h16 template<typename MatrixType, int UpLo> struct LLT_Traits;
69 UpLo = _UpLo enumerator in enum:Eigen::LLT::__anon5035
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_matri
[all...]
/external/eigen/Eigen/src/CholmodSupport/
H A DCholmodSupport.h120 template<typename _Scalar, int _Options, typename _Index, unsigned int UpLo>
121 cholmod_sparse 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 }; enumerator in enum:Eigen::CholmodBase::__anon5036
252 cholmod_sparse A = viewAsCholmod(matrix.template selfadjointView<UpLo>());
270 cholmod_sparse A = viewAsCholmod(matrix.template selfadjointView<UpLo>());
/external/eigen/Eigen/src/PaStiXSupport/
H A DPaStiXSupport.h517 * \tparam UpLo The part of the matrix to use : Lower or Upper. The default is Lower as required by PaStiX
532 enum { UpLo = _UpLo }; enumerator in enum:Eigen::PastixLLT::__anon5653
586 out.template selfadjointView<Lower>() = matrix.template selfadjointView<UpLo>();
601 * \tparam UpLo The part of the matrix to use : Lower or Upper. The default is Lower as required by PaStiX
616 enum { UpLo = _UpLo }; enumerator in enum:Eigen::PastixLDLT::__anon5654
671 out.template selfadjointView<Lower>() = matrix.template selfadjointView<UpLo>();
/external/eigen/Eigen/src/PardisoSupport/
H A DPardisoSupport.h431 * \tparam UpLo can be any bitwise combination of Upper, Lower. The default is Upper, meaning only the upper triangular part has to be used.
452 enum { UpLo = _UpLo };
475 m_matrix.template selfadjointView<Upper>() = matrix.template selfadjointView<UpLo>().twistedBy(p_null);
516 enum { UpLo = Options&(Upper|Lower) };
536 m_matrix.template selfadjointView<Upper>() = matrix.template selfadjointView<UpLo>().twistedBy(p_null);

Completed in 401 milliseconds

12