Home
last modified time | relevance | path

Searched refs:lda (Results 1 – 25 of 59) sorted by relevance

123

/external/eigen/blas/
Dlevel3_impl.h12 …har *opb, int *m, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, in… in EIGEN_BLAS_FUNC()
47 else if(*lda<std::max(1,(OP(*opa)==NOTR)?*m:*k)) info = 8; in EIGEN_BLAS_FUNC()
62 func[code](*m, *n, *k, a, *lda, b, *ldb, c, *ldc, alpha, blocking, 0); in EIGEN_BLAS_FUNC()
66 …opa, char *diag, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, in… in EIGEN_BLAS_FUNC()
125 else if(*lda<std::max(1,(SIDE(*side)==LEFT)?*m:*n)) info = 9; in EIGEN_BLAS_FUNC()
135 func[code](*m, *n, a, *lda, b, *ldb, blocking); in EIGEN_BLAS_FUNC()
140 func[code](*n, *m, a, *lda, b, *ldb, blocking); in EIGEN_BLAS_FUNC()
152 …opa, char *diag, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, in… in EIGEN_BLAS_FUNC()
209 else if(*lda<std::max(1,(SIDE(*side)==LEFT)?*m:*n)) info = 9; in EIGEN_BLAS_FUNC()
226 func[code](*m, *n, *m, a, *lda, tmp.data(), tmp.outerStride(), b, *ldb, alpha, blocking); in EIGEN_BLAS_FUNC()
[all …]
Dlevel2_cplx_impl.h19 int EIGEN_BLAS_FUNC(hemv)(char *uplo, int *n, RealScalar *palpha, RealScalar *pa, int *lda, RealSca… in EIGEN_BLAS_FUNC()
46 else if(*lda<std::max(1,*n)) info = 5; in EIGEN_BLAS_FUNC()
70 func[code](*n, a, *lda, actual_x, 1, actual_y, alpha); in EIGEN_BLAS_FUNC()
217 …C(her)(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *pa, int *lda) in EIGEN_BLAS_FUNC()
242 else if(*lda<std::max(1,*n)) info = 7; in EIGEN_BLAS_FUNC()
255 func[code](*n, a, *lda, x_cpy, x_cpy, alpha); in EIGEN_BLAS_FUNC()
257 matrix(a,*n,*n,*lda).diagonal().imag().setZero(); in EIGEN_BLAS_FUNC()
271 …RealScalar *palpha, RealScalar *px, int *incx, RealScalar *py, int *incy, RealScalar *pa, int *lda) in EIGEN_BLAS_FUNC()
298 else if(*lda<std::max(1,*n)) info = 9; in EIGEN_BLAS_FUNC()
312 func[code](*n, a, *lda, x_cpy, y_cpy, alpha); in EIGEN_BLAS_FUNC()
[all …]
Dlevel2_impl.h12 int EIGEN_BLAS_FUNC(gemv)(char *opa, int *m, int *n, RealScalar *palpha, RealScalar *pa, int *lda, … in EIGEN_BLAS_FUNC()
41 else if(*lda<std::max(1,*m)) info = 6; in EIGEN_BLAS_FUNC()
68 func[code](actual_m, actual_n, a, *lda, actual_b, 1, actual_c, 1, alpha); in EIGEN_BLAS_FUNC()
76 int EIGEN_BLAS_FUNC(trsv)(char *uplo, char *opa, char *diag, int *n, RealScalar *pa, int *lda, Real… in EIGEN_BLAS_FUNC()
114 else if(*lda<std::max(1,*n)) info = 6; in EIGEN_BLAS_FUNC()
122 func[code](*n, a, *lda, actual_b); in EIGEN_BLAS_FUNC()
131 int EIGEN_BLAS_FUNC(trmv)(char *uplo, char *opa, char *diag, int *n, RealScalar *pa, int *lda, Real… in EIGEN_BLAS_FUNC()
169 else if(*lda<std::max(1,*n)) info = 6; in EIGEN_BLAS_FUNC()
185 func[code](*n, *n, a, *lda, actual_b, 1, res.data(), 1, Scalar(1)); in EIGEN_BLAS_FUNC()
200 …(gbmv)(char *trans, int *m, int *n, int *kl, int *ku, RealScalar *palpha, RealScalar *pa, int *lda, in EIGEN_BLAS_FUNC()
[all …]
/external/eigen/bench/btl/libs/BLAS/
Dblas_interface.hh32 …void ssytrd_(char *uplo, const int *n, float *a, const int *lda, float *d, float *e, float *tau, f…
33 …void dsytrd_(char *uplo, const int *n, double *a, const int *lda, double *d, double *e, double *ta…
34 …void sgehrd_( const int *n, int *ilo, int *ihi, float *a, const int *lda, float *tau, float *work,…
35 …void dgehrd_( const int *n, int *ilo, int *ihi, double *a, const int *lda, double *tau, double *wo…
41 void sgetc2_(const int* n, float *a, const int *lda, int *ipiv, int *jpiv, int*info );
42 void dgetc2_(const int* n, double *a, const int *lda, int *ipiv, int *jpiv, int*info );
/external/eigen/lapack/
Deigenvalues.cpp14 EIGEN_LAPACK_FUNC(syev,(char *jobz, char *uplo, int* n, Scalar* a, int *lda, Scalar* w, Scalar* /*w…
23 else if(*lda<std::max(1,*n)) *info = -5;
59 if(UPLO(*uplo)==UP) mat = matrix(a,*n,*n,*lda).adjoint();
60 else mat = matrix(a,*n,*n,*lda);
69 matrix(a,*n,*n,*lda).setIdentity();
76 matrix(a,*n,*n,*lda) = eig.eigenvectors();
Dcholesky.cpp14 EIGEN_LAPACK_FUNC(potrf,(char* uplo, int *n, RealScalar *pa, int *lda, int *info))
19 else if(*lda<std::max(1,*n)) *info = -4;
27 MatrixType A(a,*n,*n,*lda);
41 EIGEN_LAPACK_FUNC(potrs,(char* uplo, int *n, int *nrhs, RealScalar *pa, int *lda, RealScalar *pb, i…
47 else if(*lda<std::max(1,*n)) *info = -5;
57 MatrixType A(a,*n,*n,*lda);
Dlu.cpp14 EIGEN_LAPACK_FUNC(getrf,(int *m, int *n, RealScalar *pa, int *lda, int *ipiv, int *info))
19 else if(*lda<std::max(1,*m)) *info = -4;
32 ::blocked_lu(*m, *n, a, *lda, ipiv, nb_transpositions));
46 EIGEN_LAPACK_FUNC(getrs,(char *trans, int *n, int *nrhs, RealScalar *pa, int *lda, int *ipiv, RealS…
52 else if(*lda<std::max(1,*n)) *info = -5;
62 MatrixType lu(a,*n,*n,*lda);
/external/eigen/Eigen/src/SparseLU/
DSparseLU_gemm_kernel.h26 void sparselu_gemm(Index m, Index n, Index d, const Scalar* A, Index lda, const Scalar* B, Index ld… in sparselu_gemm() argument
44 …eigen_internal_assert(((lda%PacketSize)==0) && ((ldc%PacketSize)==0) && (i0==internal::first_align… in sparselu_gemm()
53 c += B[k+j*ldb] * A[i+k*lda]; in sparselu_gemm()
86 const Scalar* A0 = A+ib+(k+0)*lda; in sparselu_gemm()
87 const Scalar* A1 = A+ib+(k+1)*lda; in sparselu_gemm()
88 const Scalar* A2 = A+ib+(k+2)*lda; in sparselu_gemm()
89 const Scalar* A3 = A+ib+(k+3)*lda; in sparselu_gemm()
185 const Scalar* A0 = A+ib+(k+0)*lda; in sparselu_gemm()
186 const Scalar* A1 = A+ib+(k+1)*lda; in sparselu_gemm()
187 const Scalar* A2 = A+ib+(k+2)*lda; in sparselu_gemm()
[all …]
DSparseLU_kernel_bmod.h34 … BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda,
40 … BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda, in run() argument
57 luptr += lda * no_zeros + no_zeros; in run()
59 …CompileTime>, 0, OuterStride<> > A( &(lusup.data()[luptr]), segsize, segsize, OuterStride<>(lda) ); in run()
68 …eAtCompileTime>, 0, OuterStride<> > B( &(lusup.data()[luptr]), nrow, segsize, OuterStride<>(lda) ); in run()
96 … const Index lda, const Index nrow, IndexVector& lsub, const Index lptr, const Index no_zeros);
102 … const Index lda, const Index nrow, IndexVector& lsub, const Index lptr, const Index no_zeros)
106 luptr += lda * no_zeros + no_zeros + 1;
DSparseLU_panel_bmod.h136 Index lda = glu.xlusup(fsupc+1) - glu.xlusup(fsupc); in panel_bmod() local
138 luptr += lda * no_zeros + no_zeros; in panel_bmod()
139 …ynamic,Dynamic>, 0, OuterStride<> > A(glu.lusup.data()+luptr, u_rows, u_rows, OuterStride<>(lda) ); in panel_bmod()
144 …,Dynamic,Dynamic>, 0, OuterStride<> > B(glu.lusup.data()+luptr, nrow, u_rows, OuterStride<>(lda) ); in panel_bmod()
204 Index lda = glu.xlusup(fsupc+1)-glu.xlusup(fsupc);// nsupr in panel_bmod() local
209 …e==1) LU_kernel_bmod<1>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lp… in panel_bmod()
210 …e==2) LU_kernel_bmod<2>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lp… in panel_bmod()
211 …e==3) LU_kernel_bmod<3>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lp… in panel_bmod()
212 … LU_kernel_bmod<Dynamic>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lp… in panel_bmod()
DSparseLU_column_bmod.h98 Index lda = glu.xlusup(fst_col+1) - glu.xlusup(fst_col); in column_bmod() local
105 …LU_kernel_bmod<1>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zero… in column_bmod()
107 …LU_kernel_bmod<Dynamic>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, n… in column_bmod()
164 Index lda = glu.xlusup(jcol+1) - glu.xlusup(jcol); in column_bmod() local
165 …c,Dynamic>, 0, OuterStride<> > A( &(glu.lusup.data()[luptr]), nsupc, nsupc, OuterStride<>(lda) ); in column_bmod()
169 …ynamic>, 0, OuterStride<> > ( &(glu.lusup.data()[luptr+nsupc]), nrow, nsupc, OuterStride<>(lda) ); in column_bmod()
DSparseLU_pivotL.h67 Index lda = glu.xlusup(fsupc+1) - glu.xlusup(fsupc); // leading dimension in pivotL() local
120 itemp = pivptr + icol * lda; in pivotL()
121 std::swap(lu_sup_ptr[itemp], lu_sup_ptr[nsupc + icol * lda]); in pivotL()
/external/eigen/Eigen/src/Core/products/
DTriangularSolverMatrix_MKL.h56 MKL_INT m = size, n = otherSize, lda, ldb; \
78 lda = a_tmp.outerStride(); \
81 lda = triStride; \
85 …MKLPREFIX##trsm(&side, &uplo, &transa, &diag, &m, &n, &alpha, (const MKLTYPE*)a, &lda, (MKLTYPE*)_…
111 MKL_INT m = otherSize, n = size, lda, ldb; \
133 lda = a_tmp.outerStride(); \
136 lda = triStride; \
140 …MKLPREFIX##trsm(&side, &uplo, &transa, &diag, &m, &n, &alpha, (const MKLTYPE*)a, &lda, (MKLTYPE*)_…
DSelfadjointMatrixMatrix_MKL.h58 MKL_INT m, n, lda, ldb, ldc; \
74 lda = (MKL_INT)lhsStride; \
89 …MKLPREFIX##symm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &…
109 MKL_INT m, n, lda, ldb, ldc; \
126 lda = (MKL_INT)lhsStride; \
135 lda = a_tmp.outerStride(); \
157 …MKLPREFIX##hemm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &…
185 MKL_INT m, n, lda, ldb, ldc; \
200 lda = (MKL_INT)rhsStride; \
215 …MKLPREFIX##symm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &…
[all …]
DTriangularMatrixVector_MKL.h108 MKL_INT m, n, lda, incx, incy; \
116 lda = lhsStride; \
126 MKLPREFIX##trmv(&uplo, &trans, &diag, &n, (const MKLTYPE*)_lhs, &lda, (MKLTYPE*)x, &incx); \
144 a = _lhs + size*lda; \
148 …MKLPREFIX##gemv(&trans, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)x, &incx, &beta_…
193 MKL_INT m, n, lda, incx, incy; \
201 lda = lhsStride; \
211 MKLPREFIX##trmv(&uplo, &trans, &diag, &n, (const MKLTYPE*)_lhs, &lda, (MKLTYPE*)x, &incx); \
222 a = _lhs + size*lda; \
233 …MKLPREFIX##gemv(&trans, &n, &m, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)x, &incx, &beta_…
DGeneralMatrixMatrix_MKL.h67 MKL_INT m, n, k, lda, ldb, ldc; \
87 lda = (MKL_INT)lhsStride; \
96 lda = a_tmp.outerStride(); \
106 …MKLPREFIX##gemm(&transa, &transb, &m, &n, &k, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b,…
DGeneralMatrixMatrixTriangular_MKL.h87 MKL_INT lda=lhsStride, ldc=resStride, n=size, k=depth; \
94 MKLFUNC(&uplo, &trans, &n, &k, &alpha_, lhs, &lda, &beta_, res, &ldc); \
112 MKL_INT lda=lhsStride, ldc=resStride, n=size, k=depth; \
127 lda = a.outerStride(); \
130 MKLFUNC(&uplo, &trans, &n, &k, &alpha_, (MKLTYPE*)a_ptr, &lda, &beta_, (MKLTYPE*)res, &ldc); \
DTriangularMatrixMatrix_MKL.h136 MKL_INT m, n, lda, ldb; \
171 lda = a_tmp.outerStride(); \
174 lda = lhsStride; \
178 …MKLPREFIX##trmm(&side, &uplo, &transa, &diag, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (MKLTYPE*)…
250 MKL_INT m, n, lda, ldb; \
285 lda = a_tmp.outerStride(); \
288 lda = rhsStride; \
292 …MKLPREFIX##trmm(&side, &uplo, &transa, &diag, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (MKLTYPE*)…
/external/ceres-solver/internal/ceres/
Dlapack.cc41 int* lda,
48 int* lda,
58 int* lda,
163 int lda = num_rows; in SolveInPlaceUsingQR()
173 &lda, in SolveInPlaceUsingQR()
Dblas.cc41 int* lda,
63 int lda = k; in SymmetricRankKUpdate()
71 &lda, in SymmetricRankKUpdate()
/external/eigen/Eigen/src/LU/
DPartialPivLU_MKL.h53 lapack_int m, n, lda, *ipiv, info; \
57 lda = luStride; \
64 info = LAPACKE_##MKLPREFIX##getrf( matrix_order, m, n, (MKLTYPE*)a, lda, ipiv ); \
/external/eigen/Eigen/src/Eigenvalues/
DSelfAdjointEigenSolver_MKL.h52 lapack_int n = matrix.cols(), lda, matrix_order, info; \
67 lda = matrix.outerStride(); \
72 …info = LAPACKE_##MKLNAME( matrix_order, jobz, uplo, n, (MKLTYPE*)m_eivec.data(), lda, (MKLRTYPE*)m…
/external/eigen/Eigen/src/Cholesky/
DLLT_MKL.h52 lapack_int size, lda, info, StorageOrder; \
60 lda = m.outerStride(); \
62 info = LAPACKE_##MKLPREFIX##potrf( matrix_order, uplo, size, (MKLTYPE*)a, lda ); \
/external/srec/config/en.us/
Dconfig.mk12 models/generic11.lda \
15 models/generic8.lda \
/external/eigen/bench/
Dbench_gemm.cpp48 int lda = a.rows(); int ldb = b.rows(); int ldc = c.rows(); in blas_gemm() local
51 const_cast<float*>(a.data()),&lda, in blas_gemm()
59 int lda = a.rows(); int ldb = b.rows(); int ldc = c.rows(); in blas_gemm() local
62 const_cast<double*>(a.data()),&lda, in blas_gemm()
70 int lda = a.rows(); int ldb = b.rows(); int ldc = c.rows(); in blas_gemm() local
73 const_cast<float*>((const float*)a.data()),&lda, in blas_gemm()
81 int lda = a.rows(); int ldb = b.rows(); int ldc = c.rows(); in blas_gemm() local
84 const_cast<double*>((const double*)a.data()),&lda, in blas_gemm()

123