| /external/ComputeLibrary/src/core/NEON/kernels/arm_gemm/ | 
| D | quantize_wrapper.hpp | 80     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 requantize_bias(void *in_buffer, const To *B, const int ldb, const int B_multi_stride) overri…  in requantize_bias()
 187 …void pretranspose_B_array(void *buffer, const To *B, const int ldb, const int B_multi_stride) over…  in pretranspose_B_array()
 
 | 
| D | gemv_batched.hpp | 49                     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()
 
 | 
| D | gemm_hybrid_quantized_inline.hpp | 222 …void requantize_bias(void *in_buffer, const To *B, const int ldb, const int B_multi_stride) overri…  in requantize_bias()230 …void pretranspose_B_array(void *in_buffer, const To *B, const int ldb, const int B_multi_stride) o…  in pretranspose_B_array()
 
 | 
| D | gemv_pretransposed.hpp | 204 …void requantize_bias(void *in_buffer, const To *B, const int ldb, const int B_multi_stride) overri…  in requantize_bias()218 …void pretranspose_B_array(void *buffer, const To *B, const int ldb, const int B_multi_stride) over…  in pretranspose_B_array()
 
 | 
| /external/tensorflow/tensorflow/stream_executor/rocm/ | 
| D | rocm_blas.cc | 393                                   int lda, const DeviceMemoryBase &b, int ldb,  in DoBlasGemm()557     int lda, const DeviceMemory<Eigen::half> &b, int ldb, float beta,  in DoBlasGemmWithProfiling()
 568     const DeviceMemory<float> &b, int ldb, float beta, DeviceMemory<float> *c,  in DoBlasGemmWithProfiling()
 578     const DeviceMemory<double> &b, int ldb, double beta,  in DoBlasGemmWithProfiling()
 590     const DeviceMemory<std::complex<float>> &b, int ldb,  in DoBlasGemmWithProfiling()
 602     const DeviceMemory<std::complex<double>> &b, int ldb,  in DoBlasGemmWithProfiling()
 624     int lda, const DeviceMemory<T> &b, int ldb, const ParamType &beta,  in DoBlasGemmWithProfilingImpl()
 633     blas::DataType type_b, int ldb, const void *beta, DeviceMemoryBase *c,  in DoBlasGemmWithAlgorithm()
 644     blas::DataType type_b, int ldb, int64_t stride_b, const void *beta,  in DoBlasGemmStridedBatchedWithAlgorithm()
 769     const absl::Span<DeviceMemory<T> *const> &b_ptrs_to_wrappers, int ldb,  in DoBlasGemmBatchedInternal()
 [all …]
 
 | 
| /external/cblas/testing/ | 
| D | c_cblas3.c | 16      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()
 
 | 
| D | c_zblas3.c | 16      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()
 
 | 
| D | c_dblas3.c | 15               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()
 
 | 
| D | c_sblas3.c | 13               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/tensorflow/tensorflow/compiler/xla/stream_executor/cuda/ | 
| D | cuda_blas.cc | 612                                   int lda, const DeviceMemoryBase &b, int ldb,  in DoBlasInternalImpl()792     int lda, const DeviceMemory<Eigen::half> &b, int ldb, float beta,  in DoBlasInternalImpl()
 803     const DeviceMemory<float> &b, int ldb, float beta, DeviceMemory<float> *c,  in DoBlasInternalImpl()
 813     const DeviceMemory<double> &b, int ldb, double beta,  in DoBlasInternalImpl()
 825     const DeviceMemory<std::complex<float>> &b, int ldb,  in DoBlasInternalImpl()
 837     const DeviceMemory<std::complex<double>> &b, int ldb,  in DoBlasInternalImpl()
 881     int lda, const DeviceMemory<T> &b, int ldb, const ParamType &beta,  in DoBlasInternalImpl()
 1019     blas::DataType type_b, int ldb, const void *beta, DeviceMemoryBase *c,  in DoBlasInternalImpl()
 1048     blas::DataType type_b, int ldb, int64_t stride_b, const void *beta,  in DoBlasInternalImpl()
 1191     const DeviceMemorySlice<T> &b_ptrs_to_wrappers, int ldb, Scalar beta,  in DoBlasInternalImpl()
 [all …]
 
 | 
| /external/tensorflow/tensorflow/compiler/xla/stream_executor/ | 
| D | stream.h | 757                             const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemm()771                             const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemm()
 781                             const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemm()
 819                             const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemm()
 868       const DeviceMemory<InputType> &b, int ldb, DeviceMemory<OutputType> *c,  in ThenBlasGemmWithAlgorithm()
 883       const DeviceMemory<InputType> &b, int ldb, ConstantType beta,  in ThenBlasGemmWithAlgorithm()
 921       int64_t stride_a, const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemmStridedBatchedWithAlgorithm()
 1036       int64_t stride_a, const DeviceMemory<InputType> &b, int ldb,  in ThenBlasGemmStridedBatched()
 
 | 
| D | stream.cc | 1454     const DeviceMemory<Eigen::half> &b, int ldb, float beta,  in ThenBlasGemmWithProfiling()1474     const DeviceMemory<float> &b, int ldb, float beta, DeviceMemory<float> *c,  in ThenBlasGemmWithProfiling()
 1493     const DeviceMemory<double> &b, int ldb, double beta,  in ThenBlasGemmWithProfiling()
 1514     const DeviceMemory<std::complex<float>> &b, int ldb,  in ThenBlasGemmWithProfiling()
 1536     const DeviceMemory<std::complex<double>> &b, int ldb,  in ThenBlasGemmWithProfiling()
 1558                              DeviceMemory<float> *b, int ldb) {  in ThenBlasTrsm()
 1574                              DeviceMemory<double> *b, int ldb) {  in ThenBlasTrsm()
 1591                              int ldb) {  in ThenBlasTrsm()
 1609                              int ldb) {  in ThenBlasTrsm()
 1626                                     DeviceMemory<float *> *bs, int ldb,  in ThenBlasTrsmBatched()
 [all …]
 
 | 
| /external/eigen/bench/ | 
| D | bench_gemm.cpp | 90   int lda = a.outerStride(); int ldb = b.outerStride(); int ldc = c.rows();  in blas_gemm()  local102   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/ | 
| D | eight_bit_int_gemm.cc | 71                          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/ | 
| D | mingw-long-double.c | 10   long double ldb;  member
 | 
| /external/tensorflow/tensorflow/core/kernels/mkl/ | 
| D | mkl_matmul_op.cc | 148                    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/core/kernels/ | 
| D | quantized_matmul_op.cc | 40                       int offset_a, int offset_b, int lda, int ldb, int ldc) {  in GemmlowpMultiply()147     const size_t ldb = b.dim_size(1);  in Compute()  local
 
 | 
| D | conv_ops_using_gemm.cc | 247       const int ldb = filter_count;  in operator ()()  local260       const int ldb = filter_count;  in operator ()()  local
 414       const int ldb = filter_count;  in operator ()()  local
 
 | 
| /external/cblas/examples/ | 
| D | cblas_example2.c | 12    int rout=-1,info=0,m,n,k,lda,ldb,ldc;  in main()  local
 | 
| /external/tensorflow/tensorflow/compiler/xla/service/cpu/ | 
| D | runtime_matmul_mkl.cc | 43   int ldb = transpose_rhs ? n : k;  in MatMulF32()  local65   int ldb = transpose_rhs ? n : k;  in MatMulF64()  local
 
 | 
| /external/ComputeLibrary/src/cpu/kernels/assembly/ | 
| D | gemm_common.hpp | 182 …                        const To *B, const int ldb, /* batches share B */ const int B_multi_stride,  in set_arrays()203 …                      const void *B, const int ldb, /* batches share B */ const int B_multi_stride,  in set_arrays_generic()
 
 | 
| /external/tensorflow/tensorflow/core/kernels/rnn/ | 
| D | blas_gemm.cc | 42                                      const T* b, int ldb, float beta, T* c,  in operator ()()
 | 
| /external/cblas/src/ | 
| D | cblas_zsymm.c | 15                  const void  *B, const int ldb, const void *beta,  in cblas_zsymm()
 | 
| D | cblas_zsyr2k.c | 15                   const void  *B, const int ldb, const void *beta,  in cblas_zsyr2k()
 | 
| D | cblas_chemm.c | 15                  const void *B, const int ldb, const void *beta,  in cblas_chemm()
 |