Home
last modified time | relevance | path

Searched defs:ldb (Results 1 – 25 of 69) sorted by relevance

123

/external/cblas/testing/
Dc_cblas3.c16 CBLAS_TEST_COMPLEX *b, int *ldb, CBLAS_TEST_COMPLEX *beta, in F77_cgemm()
92 CBLAS_TEST_COMPLEX *b, int *ldb, CBLAS_TEST_COMPLEX *beta, in F77_chemm()
156 CBLAS_TEST_COMPLEX *b, int *ldb, CBLAS_TEST_COMPLEX *beta, in F77_csymm()
322 CBLAS_TEST_COMPLEX *b, int *ldb, float *beta, in F77_cher2k()
386 CBLAS_TEST_COMPLEX *b, int *ldb, CBLAS_TEST_COMPLEX *beta, in F77_csyr2k()
450 int *lda, CBLAS_TEST_COMPLEX *b, int *ldb) { in F77_ctrmm()
509 int *lda, CBLAS_TEST_COMPLEX *b, int *ldb) { in F77_ctrsm()
Dc_zblas3.c16 CBLAS_TEST_ZOMPLEX *b, int *ldb, CBLAS_TEST_ZOMPLEX *beta, in F77_zgemm()
92 CBLAS_TEST_ZOMPLEX *b, int *ldb, CBLAS_TEST_ZOMPLEX *beta, in F77_zhemm()
156 CBLAS_TEST_ZOMPLEX *b, int *ldb, CBLAS_TEST_ZOMPLEX *beta, in F77_zsymm()
322 CBLAS_TEST_ZOMPLEX *b, int *ldb, double *beta, in F77_zher2k()
386 CBLAS_TEST_ZOMPLEX *b, int *ldb, CBLAS_TEST_ZOMPLEX *beta, in F77_zsyr2k()
450 int *lda, CBLAS_TEST_ZOMPLEX *b, int *ldb) { in F77_ztrmm()
509 int *lda, CBLAS_TEST_ZOMPLEX *b, int *ldb) { in F77_ztrsm()
Dc_dblas3.c15 int *k, double *alpha, double *a, int *lda, double *b, int *ldb, in F77_dgemm()
77 double *alpha, double *a, int *lda, double *b, int *ldb, in F77_dsymm()
179 double *alpha, double *a, int *lda, double *b, int *ldb, in F77_dsyr2k()
235 int *ldb) { in F77_dtrmm()
286 int *ldb) { in F77_dtrsm()
Dc_sblas3.c13 int *k, float *alpha, float *a, int *lda, float *b, int *ldb, in F77_sgemm()
74 float *alpha, float *a, int *lda, float *b, int *ldb, in F77_ssymm()
176 float *alpha, float *a, int *lda, float *b, int *ldb, in F77_ssyr2k()
232 int *ldb) { in F77_strmm()
283 int *ldb) { in F77_strsm()
/external/ComputeLibrary/src/core/NEON/kernels/arm_gemm/
Dquantize_wrapper.hpp80 void col_sums_pretransposed(const To *B, const int ldb, const int B_multi_stride) { in col_sums_pretransposed()
122 const To *B, const int ldb, const int B_multi_stride, in set_arrays()
182 …void pretranspose_B_array(void *buffer, const To *B, const int ldb, const int B_multi_stride) over… in pretranspose_B_array()
Dgemv_batched.hpp49 const To *B, const int ldb, const int B_multi_stride, in set_arrays()
91 …void pretranspose_B_array(void *buffer, const To *B, const int ldb, const int B_multi_stride) over… in pretranspose_B_array()
/external/eigen/bench/
Dbench_gemm.cpp90 int lda = a.outerStride(); int ldb = b.outerStride(); int ldc = c.rows(); in blas_gemm() local
102 int lda = a.outerStride(); int ldb = b.outerStride(); int ldc = c.rows(); in blas_gemm() local
114 int lda = a.outerStride(); int ldb = b.outerStride(); int ldc = c.rows(); in blas_gemm() local
126 int lda = a.outerStride(); int ldb = b.outerStride(); int ldc = c.rows(); in blas_gemm() local
/external/gemmlowp/eight_bit_int_gemm/
Deight_bit_int_gemm.cc71 const std::uint8_t* b, std::int32_t b_offset, int ldb, in EightBitIntGemmImpl()
111 std::int32_t b_offset, int ldb, std::int32_t* c, in EightBitIntGemmInt32Impl()
218 int m, int n, int k, int lda, int ldb, int ldc, in CanHandleMetaFastpath()
304 std::int32_t b_offset, int ldb, std::uint8_t* c, in EightBitIntGemm()
342 std::int32_t ldb, float* c, float c_offset, in EightBitIntGemm()
/external/clang/test/CodeGen/
Dmingw-long-double.c10 long double ldb; member
/external/tensorflow/tensorflow/core/kernels/
Dquantized_matmul_op.cc37 int offset_a, int offset_b, int lda, int ldb, int ldc) { in GemmlowpMultiply()
132 const size_t ldb = b.dim_size(1); in Compute() local
Dconv_ops_using_gemm.cc247 const int ldb = filter_count; in operator ()() local
260 const int ldb = filter_count; in operator ()() local
414 const int ldb = filter_count; in operator ()() local
/external/tensorflow/tensorflow/core/kernels/mkl/
Dmkl_matmul_op.cc148 const float* b, const int ldb, float* c, const int ldc) { in MklBlasGemm()
181 const bfloat16* b, const int ldb, bfloat16* c, in MklBlasGemm()
/external/tensorflow/tensorflow/stream_executor/rocm/
Drocm_blas.cc1352 int lda, const DeviceMemoryBase &b, int ldb, in DoBlasGemm()
1516 int lda, const DeviceMemory<Eigen::half> &b, int ldb, float beta, in DoBlasGemmWithProfiling()
1527 const DeviceMemory<float> &b, int ldb, float beta, DeviceMemory<float> *c, in DoBlasGemmWithProfiling()
1537 const DeviceMemory<double> &b, int ldb, double beta, in DoBlasGemmWithProfiling()
1549 const DeviceMemory<std::complex<float>> &b, int ldb, in DoBlasGemmWithProfiling()
1561 const DeviceMemory<std::complex<double>> &b, int ldb, in DoBlasGemmWithProfiling()
1583 int lda, const DeviceMemory<T> &b, int ldb, const ParamType &beta, in DoBlasGemmWithProfilingImpl()
1592 blas::DataType type_b, int ldb, const void *beta, DeviceMemoryBase *c, in DoBlasGemmWithAlgorithm()
1603 blas::DataType type_b, int ldb, int64 stride_b, const void *beta, in DoBlasGemmStridedBatchedWithAlgorithm()
1728 const port::ArraySlice<DeviceMemory<T> *> &b_ptrs_to_wrappers, int ldb, in DoBlasGemmBatchedInternal()
[all …]
/external/cblas/examples/
Dcblas_example2.c12 int rout=-1,info=0,m,n,k,lda,ldb,ldc; in main() local
/external/tensorflow/tensorflow/compiler/xla/service/cpu/
Druntime_matmul_mkl.cc47 int ldb = transpose_rhs ? n : k; in MatMulF32() local
69 int ldb = transpose_rhs ? n : k; in MatMulF64() local
/external/tensorflow/tensorflow/stream_executor/
Dstream.h1334 const DeviceMemory<InputType> &b, int ldb, in ThenBlasGemm()
1346 const DeviceMemory<InputType> &b, int ldb, in ThenBlasGemm()
1427 const DeviceMemory<InputType> &b, int ldb, DeviceMemory<OutputType> *c, in ThenBlasGemmWithAlgorithm()
1442 const DeviceMemory<InputType> &b, int ldb, ConstantType beta, in ThenBlasGemmWithAlgorithm()
1480 int64_t stride_a, const DeviceMemory<InputType> &b, int ldb, in ThenBlasGemmStridedBatchedWithAlgorithm()
1593 int64_t stride_a, const DeviceMemory<InputType> &b, int ldb, in ThenBlasGemmStridedBatched()
/external/ComputeLibrary/src/core/NEON/kernels/assembly/
Dgemm_common.hpp175 … const To *B, const int ldb, /* batches share B */ const int B_multi_stride, in set_arrays()
196 … const void *B, const int ldb, /* batches share B */ const int B_multi_stride, in set_arrays_generic()
/external/tensorflow/tensorflow/stream_executor/cuda/
Dcuda_blas.cc1747 int lda, const DeviceMemoryBase &b, int ldb, in DoBlasInternalImpl()
1924 int lda, const DeviceMemory<Eigen::half> &b, int ldb, float beta, in DoBlasInternalImpl()
1935 const DeviceMemory<float> &b, int ldb, float beta, DeviceMemory<float> *c, in DoBlasInternalImpl()
1945 const DeviceMemory<double> &b, int ldb, double beta, in DoBlasInternalImpl()
1957 const DeviceMemory<std::complex<float>> &b, int ldb, in DoBlasInternalImpl()
1969 const DeviceMemory<std::complex<double>> &b, int ldb, in DoBlasInternalImpl()
2013 int lda, const DeviceMemory<T> &b, int ldb, const ParamType &beta, in DoBlasInternalImpl()
2151 blas::DataType type_b, int ldb, const void *beta, DeviceMemoryBase *c, in DoBlasInternalImpl()
2180 blas::DataType type_b, int ldb, int64_t stride_b, const void *beta, in DoBlasInternalImpl()
2312 const port::ArraySlice<DeviceMemory<T> *> &b_ptrs_to_wrappers, int ldb, in DoBlasInternalImpl()
[all …]
/external/tensorflow/tensorflow/core/kernels/rnn/
Dblas_gemm.cc42 const T* b, int ldb, float beta, T* c, in operator ()()
/external/cblas/src/
Dcblas_ssymm.c15 const float *B, const int ldb, const float beta, in cblas_ssymm()
Dcblas_zsyr2k.c15 const void *B, const int ldb, const void *beta, in cblas_zsyr2k()
Dcblas_csyr2k.c15 const void *B, const int ldb, const void *beta, in cblas_csyr2k()
Dcblas_ssyr2k.c15 const float *B, const int ldb, const float beta, in cblas_ssyr2k()
Dcblas_dsymm.c15 const double *B, const int ldb, const double beta, in cblas_dsymm()
/external/tensorflow/tensorflow/compiler/xla/service/gpu/
Dtriangular_solve_thunk.cc82 const int ldb = m_; in ExecuteOnStream() local

123