Home
last modified time | relevance | path

Searched refs:A_rows (Results 1 – 25 of 39) sorted by relevance

12

/dports/www/firefox/firefox-99.0/third_party/intgemm/test/
H A Dadd127_test.cc70 int A_rows = 1; in TestPrepareBias() local
71 AlignedVector<int8_t> A_prep2(A_rows*rows); in TestPrepareBias()
90 AlignedVector<float> A(A_rows * width); in TestMultiplyBiasNew()
111 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in TestMultiplyBiasNew()
114 AlignedVector<float> test_C(A_rows * B_cols); in TestMultiplyBiasNew()
125 Routine::PrepareA(A.begin(), A_prep2.begin(), quant_mult, A_rows, width); in TestMultiplyBiasNew()
153 AlignedVector<float> A(A_rows * width); in TestMultiplyShiftNonShift()
175 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in TestMultiplyShiftNonShift()
179 AlignedVector<float> test_C(A_rows * B_cols); in TestMultiplyShiftNonShift()
209 AlignedVector<float> A(A_rows * width); in TestMultiplyShiftInt()
[all …]
H A Dmultiply_test.cc275 AlignedVector<float> A(A_rows * width); in TestMultiply()
291 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in TestMultiply()
294 AlignedVector<float> test_C(A_rows * B_cols); in TestMultiply()
325 AlignedVector<float> A(A_rows * width); in TestMultiplyRelu()
341 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in TestMultiplyRelu()
344 AlignedVector<float> test_C(A_rows * B_cols); in TestMultiplyRelu()
378 AlignedVector<float> A(A_rows * width); in TestMultiplyBias()
398 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in TestMultiplyBias()
401 AlignedVector<float> test_C(A_rows * B_cols); in TestMultiplyBias()
429 AlignedVector<float> A(A_rows * width); in TestMultiplyBiasRelu()
[all …]
H A Dtest.h93 void Multiply(const TypeA* A, const TypeB* B, TypeC* C, Index A_rows, Index width, Index B_cols, La… in Multiply() argument
96 for (Index r = 0; r < A_rows; ++r) { in Multiply()
102 C[r * B_cols + c] = callback(sum, {r, c, A_rows, B_cols}); in Multiply()
/dports/www/firefox/firefox-99.0/third_party/intgemm/
H A Dexample.cc13 const Index A_rows = 1; in main() local
21 AlignedVector<float> A(A_rows * width); in main()
48 intgemm::Int16::PrepareA(A.begin(), A_prepared.begin(), quant_mult, A_rows, width); in main()
53 AlignedVector<float> C(A_rows * B_cols); in main()
55 …intgemm::Int16::Multiply(A_prepared.begin(), B_prepared.begin(), A_rows, width, B_cols, intgemm::c… in main()
67 intgemm::Int8::PrepareA(A.begin(), A_prepared.begin(), quant_mult, A_rows, width); in main()
72 AlignedVector<float> C(A_rows * B_cols); in main()
74 …intgemm::Int8::Multiply(A_prepared.begin(), B_prepared.begin(), A_rows, width, B_cols, intgemm::ca… in main()
H A DREADME.md37 * A is A_rows x width.
41 intgemm::Int16::PrepareA(A.begin(), A_prepared.begin(), quant_mult, A_rows, width);
45 intgemm::Int16::Multiply(A_prepared.begin(), B_prepared.begin(), A_rows, width, B_cols, intgemm::ca…
63 * A is A_rows x width.
72 intgemm::Int8Shift::PrepareA(A.begin(), A_prepared.begin(), quant_mult, A_rows, width);
78 intgemm::Int8Shift::Multiply(A_prepared.begin(), B_prepared.begin(), A_rows, width, B_cols, callbac…
/dports/math/armadillo/armadillo-10.7.1/include/armadillo_bits/
H A Dglue_kron_meat.hpp33 const uword A_rows = A.n_rows; in direct_kron() local
38 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
44 for(uword i = 0; i < A_rows; i++) in direct_kron()
65 const uword A_rows = A.n_rows; in direct_kron() local
70 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
78 for(uword i = 0; i < A_rows; i++) in direct_kron()
97 const uword A_rows = A.n_rows; in direct_kron() local
102 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
108 for(uword i = 0; i < A_rows; i++) in direct_kron()
/dports/math/R-cran-RcppArmadillo/RcppArmadillo/inst/include/armadillo_bits/
H A Dglue_kron_meat.hpp33 const uword A_rows = A.n_rows; in direct_kron() local
38 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
44 for(uword i = 0; i < A_rows; i++) in direct_kron()
65 const uword A_rows = A.n_rows; in direct_kron() local
70 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
78 for(uword i = 0; i < A_rows; i++) in direct_kron()
97 const uword A_rows = A.n_rows; in direct_kron() local
102 out.set_size(A_rows*B_rows, A_cols*B_cols); in direct_kron()
108 for(uword i = 0; i < A_rows; i++) in direct_kron()
/dports/math/qposases/qpOASES-3.2.1/interfaces/scilab/
H A DqpOASESinterface.c120 int_t A, A_rows, A_cols; in interface_qpOASES() local
194 y_size = H_rows + A_rows; in interface_qpOASES()
205 &H_rows,&A_rows,istk(nWSR), in interface_qpOASES()
226 int_t A, A_rows, A_cols; in interface_QProblem_init() local
300 y_size = H_rows + A_rows; in interface_QProblem_init()
310 qp_rowsA = A_rows; in interface_QProblem_init()
419 int_t A, A_rows, A_cols; in interface_SQProblem_init() local
493 y_size = H_rows + A_rows; in interface_SQProblem_init()
503 sqp_rowsA = A_rows; in interface_SQProblem_init()
703 int_t A, A_rows, A_cols; in interface_SQProblem_hotstart() local
[all …]
/dports/math/stanmath/math-4.2.0/stan/math/opencl/kernels/
H A Dneg_rect_lower_tri_multiply.hpp41 __global double* A, const __global double* temp, const int A_rows,
79 if (C1_global_col <= C1_global_row && C1_global_col < A_rows
80 && C1_global_row < A_rows) {
82 = A[C1_global_col * A_rows + C1_global_row];
109 if (A_global_col < A_rows && (i + rows + offset) < A_rows) {
110 A[A_global_col * A_rows + i + rows + offset] = -acc[w];
H A Dinv_lower_tri_multiply.hpp48 const int A_rows, const int rows) {
83 if (C2_global_col <= C2_global_row && C2_global_col < A_rows
84 && C2_global_row < A_rows) {
86 = A[C2_global_col * A_rows + C2_global_row];
90 if (A3_global_col < A_rows && A3_global_row < A_rows) {
92 = A[A3_global_col * A_rows + A3_global_row];
/dports/math/py-pystan/pystan-2.19.0.0/pystan/stan/lib/stan_math/stan/math/opencl/kernels/
H A Dinv_lower_tri_multiply.hpp46 const int A_rows, const int rows) {
81 if (C2_global_col <= C2_global_row && C2_global_col < A_rows
82 && C2_global_row < A_rows) {
84 = A[C2_global_col * A_rows + C2_global_row];
88 if (A3_global_col < A_rows && A3_global_row < A_rows) {
90 = A[A3_global_col * A_rows + A3_global_row];
H A Dneg_rect_lower_tri_multiply.hpp39 __global double* A, const __global double* temp, const int A_rows,
77 if (C1_global_col <= C1_global_row && C1_global_col < A_rows
78 && C1_global_row < A_rows) {
80 = A[C1_global_col * A_rows + C1_global_row];
107 if (A_global_col < A_rows && (i + rows + offset) < A_rows) {
108 A[A_global_col * A_rows + i + rows + offset] = -acc[w];
/dports/www/firefox/firefox-99.0/third_party/intgemm/benchmarks/
H A Dbiasmultiply.cc14 std::chrono::duration<double> testNew(Index A_rows, Index width, Index B_cols) { in testNew() argument
15 AlignedVector<float> A(A_rows * width); in testNew()
36 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in testNew()
39 AlignedVector<float> test_C(A_rows * B_cols); in testNew()
53 std::chrono::duration<double> testOld(Index A_rows, Index width, Index B_cols) { in testOld() argument
54 AlignedVector<float> A(A_rows * width); in testOld()
75 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in testOld()
78 AlignedVector<float> test_C(A_rows * B_cols); in testOld()
91 AlignedVector<float> A(A_rows * width); in testOld_nobias()
108 Routine::PrepareA(A.begin(), A_prep.begin(), quant_mult, A_rows, width); in testOld_nobias()
[all …]
H A Dbenchmark.cc27 A_rows(A_rows_in), width(width_in), B_cols(B_cols_in), in RandomMatrices()
28 A(A_rows * width), B(width * B_cols) { in RandomMatrices()
41 const Index A_rows, width, B_cols; member
49 AlignedVector<Integer> A_prepared(m.A_rows * m.width); in Run()
50 Backend::PrepareA(m.A.begin(), A_prepared.begin(), quant_mult, m.A_rows, m.width); in Run()
53 AlignedVector<float> output(m.A_rows * m.B_cols); in Run()
55 …Backend::Multiply(A_prepared.begin(), B_prepared.begin(), m.A_rows, m.width, m.B_cols, callbacks::… in Run()
57 …Backend::Multiply(A_prepared.begin(), B_prepared.begin(), m.A_rows, m.width, m.B_cols, callbacks::… in Run()
138 …for (full_sample = matrices_end - 1; full_sample >= matrices && full_sample->A_rows >= 1024; --ful… in main()
196 …std::cout << "Multiply\t" << matrices[i].A_rows << '\t' << matrices[i].width << '\t' << matrices[i… in main()
/dports/www/firefox/firefox-99.0/third_party/intgemm/intgemm/
H A Dintgemm.h207 …static void Multiply(const int8_t *A, const int8_t *B, Index A_rows, Index width, Index B_cols, Ca… in Multiply()
208 MultiplyImpl<Callback>::run(A, B, A_rows, width, B_cols, callback); in Multiply()
216 …static void (*run)(const int8_t *A, const int8_t *B, Index A_rows, Index width, Index B_cols, Call…
221 void (*Int8::MultiplyImpl<Callback>::run)(const int8_t *A, const int8_t *B, Index A_rows, Index wid…
255 …static void Multiply(const int8_t *A, const int8_t *B, Index A_rows, Index width, Index B_cols, Ca… in Multiply()
256 MultiplyImpl<Callback>::run((const uint8_t *)A, B, A_rows, width, B_cols, callback); in Multiply()
274 …static void (*run)(const uint8_t *A, const int8_t *B, Index A_rows, Index width, Index B_cols, Cal…
284 void (*Int8Shift::MultiplyImpl<Callback>::run)(const uint8_t *A, const int8_t *B, Index A_rows, Ind…
334 …static void Multiply(const int16_t *A, const int16_t *B, Index A_rows, Index width, Index B_cols, … in Multiply()
335 MultiplyImpl<Callback>::run(A, B, A_rows, width, B_cols, callback); in Multiply()
[all …]
H A Davx512vnni_gemm.h23 …INTGEMM_AVX512VNNI static void Multiply(const int8_t *A, const int8_t *B, Index A_rows, Index widt… in Multiply()
36 for (Index A_rowidx = 0; A_rowidx < A_rows; ++A_rowidx) { in Multiply()
78 callback_impl.Run(total, callbacks::OutputBufferInfo(A_rowidx, B0_colidx, A_rows, B_cols)); in Multiply()
84 …INTGEMM_AVX512VNNI static void Multiply8Shift(const uint8_t *A, const int8_t *B, Index A_rows, Ind… in Multiply8Shift()
97 for (Index A_rowidx = 0; A_rowidx < A_rows; ++A_rowidx) { in Multiply8Shift()
119 callback_impl.Run(total, callbacks::OutputBufferInfo(A_rowidx, B0_colidx, A_rows, B_cols)); in Multiply8Shift()
H A Dmultiply.h162 …k> target static void Multiply(const int16_t *A, const int16_t *B, Index A_rows, Index width, Inde…
173 for (Index A_rowidx = 0; A_rowidx < A_rows; ++A_rowidx) { \
213 RunCallback(callback_impl, total, A_rowidx, B0_colidx, A_rows, B_cols); \
294 …rget static void Multiply8Shift(const uint8_t *A, const int8_t *B, Index A_rows, Index width, Inde…
305 for (Index A_rowidx = 0; A_rowidx < A_rows; ++A_rowidx) { \
365 RunCallback(callback_impl, total, A_rowidx, B0_colidx, A_rows, B_cols); \
541 …ack> target static void Multiply(const int8_t *A, const int8_t *B, Index A_rows, Index width, Inde…
552 for (Index A_rowidx = 0; A_rowidx < A_rows; ++A_rowidx) { \
603 RunCallback(callback_impl, total, A_rowidx, B0_colidx, A_rows, B_cols); \
619 Backend::template Multiply<Callback>(A, B, A_rows, width, B_cols, callback); in OMPParallelWrap()
[all …]
/dports/math/scilab/scilab-6.1.1/scilab/modules/elementary_functions/tests/unit_tests/
H A Dmembers.dia.ref268 A_rows = A_cols';
270 [nb, loc] = members(A_rows, S_rows, "rows");
279 A_rows = A_cols';
281 [nb, loc] = members(A_rows, S_rows, "rows");
290 A_rows = A_cols';
292 [nb, loc] = members(A_rows, S_rows, "rows");
311 A_rows = A_cols';
328 A_rows = A_cols';
345 A_rows = A_cols';
391 A_rows(2, 1) = "%inf";
[all …]
H A Dmembers.tst320 A_rows = A_cols';
322 [nb, loc] = members(A_rows, S_rows, "rows");
331 A_rows = A_cols';
333 [nb, loc] = members(A_rows, S_rows, "rows");
342 A_rows = A_cols';
344 [nb, loc] = members(A_rows, S_rows, "rows");
365 A_rows = A_cols';
382 A_rows = A_cols';
399 A_rows = A_cols';
451 A_rows(2, 1) = "%inf";
[all …]
/dports/math/py-cvxpy/cvxpy-1.1.17/cvxpy/cvxcore/python/
H A DcanonInterface.py158 A_rows, A_cols = A.nonzero()
160 A_rows = A_rows[ind]
164 return A_rows, A_cols
240 A_rows, A_cols = nonzero_csc_matrix(A)
242 A_rows = np.append(A_rows, nonzero_rows % A_nrows)
244 A = scipy.sparse.csc_matrix((A_vals, (A_rows, A_cols)),
/dports/misc/py-mxnet/incubator-mxnet-1.9.0/src/operator/contrib/intgemm/
H A Dintgemm_fully_connected_op.cc181 size_t A_rows = A.shape_.ProdShape(0, A.shape_.ndim() - 1); in IntgemmFullyConnectedOpForwardCPU() local
186 CHECK_EQ(C.shape_.Size(), A_rows * B_cols); in IntgemmFullyConnectedOpForwardCPU()
218 ::intgemm::Int8::PrepareA(A_raw, A_quant, scale, A_rows, inner); in IntgemmFullyConnectedOpForwardCPU()
244 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
252 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
257 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
261 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
/dports/misc/mxnet/incubator-mxnet-1.9.0/src/operator/contrib/intgemm/
H A Dintgemm_fully_connected_op.cc181 size_t A_rows = A.shape_.ProdShape(0, A.shape_.ndim() - 1); in IntgemmFullyConnectedOpForwardCPU() local
186 CHECK_EQ(C.shape_.Size(), A_rows * B_cols); in IntgemmFullyConnectedOpForwardCPU()
218 ::intgemm::Int8::PrepareA(A_raw, A_quant, scale, A_rows, inner); in IntgemmFullyConnectedOpForwardCPU()
244 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
252 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
257 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
261 ::intgemm::Int8::Multiply(A_quant, B_quant, A_rows, inner, B_cols, cb); in IntgemmFullyConnectedOpForwardCPU()
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/HYPRE/
H A Dhypre_parcsr.cpp331 HYPRE_Int A_rows = hypre_CSRMatrixNumRows(A); in hypre_CSRMatrixElimCreate() local
333 hypre_CSRMatrixI(Ae) = hypre_TAlloc(HYPRE_Int, A_rows+1); in hypre_CSRMatrixElimCreate()
338 for (i = 0; i < A_rows; i++) in hypre_CSRMatrixElimCreate()
372 Ae_i[A_rows] = nnz; in hypre_CSRMatrixElimCreate()
399 HYPRE_Int A_rows = hypre_CSRMatrixNumRows(A); in hypre_CSRMatrixEliminateRowsCols() local
405 for (i = 0; i < A_rows; i++) in hypre_CSRMatrixEliminateRowsCols()
642 HYPRE_Int A_rows = hypre_CSRMatrixNumRows(A); in hypre_CSRMatrixSplit() local
648 HYPRE_Int *block_row = hypre_TAlloc(HYPRE_Int, A_rows); in hypre_CSRMatrixSplit()
651 for (i = 0; i < A_rows; i++) in hypre_CSRMatrixSplit()
672 for (i = 0; i < A_rows; i++) in hypre_CSRMatrixSplit()
[all …]
/dports/math/viennacl/ViennaCL-1.7.1/tests/src/
H A Dlibviennacl_blas3.cpp158 ViennaCLInt A_rows = A_size1 * A_stride1 + A_start1 + 5; in test_blas() local
179 …t = get_value(A_float, i, k, A_start1, A_start2, A_stride1, A_stride2, A_rows, A_columns, order_… in test_blas()
180 …le = get_value(A_double, i, k, A_start1, A_start2, A_stride1, A_stride2, A_rows, A_columns, order_… in test_blas()
207 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
217 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
228 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
238 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
250 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
262 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
H A Dlibviennacl_blas3.cu158 ViennaCLInt A_rows = A_size1 * A_stride1 + A_start1 + 5; in test_blas() local
179 …t = get_value(A_float, i, k, A_start1, A_start2, A_stride1, A_stride2, A_rows, A_columns, order_… in test_blas()
180 …le = get_value(A_double, i, k, A_start1, A_start2, A_stride1, A_stride2, A_rows, A_columns, order_… in test_blas()
207 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
217 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
228 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
238 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
250 …oat), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()
262 …ble), A_start1, A_start2, A_stride1, A_stride2, (order_A == ViennaCLRowMajor) ? A_columns : A_rows, in test_blas()

12