Searched refs:uplo (Results 1 - 19 of 19) sorted by relevance

/external/ceres-solver/internal/ceres/
H A Dblas.cc34 extern "C" void dsyrk_(char* uplo,
58 char uplo = 'L';
64 dsyrk_(&uplo,
H A Dlapack.cc35 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/
H A Dcholesky.cpp14 EIGEN_LAPACK_FUNC(potrf,(char* uplo, int *n, RealScalar *pa, int *lda, int *info)) argument
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)) argument
44 if(UPLO(*uplo)==INVALID) *info = -1;
60 if(UPLO(*uplo)==UP)
H A Deigenvalues.cpp14 EIGEN_LAPACK_FUNC(syev,(char *jobz, char *uplo, int* n, Scalar* a, int *lda, Scalar* w, Scalar* /*work*/, int* lwork, int *info)) argument
21 else if(UPLO(*uplo)==INVALID) *info = -2;
59 if(UPLO(*uplo)==UP) mat = matrix(a,*n,*n,*lda).adjoint();
/external/eigen/Eigen/src/Core/products/
H A DTriangularSolverMatrix_MKL.h57 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
[all...]
H A DSelfadjointMatrixMatrix_MKL.h57 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
[all...]
H A DGeneralMatrixMatrixTriangular_MKL.h88 char uplo=(IsLower) ? 'L' : 'U', trans=(AStorageOrder==RowMajor) ? 'T':'N'; \
94 MKLFUNC(&uplo, &trans, &n, &k, &alpha_, lhs, &lda, &beta_, res, &ldc); \
113 char uplo=(IsLower) ? 'L' : 'U', trans=(AStorageOrder==RowMajor) ? 'C':'N'; \
130 MKLFUNC(&uplo, &trans, &n, &k, &alpha_, (MKLTYPE*)a_ptr, &lda, &beta_, (MKLTYPE*)res, &ldc); \
H A DTriangularMatrixMatrix_MKL.h133 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
[all...]
H A DTriangularMatrixVector_MKL.h107 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); \
H A DSelfadjointMatrixVector_MKL.h91 char uplo=(IsRowMajor) ? (IsLower ? 'U' : 'L') : (IsLower ? 'L' : 'U'); \
101 MKLFUNC(&uplo, &n, &alpha_, (const MKLTYPE*)lhs, &lda, (const MKLTYPE*)x_ptr, &incx, &beta_, (MKLTYPE*)res, &incy); \
/external/eigen/blas/
H A Dlevel2_real_impl.h13 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) argument
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) argument
77 if(UPLO(*uplo)==INVALID) info = 1;
92 // if(UPLO(*uplo)==LO) matrix(c,*n,*n,*ldc).selfadjointView<Lower>().rankUpdate(vector(x_cpy,*n), alpha);
93 // else if(UPLO(*uplo)==UP) matrix(c,*n,*n,*ldc).selfadjointView<Upper>().rankUpdate(vector(x_cpy,*n), alpha);
95 if(UPLO(*uplo)==LO)
108 int EIGEN_BLAS_FUNC(syr2)(char *uplo, in argument
[all...]
H A Dlevel2_cplx_impl.h19 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) argument
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)
106 // int EIGEN_BLAS_FUNC(hpr2)(char *uplo, int *n, RealScalar *palpha, RealScalar *x, int *incx, RealScalar *y, int *incy, RealScalar *ap)
118 int EIGEN_BLAS_FUNC(her)(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *pa, int *lda) argument
125 if(UPLO(*uplo)
162 her2(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *py, int *incy, RealScalar *pa, int *lda) argument
[all...]
H A Dlevel3_impl.h66 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) argument
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) argument
154 // std::cerr << "in trmm " << *side << " " << *uplo << " " << *opa << " " << *diag << " " << *m << " " << *n << " " << *lda << " " << *ldb << " " << *palpha << "\n";
204 else if(UPLO(*uplo)==INVALID) info = 2;
214 int code = OP(*opa) | (SIDE(*side) << 2) | (UPLO(*uplo) << 3) | (DIAG(*diag) << 4);
238 int EIGEN_BLAS_FUNC(symm)(char *side, char *uplo, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
240 // std::cerr << "in symm " << *side << " " << *uplo << " " << *
305 syrk(char *uplo, char *op, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
379 syr2k(char *uplo, char *op, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
444 hemm(char *side, char *uplo, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
499 herk(char *uplo, char *op, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
564 her2k(char *uplo, char *op, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, RealScalar *pbeta, RealScalar *pc, int *ldc) argument
[all...]
H A Dlevel2_impl.h73 int EIGEN_BLAS_FUNC(trsv)(char *uplo, char *opa, char *diag, int *n, RealScalar *pa, int *lda, RealScalar *pb, int *incb) argument
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) argument
162 if(UPLO(*uplo)==INVALID) info = 1;
178 int code = OP(*opa) | (UPLO(*uplo) << 2) | (DIAG(*diag) << 3);
267 int EIGEN_BLAS_FUNC(tbmv)(char *uplo, char *opa, char *diag, int *n, int *k, RealScalar *pa, int *lda, RealScalar *px, int *incx)
274 if(UPLO(*uplo)==INVALID) info = 1;
293 int ku = UPLO(*uplo)==UPPER ? *k : 0;
294 int kl = UPLO(*uplo)
329 tbsv(char *uplo, char *op, char *diag, int *n, int *k, RealScalar *pa, int *lda, RealScalar *px, int *incx) argument
[all...]
H A Dcommon.h66 inline bool check_uplo(const char* uplo) argument
68 return UPLO(*uplo)!=0xff;
/external/eigen/bench/btl/libs/BLAS/
H A Dblas_interface.hh30 // 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 );
H A Dblas_interface_impl.hh69 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/Eigenvalues/
H A DSelfAdjointEigenSolver_MKL.h69 char jobz, uplo='L'/*, range='A'*/; \
72 info = LAPACKE_##MKLNAME( matrix_order, jobz, uplo, n, (MKLTYPE*)m_eivec.data(), lda, (MKLRTYPE*)m_eivalues.data() ); \
/external/eigen/Eigen/src/Cholesky/
H A DLLT_MKL.h49 static inline typename MatrixType::Index potrf(MatrixType& m, char uplo) \
62 info = LAPACKE_##MKLPREFIX##potrf( matrix_order, uplo, size, (MKLTYPE*)a, lda ); \

Completed in 551 milliseconds