HomeSort by relevance Sort by last modified time
    Searched refs:lda (Results 1 - 25 of 46) sorted by null

1 2

  /external/ceres-solver/internal/ceres/
blas.cc 41 int* lda,
63 int lda = k;
71 &lda,
lapack.cc 41 int* lda,
48 int* lda,
58 int* lda,
163 int lda = num_rows;
173 &lda,
  /external/eigen/bench/btl/libs/BLAS/
blas_interface.hh 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 );
34 void sgehrd_( const int *n, int *ilo, int *ihi, float *a, const int *lda, float *tau, float *work, int *lwork, int *info );
35 void dgehrd_( const int *n, int *ilo, int *ihi, double *a, const int *lda, double *tau, double *work, int *lwork, int *info );
38 // void dgetrf_( int *m, int *n, double *a, int *lda, int *ipiv, int *info );
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/
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))
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();
cholesky.cpp 14 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, int *ldb, int *info))
47 else if(*lda<std::max(1,*n)) *info = -5;
57 MatrixType A(a,*n,*n,*lda);
lu.cpp 14 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, RealScalar *pb, int *ldb, int *info))
52 else if(*lda<std::max(1,*n)) *info = -5;
62 MatrixType lu(a,*n,*n,*lda);
  /external/eigen/Eigen/src/Core/products/
TriangularSolverMatrix_MKL.h 56 MKL_INT m = size, n = otherSize, lda, ldb; \
70 /* Set a, lda */ \
78 lda = a_tmp.outerStride(); \
81 lda = triStride; \
85 MKLPREFIX##trsm(&side, &uplo, &transa, &diag, &m, &n, &alpha, (const MKLTYPE*)a, &lda, (MKLTYPE*)_other, &ldb); \
111 MKL_INT m = otherSize, n = size, lda, ldb; \
125 /* Set a, lda */ \
133 lda = a_tmp.outerStride(); \
136 lda = triStride; \
140 MKLPREFIX##trsm(&side, &uplo, &transa, &diag, &m, &n, &alpha, (const MKLTYPE*)a, &lda, (MKLTYPE*)_other, &ldb);
    [all...]
SelfadjointMatrixMatrix_MKL.h 58 MKL_INT m, n, lda, ldb, ldc; \
73 /* Set lda, ldb, ldc */ \
74 lda = (MKL_INT)lhsStride; \
89 MKLPREFIX##symm(&side, &uplo, &m, &n, &alpha_, (const MKLTYPE*)a, &lda, (const MKLTYPE*)b, &ldb, &beta_, (MKLTYPE*)res, &ldc); \
109 MKL_INT m, n, lda, ldb, ldc; \
125 /* Set 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, &beta_, (MKLTYPE*)res, &ldc); \
185 MKL_INT m, n, lda, ldb, ldc;
    [all...]
GeneralMatrixMatrix_MKL.h 67 MKL_INT m, n, k, lda, ldb, ldc; \
86 /* Set 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, &ldb, &beta_, (MKLTYPE*)res, &ldc); \
GeneralMatrixMatrixTriangular_MKL.h 87 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); \
TriangularMatrixVector_MKL.h 108 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_, (MKLTYPE*)y, &incy); \
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_, (MKLTYPE*)y, &incy);
    [all...]
  /external/eigen/Eigen/src/QR/
HouseholderQR_MKL.h 53 lapack_int lda = mat.outerStride(); \
55 LAPACKE_##MKLPREFIX##geqrf( matrix_order, m, n, (MKLTYPE*)mat.data(), lda, (MKLTYPE*)hCoeffs.data()); \
  /external/eigen/Eigen/src/LU/
PartialPivLU_MKL.h 53 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/SparseLU/
SparseLU_gemm_kernel.h 21 * - lda and ldc must be multiples of the respective packet size
26 void sparselu_gemm(Index m, Index n, Index d, const Scalar* A, Index lda, const Scalar* B, Index ldb, Scalar* C, Index ldc)
44 eigen_internal_assert(((lda%PacketSize)==0) && ((ldc%PacketSize)==0) && (i0==internal::first_aligned(C,m)));
53 c += B[k+j*ldb] * A[i+k*lda];
86 const Scalar* A0 = A+ib+(k+0)*lda;
87 const Scalar* A1 = A+ib+(k+1)*lda;
88 const Scalar* A2 = A+ib+(k+2)*lda;
89 const Scalar* A3 = A+ib+(k+3)*lda;
185 const Scalar* A0 = A+ib+(k+0)*lda;
186 const Scalar* A1 = A+ib+(k+1)*lda;
    [all...]
SparseLU_kernel_bmod.h 24 * \param lda Leading dimension in the supernode
34 static EIGEN_DONT_INLINE void run(const int segsize, BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda,
40 EIGEN_DONT_INLINE void LU_kernel_bmod<SegSizeAtCompileTime>::run(const int segsize, BlockScalarVector& dense, ScalarVector& tempv, ScalarVector& lusup, Index& luptr, const Index lda,
57 luptr += lda * no_zeros + no_zeros;
59 Map<Matrix<Scalar,SegSizeAtCompileTime,SegSizeAtCompileTime>, 0, OuterStride<> > A( &(lusup.data()[luptr]), segsize, segsize, OuterStride<>(lda) );
68 Map<Matrix<Scalar,Dynamic,SegSizeAtCompileTime>, 0, OuterStride<> > B( &(lusup.data()[luptr]), nrow, segsize, OuterStride<>(lda) );
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;
SparseLU_panel_bmod.h 136 Index lda = glu.xlusup(fsupc+1) - glu.xlusup(fsupc); local
138 luptr += lda * no_zeros + no_zeros;
139 Map<Matrix<Scalar,Dynamic,Dynamic>, 0, OuterStride<> > A(glu.lusup.data()+luptr, u_rows, u_rows, OuterStride<>(lda) );
144 Map<Matrix<Scalar,Dynamic,Dynamic>, 0, OuterStride<> > B(glu.lusup.data()+luptr, nrow, u_rows, OuterStride<>(lda) );
204 Index lda = glu.xlusup(fsupc+1)-glu.xlusup(fsupc);// nsupr local
209 if(segsize==1) LU_kernel_bmod<1>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
210 else if(segsize==2) LU_kernel_bmod<2>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
211 else if(segsize==3) LU_kernel_bmod<3>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
212 else LU_kernel_bmod<Dynamic>::run(segsize, dense_col, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
SparseLU_pivotL.h 67 Index lda = glu.xlusup(fsupc+1) - glu.xlusup(fsupc); // leading dimension local
120 itemp = pivptr + icol * lda;
121 std::swap(lu_sup_ptr[itemp], lu_sup_ptr[nsupc + icol * lda]);
SparseLU_column_bmod.h 98 Index lda = glu.xlusup(fst_col+1) - glu.xlusup(fst_col); local
105 LU_kernel_bmod<1>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
107 LU_kernel_bmod<Dynamic>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zeros);
164 Index lda = glu.xlusup(jcol+1) - glu.xlusup(jcol); local
165 Map<Matrix<Scalar,Dynamic,Dynamic>, 0, OuterStride<> > A( &(glu.lusup.data()[luptr]), nsupc, nsupc, OuterStride<>(lda) );
169 new (&A) Map<Matrix<Scalar,Dynamic,Dynamic>, 0, OuterStride<> > ( &(glu.lusup.data()[luptr+nsupc]), nrow, nsupc, OuterStride<>(lda) );
  /external/eigen/blas/
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)
46 else if(*lda<std::max(1,*n)) info = 5;
70 func[code](*n, a, *lda, actual_x, 1, actual_y, alpha);
86 // int EIGEN_BLAS_FUNC(hbmv)(char *uplo, int *n, int *k, RealScalar *alpha, RealScalar *a, int *lda,
217 int EIGEN_BLAS_FUNC(her)(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *pa, int *lda)
242 else if(*lda<std::max(1,*n)) info = 7;
255 func[code](*n, a, *lda, x_cpy, x_cpy, alpha);
257 matrix(a,*n,*n,*lda).diagonal().imag().setZero();
271 int EIGEN_BLAS_FUNC(her2)(char *uplo, int *n, RealScalar *palpha, RealScalar *px, int *incx, RealScalar *py, int *incy, RealScalar *pa, int *lda)
298 else if(*lda<std::max(1,*n)) info = 9
    [all...]
level3_impl.h 12 int EIGEN_BLAS_FUNC(gemm)(char *opa, char *opb, int *m, int *n, int *k, RealScalar *palpha, RealScalar *pa, int *lda, RealScalar *pb, int *ldb, RealScalar *pbeta, RealScalar *pc, int *ldc)
14 // std::cerr << "in gemm " << *opa << " " << *opb << " " << *m << " " << *n << " " << *k << " " << *lda << " " << *ldb << " " << *ldc << " " << *palpha << " " << *pbeta << "\n";
47 else if(*lda<std::max(1,(OP(*opa)==NOTR)?*m:*k)) info = 8;
62 func[code](*m, *n, *k, a, *lda, b, *ldb, c, *ldc, alpha, blocking, 0);
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";
125 else if(*lda<std::max(1,(SIDE(*side)==LEFT)?*m:*n)) info = 9;
135 func[code](*m, *n, a, *lda, b, *ldb, blocking);
140 func[code](*n, *m, a, *lda, b, *ldb, blocking);
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
    [all...]
  /external/eigen/Eigen/src/Cholesky/
LLT_MKL.h 52 lapack_int size, lda, info, StorageOrder; \
60 lda = m.outerStride(); \
62 info = LAPACKE_##MKLPREFIX##potrf( matrix_order, uplo, size, (MKLTYPE*)a, lda ); \
  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver_MKL.h 52 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_eivalues.data() ); \
ComplexSchur_MKL.h 65 lapack_int lda = matrix.outerStride(); \
75 info = LAPACKE_##MKLPREFIX##gees( matrix_order, jobvs, sort, select, n, (MKLTYPE*)m_matT.data(), lda, &sdim, (MKLTYPE*)w.data(), (MKLTYPE*)m_matU.data(), ldvs ); \
RealSchur_MKL.h 54 lapack_int lda = matrix.outerStride(); \
64 info = LAPACKE_##MKLPREFIX##gees( matrix_order, jobvs, sort, select, n, (MKLTYPE*)m_matT.data(), lda, &sdim, (MKLTYPE*)wr.data(), (MKLTYPE*)wi.data(), (MKLTYPE*)m_matU.data(), ldvs ); \
  /external/openssl/crypto/bn/asm/
alpha-mont.pl 60 lda sp,-48(sp)
83 lda AT,-4096(zero) # mov -4096,AT
116 lda $tp,8($tp)
208 lda $tp,8($tp)
275 lda $tp,8($tp)
276 lda $np,8($np)
284 lda $rp,8($rp)
297 lda $tp,8($tp)
298 lda $rp,8($rp)
299 lda $ap,8($ap
    [all...]

Completed in 264 milliseconds

1 2