Home
last modified time | relevance | path

Searched refs:cols (Results 1 – 25 of 587) sorted by relevance

12345678910>>...24

/external/libvpx/libvpx/test/
Dpp_filter_test.cc26 int dst_pixels_per_line, int cols, unsigned char *flimit, int size);
29 int rows, int cols, int flimit);
32 int cols, int flimit);
167 void SetCols(unsigned char *s, int rows, int cols, int src_width) { in SetCols() argument
169 for (int c = 0; c < cols; c++) { in SetCols()
177 int rows, int cols, int src_pitch) { in RunComparison() argument
179 for (int c = 0; c < cols; c++) { in RunComparison()
187 void RunFilterLevel(unsigned char *s, int rows, int cols, int src_width, in RunFilterLevel() argument
190 GetParam()(s, src_width, rows, cols, filter_level)); in RunFilterLevel()
191 RunComparison(expected_output, s, rows, cols, src_width); in RunFilterLevel()
[all …]
/external/swiftshader/third_party/LLVM/include/llvm/CodeGen/PBQP/
DMath.h116 Matrix(unsigned rows, unsigned cols) : in Matrix() argument
117 rows(rows), cols(cols), data(new PBQPNum[rows * cols]) { in Matrix()
122 Matrix(unsigned rows, unsigned cols, PBQPNum initVal) : in Matrix() argument
123 rows(rows), cols(cols), data(new PBQPNum[rows * cols]) { in Matrix()
124 std::fill(data, data + (rows * cols), initVal); in Matrix()
129 rows(m.rows), cols(m.cols), data(new PBQPNum[rows * cols]) { in Matrix()
130 std::copy(m.data, m.data + (rows * cols), data); in Matrix()
139 rows = m.rows; cols = m.cols;
140 data = new PBQPNum[rows * cols];
141 std::copy(m.data, m.data + (rows * cols), data);
[all …]
/external/eigen/test/
Dproduct.h34 Index cols = m.cols(); in product() local
38 MatrixType m1 = MatrixType::Random(rows, cols), in product()
39 m2 = MatrixType::Random(rows, cols), in product()
40 m3(rows, cols); in product()
46 square2 = ColSquareMatrixType::Random(cols, cols), in product()
47 res2 = ColSquareMatrixType::Random(cols, cols); in product()
49 ColVectorType vc2 = ColVectorType::Random(cols), vcres(cols); in product()
55 c = internal::random<Index>(0, cols-1), in product()
56 c2 = internal::random<Index>(0, cols-1); in product()
78 VERIFY_IS_APPROX(MatrixType::Identity(rows, cols)(r,c), static_cast<Scalar>(r==c)); in product()
[all …]
Darray_for_matrix.cpp20 Index cols = m.cols(); in array_for_matrix() local
22 MatrixType m1 = MatrixType::Random(rows, cols), in array_for_matrix()
23 m2 = MatrixType::Random(rows, cols), in array_for_matrix()
24 m3(rows, cols); in array_for_matrix()
27 RowVectorType rv1 = RowVectorType::Random(cols); in array_for_matrix()
34 VERIFY_IS_APPROX((m1.array() + s1).matrix(), MatrixType::Constant(rows,cols,s1) + m1); in array_for_matrix()
35 …VERIFY_IS_APPROX(((m1*Scalar(2)).array() - s2).matrix(), (m1+m1) - MatrixType::Constant(rows,cols,… in array_for_matrix()
61 VERIFY_IS_APPROX(m1.block(0,0,0,cols).colwise().sum(), RowVectorType::Zero(cols)); in array_for_matrix()
91 Index cols = m.cols(); in comparisons() local
94 c = internal::random<Index>(0, cols-1); in comparisons()
[all …]
Dmapstaticmethods.cpp73 Index rows = m.rows(), cols = m.cols(); in run() local
77 PlainObjectType::Map(ptr, rows, cols).setZero(); in run()
78 PlainObjectType::MapAligned(ptr, rows, cols).setZero(); in run()
79 PlainObjectType::Map(const_ptr, rows, cols).sum(); in run()
80 PlainObjectType::MapAligned(const_ptr, rows, cols).sum(); in run()
82 PlainObjectType::Map(ptr, rows, cols, InnerStride<>(i)).setZero(); in run()
83 PlainObjectType::MapAligned(ptr, rows, cols, InnerStride<>(i)).setZero(); in run()
84 PlainObjectType::Map(const_ptr, rows, cols, InnerStride<>(i)).sum(); in run()
85 PlainObjectType::MapAligned(const_ptr, rows, cols, InnerStride<>(i)).sum(); in run()
87 PlainObjectType::Map(ptr, rows, cols, InnerStride<2>()).setZero(); in run()
[all …]
Dcorners.cpp20 Index cols = m.cols(); in corners() local
23 Index c = internal::random<Index>(1,cols); in corners()
25 MatrixType matrix = MatrixType::Random(rows,cols); in corners()
26 const MatrixType const_matrix = MatrixType::Random(rows,cols); in corners()
29 COMPARE_CORNER(topRightCorner(r,c), block(0,cols-c,r,c)); in corners()
31 COMPARE_CORNER(bottomRightCorner(r,c), block(rows-r,cols-c,r,c)); in corners()
35 Index sc = internal::random<Index>(1,cols) - 1; in corners()
36 Index nc = internal::random<Index>(1,cols-sc); in corners()
38 COMPARE_CORNER(topRows(r), block(0,0,r,cols)); in corners()
39 COMPARE_CORNER(middleRows(sr,nr), block(sr,0,nr,cols)); in corners()
[all …]
Dsparse_basic.cpp23 const Index cols = ref.cols(); in sparse_basic() local
31 double density = (std::max)(8./(rows*cols), 0.01); in sparse_basic()
38 SparseMatrixType m(rows, cols); in sparse_basic()
39 DenseMatrix refMat = DenseMatrix::Zero(rows, cols); in sparse_basic()
64 VERIFY_RAISES_ASSERT( m.coeffRef(0,m.cols()) = 0 ); in sparse_basic()
69 DenseMatrix m1(rows,cols); in sparse_basic()
71 SparseMatrixType m2(rows,cols); in sparse_basic()
82 for (Index j=0; j<cols; ++j) in sparse_basic()
103 DenseMatrix m1(rows,cols); in sparse_basic()
105 SparseMatrixType m2(rows,cols); in sparse_basic()
[all …]
Darray.cpp21 Index cols = m.cols(); in array() local
23 ArrayType m1 = ArrayType::Random(rows, cols), in array()
24 m2 = ArrayType::Random(rows, cols), in array()
25 m3(rows, cols); in array()
30 RowVectorType rv1 = RowVectorType::Random(cols); in array()
37 VERIFY_IS_APPROX(m1 + s1, ArrayType::Constant(rows,cols,s1) + m1); in array()
39 VERIFY_IS_APPROX(m1 - s1, m1 - ArrayType::Constant(rows,cols,s1)); in array()
40 VERIFY_IS_APPROX(s1 - m1, ArrayType::Constant(rows,cols,s1) - m1); in array()
41 VERIFY_IS_APPROX((m1*Scalar(2)) - s2, (m1+m1) - ArrayType::Constant(rows,cols,s2) ); in array()
51 …ArrayType::Map(m1.data(), m1.rows(), m1.cols()) -= ArrayType::Map(m2.data(), m2.rows(), m2.cols()); in array()
[all …]
Dresize.cpp12 template<DenseIndex rows, DenseIndex cols>
15 MatrixXf A(rows, cols); in resizeLikeTest()
17 Matrix<double, rows, cols> C; in resizeLikeTest()
20 VERIFY(B.rows() == rows && B.cols() == cols); in resizeLikeTest()
25 VERIFY(y.rows() == 1 && y.cols() == rows); in resizeLikeTest()
27 y.resize(cols); in resizeLikeTest()
29 VERIFY(x.rows() == cols && x.cols() == 1); in resizeLikeTest()
/external/libavc/common/
Dih264_chroma_intra_pred_filters.c314 WORD32 rows, cols; /* loop variables*/ in ih264_intra_pred_chroma_8x8_mode_horz() local
320 for(cols = 0; cols < 16; cols += 2) in ih264_intra_pred_chroma_8x8_mode_horz()
322 *(pu1_dst + rows * dst_strd + cols) = *pu1_left; in ih264_intra_pred_chroma_8x8_mode_horz()
324 *(pu1_dst + rows * dst_strd + cols + 1) = *(pu1_left + 1); in ih264_intra_pred_chroma_8x8_mode_horz()
438 WORD32 rows, cols; /* loop variables*/ in ih264_intra_pred_chroma_8x8_mode_plane() local
450 for(cols = 0; cols < 4; cols++) in ih264_intra_pred_chroma_8x8_mode_plane()
452 …h_u += (cols + 1) * (pu1_top[8 + 2 * cols] - pu1_top[4 - 2 * cols]);/*section 8.3.4.4 equation (… in ih264_intra_pred_chroma_8x8_mode_plane()
453 h_v += (cols + 1) * (pu1_top[8 + 2 * cols + 1] - pu1_top[4 - 2 * cols+ 1]); in ih264_intra_pred_chroma_8x8_mode_plane()
455 v_u += (cols + 1) * (pu1_left[(4 + cols) * (-2)] - pu1_left[(2 - cols) * (-2)]); in ih264_intra_pred_chroma_8x8_mode_plane()
456 …v_v += (cols + 1) * (pu1_left[(4 + cols) * (-2) + 1] - pu1_left[(2 - cols) * (-2) + 1]);/*sectio… in ih264_intra_pred_chroma_8x8_mode_plane()
[all …]
/external/eigen/bench/
Dsparse_product.cpp101 int cols = SIZE; in main() local
104 EigenSparseMatrix sm1(rows,cols), sm2(rows,cols), sm3(rows,cols), sm4(rows,cols); in main()
111 fillMatrix2(nnzPerCol, rows, cols, sm1); in main()
112 fillMatrix2(nnzPerCol, rows, cols, sm2); in main()
119 DenseMatrix m1(rows,cols), m2(rows,cols), m3(rows,cols); in main()
155 …std::cout << "Eigen sparse\t" << sm1.nonZeros()/(float(sm1.rows())*float(sm1.cols()))*100 << "% * " in main()
156 << sm2.nonZeros()/(float(sm2.rows())*float(sm2.cols()))*100 << "%\n"; in main()
254 UBlasSparse m1(rows,cols), m2(rows,cols), m3(rows,cols); in main()
267 GmmDynSparse gmmT3(rows,cols); in main()
268 GmmSparse m1(rows,cols), m2(rows,cols), m3(rows,cols); in main()
[all …]
/external/valgrind/drd/tests/
Domp_matinv.c44 static elem_t* new_matrix(const int rows, const int cols) in new_matrix() argument
47 assert(cols > 0); in new_matrix()
48 return malloc(rows * cols * sizeof(elem_t)); in new_matrix()
58 static void init_matrix(elem_t* const a, const int rows, const int cols) in init_matrix() argument
65 a[i * cols + j] = 1.0 / (1 + abs(i-j)); in init_matrix()
72 const elem_t* const a, const int rows, const int cols) in print_matrix() argument
78 for (j = 0; j < cols; j++) in print_matrix()
80 printf("%g ", a[i * cols + j]); in print_matrix()
158 static void gj(elem_t* const a, const int rows, const int cols) in gj() argument
169 if (a[k * cols + i] > a[j * cols + i]) in gj()
[all …]
Dmatinv.c36 int cols; member
56 static elem_t* new_matrix(const int rows, const int cols) in new_matrix() argument
59 assert(cols > 0); in new_matrix()
60 return malloc(rows * cols * sizeof(elem_t)); in new_matrix()
70 static void init_matrix(elem_t* const a, const int rows, const int cols) in init_matrix() argument
77 a[i * cols + j] = 1.0 / (1 + abs(i-j)); in init_matrix()
84 const elem_t* const a, const int rows, const int cols) in print_matrix() argument
90 for (j = 0; j < cols; j++) in print_matrix()
92 printf("%g ", a[i * cols + j]); in print_matrix()
175 const int cols = p->cols; in gj_threadfunc() local
[all …]
/external/dng_sdk/source/
Ddng_bottlenecks.h56 uint32 cols,
66 uint32 cols,
76 uint32 cols,
88 uint32 cols,
101 uint32 cols,
114 uint32 cols,
127 uint32 cols,
140 uint32 cols,
153 uint32 cols,
166 uint32 cols,
[all …]
/external/eigen/Eigen/src/QR/
DColPivHouseholderQR.h100 ColPivHouseholderQR(Index rows, Index cols)
101 : m_qr(rows, cols),
102 m_hCoeffs((std::min)(rows,cols)),
103 m_colsPermutation(PermIndexType(cols)),
104 m_colsTranspositions(cols),
105 m_temp(cols),
106 m_colNormsUpdated(cols),
107 m_colNormsDirect(cols),
125 : m_qr(matrix.rows(), matrix.cols()),
126 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())),
[all …]
DCompleteOrthogonalDecomposition.h93 CompleteOrthogonalDecomposition(Index rows, Index cols)
94 : m_cpqr(rows, cols), m_zCoeffs((std::min)(rows, cols)), m_temp(cols) {}
114 : m_cpqr(matrix.rows(), matrix.cols()),
115 m_zCoeffs((std::min)(matrix.rows(), matrix.cols())),
116 m_temp(matrix.cols())
130 m_zCoeffs((std::min)(matrix.rows(), matrix.cols())),
131 m_temp(matrix.cols())
160 MatrixType Z = MatrixType::Identity(m_cpqr.cols(), m_cpqr.cols());
282 inline Index cols() const { return m_cpqr.cols(); }
415 eigen_assert(m_cpqr.cols() <= NumTraits<int>::highest());
[all …]
DHouseholderQR.h78 HouseholderQR(Index rows, Index cols) in HouseholderQR() argument
79 : m_qr(rows, cols), in HouseholderQR()
80 m_hCoeffs((std::min)(rows,cols)), in HouseholderQR()
81 m_temp(cols), in HouseholderQR()
98 : m_qr(matrix.rows(), matrix.cols()), in HouseholderQR()
99 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())), in HouseholderQR()
100 m_temp(matrix.cols()), in HouseholderQR()
117 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())), in HouseholderQR()
118 m_temp(matrix.cols()), in HouseholderQR()
206 inline Index cols() const { return m_qr.cols(); } in cols() function
[all …]
DFullPivHouseholderQR.h103 FullPivHouseholderQR(Index rows, Index cols)
104 : m_qr(rows, cols),
105 m_hCoeffs((std::min)(rows,cols)),
106 m_rows_transpositions((std::min)(rows,cols)),
107 m_cols_transpositions((std::min)(rows,cols)),
108 m_cols_permutation(cols),
109 m_temp(cols),
127 : m_qr(matrix.rows(), matrix.cols()),
128 m_hCoeffs((std::min)(matrix.rows(), matrix.cols())),
129 m_rows_transpositions((std::min)(matrix.rows(), matrix.cols())),
[all …]
/external/eigen/Eigen/src/Core/
DPlainObjectBase.h40 static EIGEN_ALWAYS_INLINE void run(Index rows, Index cols)
45 bool error = (rows == 0 || cols == 0) ? false
46 : (rows > max_index / cols);
153 EIGEN_STRONG_INLINE Index cols() const { return m_storage.cols(); }
163 return m_storage.data()[colId + rowId * m_storage.cols()];
186 return m_storage.data()[colId + rowId * m_storage.cols()];
207 return m_storage.data()[colId + rowId * m_storage.cols()];
226 ? colId + rowId * m_storage.cols()
243 ? colId + rowId * m_storage.cols()
279 EIGEN_STRONG_INLINE void resize(Index rows, Index cols)
[all …]
/external/apache-commons-math/src/main/java/org/apache/commons/math/estimation/
DLevenbergMarquardtEstimator.java254 solvedCols = FastMath.min(rows, cols); in estimate()
255 diagR = new double[cols]; in estimate()
256 jacNorm = new double[cols]; in estimate()
257 beta = new double[cols]; in estimate()
258 permutation = new int[cols]; in estimate()
259 lmDir = new double[cols]; in estimate()
264 double[] diag = new double[cols]; in estimate()
265 double[] oldX = new double[cols]; in estimate()
267 double[] work1 = new double[cols]; in estimate()
268 double[] work2 = new double[cols]; in estimate()
[all …]
/external/eigen/doc/
DAsciiQuickReference.txt6 Matrix<double, 3, 3> A; // Fixed rows and cols. Same as Matrix3d.
7 Matrix<double, 3, Dynamic> B; // Fixed rows, dynamic cols.
20 C.cols() // size(C,2) // number of columns
27 B.resize(3, 9); // Ok; only dynamic cols changed.
30 4, 5, 6, // matrices, which are stacked along cols
36 MatrixXd::Identity(rows,cols) // eye(rows,cols)
37 C.setIdentity(rows,cols) // C = eye(rows,cols)
38 MatrixXd::Zero(rows,cols) // zeros(rows,cols)
39 C.setZero(rows,cols) // C = zeros(rows,cols)
40 MatrixXd::Ones(rows,cols) // ones(rows,cols)
[all …]
/external/trappy/trappy/plotter/
DPlotLayout.py42 def __init__(self, cols, num_plots, **kwargs): argument
44 self.cols = cols
51 if self.num_plots < self.cols:
52 self.cols = self.num_plots
53 self.rows = (self.num_plots / self.cols)
55 if self.num_plots % self.cols != 0:
72 elif self.cols == 1:
77 self.rows, self.cols, figsize=(
78 self._attr["width"] * self.cols,
109 return linear_val % self.cols
[all …]
/external/gemmlowp/meta/generators/
Dgemv_1xMxK_neon.py83 def GenerateMulCols(emitter, result_type, lhs_add, rhs_add, aligned, cols, argument
104 if cols > 4:
111 zip_Nx8_neon.BuildName(cols - 4, leftovers, aligned),
115 mul_1x8_Mx8_neon.BuildName(result_type, lhs_add, rhs_add, cols),
117 elif cols > 0:
119 zip_Nx8_neon.BuildName(cols, leftovers, aligned),
123 mul_Nx8_Mx8_neon.BuildName(result_type, lhs_add, rhs_add, 1, cols),
127 def GenerateQuantized8BitMul(emitter, aligned, cols, leftovers): argument
129 GenerateMulCols(emitter, 'int32', False, True, aligned, cols, leftovers)
131 qnt_Nx8_neon.BuildName(1, cols, aligned),
[all …]
Dgemm_NxMxK_neon.py80 def GenerateZipRhs(emitter, aligned, cols, leftovers): argument
90 if cols is not 0:
92 ZipName(cols, leftovers, aligned),
97 def MulName(result_type, lhs_add, rhs_add, rows, cols): argument
98 return mul_Nx8_Mx8_neon.BuildName(result_type, lhs_add, rhs_add, rows, cols)
110 rows, cols, leftovers): argument
128 if cols is not 0:
130 MulName(result_type, lhs_add, rhs_add, rows, cols),
134 def GenerateQuantized8BitMul(emitter, aligned, rows, cols, leftovers): argument
138 cols, leftovers)
[all …]
/external/eigen/Eigen/src/LU/
DFullPivLU.h92 FullPivLU(Index rows, Index cols);
352 return cols() - rank();
365 return rank() == cols();
390 return isInjective() && (m_lu.rows() == m_lu.cols());
403 … eigen_assert(m_lu.rows() == m_lu.cols() && "You can't take the inverse of a non-square matrix!");
410 EIGEN_DEVICE_FUNC inline Index cols() const { return m_lu.cols(); }
450 FullPivLU<MatrixType>::FullPivLU(Index rows, Index cols)
451 : m_lu(rows, cols),
453 m_q(cols),
455 m_colsTranspositions(cols),
[all …]

12345678910>>...24