HomeSort by relevance Sort by last modified time
    Searched refs:uplo (Results 1 - 19 of 19) sorted by null

  /external/ceres-solver/internal/ceres/
blas.cc 34 extern "C" void dsyrk_(char* uplo,
58 char uplo = 'L';
64 dsyrk_(&uplo,
lapack.cc 35 extern "C" void dpotrf_(char* uplo,
41 extern "C" void dpotrs_(char* uplo,
50 extern "C" void dgels_(char* uplo,
73 char uplo = 'L';
79 dpotrf_(&uplo, &n, lhs, &n, &info);
85 dpotrs_(&uplo, &n, &nrhs, lhs, &n, rhs_and_solution, &n, &info);
  /external/eigen/lapack/
cholesky.cpp 14 EIGEN_LAPACK_FUNC(potrf,(char* uplo, int *n, RealScalar *pa, int *lda, int *info))
17 if(UPLO(*uplo)==INVALID) *info = -1;
29 if(UPLO(*uplo)==UP) ret = internal::llt_inplace<Scalar, Upper>::blocked(A);
41 EIGEN_LAPACK_FUNC(potrs,(char* uplo, int *n, int *nrhs, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, int *info))
44 if(UPLO(*uplo)==INVALID) *info = -1;
60 if(UPLO(*uplo)==UP
    [all...]
eigenvalues.cpp 14 EIGEN_LAPACK_FUNC(syev,(char *jobz, char *uplo, int* n, Scalar* a, int *lda, Scalar* w, Scalar* /*work*/, int* lwork, int *info))
21 else if(UPLO(*uplo)==INVALID) *info = -2;
28 // int nb = ILAENV( 1, 'SSYTRD', UPLO, N, -1, -1, -1 )
59 if(UPLO(*uplo)==UP) mat = matrix(a,*n,*n,*lda).adjoint();
  /external/eigen/Eigen/src/Core/products/
TriangularSolverMatrix_MKL.h 57 char side = 'L', uplo, diag='N', transa; \
67 /* Set uplo */ \
68 uplo = IsLower ? 'L' : 'U'; \
69 if (TriStorageOrder==RowMajor) uplo = (uplo == 'L') ? 'U' : 'L'; \
85 MKLPREFIX##trsm(&side, &uplo, &transa, &diag, &m, &n, &alpha, (const MKLTYPE*)a, &lda, (MKLTYPE*)_other, &ldb); \
112 char side = 'R', uplo, diag='N', transa; \
122 /* Set uplo */ \
123 uplo = IsLower ? 'L' : 'U'; \
124 if (TriStorageOrder==RowMajor) uplo = (uplo == 'L') ? 'U' : 'L';
    [all...]
SelfadjointMatrixMatrix_MKL.h 57 char side='L', uplo='L'; \
79 if (LhsStorageOrder==RowMajor) uplo='U'; \
89 MKLPREFIX##symm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &beta_, (MKLTYPE*)res, &ldc); \
108 char side='L', uplo='L'; \
137 if (LhsStorageOrder==RowMajor) uplo='U'; \
157 MKLPREFIX##hemm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &beta_, (MKLTYPE*)res, &ldc); \
184 char side='R', uplo='L'; \
205 if (RhsStorageOrder==RowMajor) uplo='U'; \
215 MKLPREFIX##symm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &beta_, (MKLTYPE*)res, &ldc); \
234 char side='R', uplo='L';
    [all...]
GeneralMatrixMatrixTriangular_MKL.h 40 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> \
75 template <typename Index, int AStorageOrder, bool ConjugateA, int UpLo> \
76 struct general_matrix_matrix_rankupdate<Index,EIGTYPE,AStorageOrder,ConjugateA,ColMajor,UpLo> { \
78 IsLower = (UpLo&Lower) == Lower, \
88 char uplo=(IsLower) ? 'L' : 'U', trans=(AStorageOrder==RowMajor) ? 'T':'N';
    [all...]
TriangularMatrixMatrix_MKL.h 133 char side = 'L', transa, uplo, diag = 'N'; \
157 /* Set uplo */ \
158 uplo = IsLower ? 'L' : 'U'; \
159 if (LhsStorageOrder==RowMajor) uplo = (uplo == 'L') ? 'U' : 'L'; \
178 MKLPREFIX##trmm(&side, &uplo, &transa, &diag, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (MKLTYPE*)b, &ldb); \
247 char side = 'R', transa, uplo, diag = 'N'; \
271 /* Set uplo */ \
272 uplo = IsLower ? 'L' : 'U'; \
273 if (RhsStorageOrder==RowMajor) uplo = (uplo == 'L') ? 'U' : 'L';
    [all...]
TriangularMatrixVector_MKL.h 107 char trans, uplo, diag; \
120 /* Set uplo, trans and diag*/ \
122 uplo = IsLower ? 'L' : 'U'; \
126 MKLPREFIX##trmv(&uplo, &trans, &diag, &n, (const MKLTYPE*)_lhs, &lda, (MKLTYPE*)x, &incx); \
192 char trans, uplo, diag; \
205 /* Set uplo, trans and diag*/ \
207 uplo = IsLower ? 'U' : 'L'; \
211 MKLPREFIX##trmv(&uplo, &trans, &diag, &n, (const MKLTYPE*)_lhs, &lda, (MKLTYPE*)x, &incx); \
SelfadjointMatrixVector_MKL.h 46 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 \
91 char uplo=(IsRowMajor) ? (IsLower ? 'U' : 'L') : (IsLower ? 'L' : 'U');
    [all...]
  /external/eigen/blas/
level2_real_impl.h 13 int EIGEN_BLAS_FUNC(symv) (char *uplo, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *px, int *incx, RealScalar *pbeta, RealScalar *py, int *incy)
23 if(UPLO(*uplo)==INVALID) info = 1;
44 if(UPLO(*uplo)==UP) vector(actual_y,*n).noalias() += matrix(a,*n,*n,*lda).selfadjointView<Upper>() * (alpha * vector(actual_x,*n));
45 else if(UPLO(*uplo)==LO) vector(actual_y,*n).noalias() += matrix(a,*n,*n,*lda).selfadjointView<Lower>() * (alpha * vector(actual_x,*n));
54 int EIGEN_BLAS_FUNC(syr)(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *pc, int *ldc)
77 if(UPLO(*uplo)==INVALID) info = 1
    [all...]
level2_cplx_impl.h 19 int EIGEN_BLAS_FUNC(hemv)(char *uplo, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *px, int *incx, RealScalar *pbeta, RealScalar *py, int *incy)
29 if(UPLO(*uplo)==INVALID) info = 1;
52 if(UPLO(*uplo)==UP) vector(actual_y,*n).noalias() += matrix(a,*n,*n,*lda).selfadjointView<Upper>() * (alpha * vector(actual_x,*n));
53 else if(UPLO(*uplo)==LO) vector(actual_y,*n).noalias() += matrix(a,*n,*n,*lda).selfadjointView<Lower>() * (alpha * vector(actual_x,*n));
69 // int EIGEN_BLAS_FUNC(hbmv)(char *uplo, int *n, int *k, RealScalar *alpha, RealScalar *a, int *lda,
82 // int EIGEN_BLAS_FUNC(hpmv)(char *uplo, int *n, RealScalar *alpha, RealScalar *ap, RealScalar *x, int *incx, RealScalar *beta, RealScalar *y, int *incy)
94 // int EIGEN_BLAS_FUNC(hpr)(char *uplo, int *n, RealScalar *alpha, RealScalar *x, int *incx, RealScalar *ap
    [all...]
level3_impl.h 66 int EIGEN_BLAS_FUNC(trsm)(char *side, char *uplo, char *opa, char *diag, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb)
68 // std::cerr << "in trsm " << *side << " " << *uplo << " " << *opa << " " << *diag << " " << *m << "," << *n << " " << *palpha << " " << *lda << " " << *ldb<< "\n";
120 else if(UPLO(*uplo)==INVALID) info = 2;
130 int code = OP(*opa) | (SIDE(*side) << 2) | (UPLO(*uplo) << 3) | (DIAG(*diag) << 4);
152 int EIGEN_BLAS_FUNC(trmm)(char *side, char *uplo, char *opa, char *diag, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb)
154 // std::cerr << "in trmm " << *side << " " << *uplo << " " << *opa << " " << *diag << " " << *m << " " << *n << " " << *lda << " " << *ldb << " " << *palpha << "\n";
204 else if(UPLO(*uplo)==INVALID) info = 2
    [all...]
level2_impl.h 73 int EIGEN_BLAS_FUNC(trsv)(char *uplo, char *opa, char *diag, int *n, RealScalar *pa, int *lda, RealScalar *pb, int *incb)
107 if(UPLO(*uplo)==INVALID) info = 1;
118 int code = OP(*opa) | (UPLO(*uplo) << 2) | (DIAG(*diag) << 3);
128 int EIGEN_BLAS_FUNC(trmv)(char *uplo, char *opa, char *diag, int *n, RealScalar *pa, int *lda, RealScalar *pb, int *incb)
162 if(UPLO(*uplo)==INVALID) info = 1;
178 int code = OP(*opa) | (UPLO(*uplo) << 2) | (DIAG(*diag) << 3)
    [all...]
common.h 47 #define UPLO(X) ( ((X)=='U' || (X)=='u') ? UP \
66 inline bool check_uplo(const char* uplo)
68 return UPLO(*uplo)!=0xff;
  /external/eigen/bench/btl/libs/BLAS/
blas_interface.hh 30 // void spotrf_(const char* uplo, const int* n, float *a, const int* ld, int* info);
31 // void dpotrf_(const char* uplo, const int* n, double *a, const int* ld, int* info);
32 void ssytrd_(char *uplo, const int *n, float *a, const int *lda, float *d, float *e, float *tau, float *work, int *lwork, int *info );
33 void dsytrd_(char *uplo, const int *n, double *a, const int *lda, double *d, double *e, double *tau, double *work, int *lwork, int *info );
blas_interface_impl.hh 69 char uplo = 'L'; local
71 BLAS_FUNC(potrf)(&uplo, &N, C, &N, &info);
78 char uplo = 'L'; local
104 char uplo = 'L'; local
135 char uplo = 'U'; local
142 BLAS_FUNC(sytrd)(&uplo, &N, C, &N, d, d+N, d+2*N, d+3*N, &worksize, &info);
  /external/eigen/Eigen/src/Cholesky/
LLT_MKL.h 49 static inline typename MatrixType::Index potrf(MatrixType& m, char uplo) \
62 info = LAPACKE_##MKLPREFIX##potrf( matrix_order, uplo, size, (MKLTYPE*)a, lda ); \
  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver_MKL.h 69 char jobz, uplo='L'/*, range='A'*/; \
72 info = LAPACKE_##MKLNAME( matrix_order, jobz, uplo, n, (MKLTYPE*)m_eivec.data(), lda, (MKLRTYPE*)m_eivalues.data() ); \

Completed in 2038 milliseconds