/external/chromium_org/third_party/skia/src/utils/ |
SkMeshUtils.cpp | 21 int texW, int texH, int rows, int cols) { 22 if (rows < 2 || cols < 2) { 34 fTexCount = rows * cols; 36 cols -= 1; 37 fIndexCount = rows * cols * 6; 53 for (int y = 0; y < cols; y++) { 73 const SkScalar dy = SkIntToScalar(texH) / cols; 74 for (int y = 0; y <= cols; y++) { 89 int rows, int cols, const SkPoint verts[], 93 if (idx.init(bitmap.width(), bitmap.height(), rows, cols)) { [all...] |
/external/skia/src/utils/ |
SkMeshUtils.cpp | 21 int texW, int texH, int rows, int cols) { 22 if (rows < 2 || cols < 2) { 34 fTexCount = rows * cols; 36 cols -= 1; 37 fIndexCount = rows * cols * 6; 53 for (int y = 0; y < cols; y++) { 73 const SkScalar dy = SkIntToScalar(texH) / cols; 74 for (int y = 0; y <= cols; y++) { 89 int rows, int cols, const SkPoint verts[], 93 if (idx.init(bitmap.width(), bitmap.height(), rows, cols)) { [all...] |
/external/eigen/doc/examples/ |
tut_matrix_resize.cpp | 11 << m.rows() << "x" << m.cols() << std::endl; 17 << v.rows() << "x" << v.cols() << std::endl;
|
/external/eigen/test/eigen2/ |
eigen2_nomalloc.cpp | 31 int cols = m.cols(); local 33 MatrixType m1 = MatrixType::Random(rows, cols), 34 m2 = MatrixType::Random(rows, cols), 35 m3(rows, cols), 36 mzero = MatrixType::Zero(rows, cols), 48 c = ei_random<int>(0, cols-1); 52 VERIFY_IS_APPROX(m1.cwise() * m1.block(0,0,rows,cols), m1.cwise() * m1);
|
eigen2_inverse.cpp | 20 int cols = m.cols(); local 26 MatrixType m1 = MatrixType::Random(rows, cols), 27 m2(rows, cols), 28 mzero = MatrixType::Zero(rows, cols), 33 m1 = MatrixType::Random(rows, cols);
|
eigen2_lu.cpp | 17 for(int a = 0; a < 3*(m.rows()+m.cols()); a++) 27 i = Eigen::ei_random<int>(0,m.cols()-1); // i is a random column number 29 j = Eigen::ei_random<int>(0,m.cols()-1); 41 int rows = ei_random<int>(20,200), cols = ei_random<int>(20,200), cols2 = ei_random<int>(20,200); local 42 int rank = ei_random<int>(1, std::min(rows, cols)-1); 44 MatrixType m1(rows, cols), m2(cols, cols2), m3(rows, cols2), k(1,1); 45 m1 = MatrixType::Random(rows,cols); 46 if(rows <= cols) 49 for(int i = rank; i < cols; i++) m1.col(i).setZero() [all...] |
eigen2_array.cpp | 24 int cols = m.cols(); local 26 MatrixType m1 = MatrixType::Random(rows, cols), 27 m2 = MatrixType::Random(rows, cols), 28 m3(rows, cols); 35 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1); 36 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) ); 59 int cols = m.cols(); local 62 c = ei_random<int>(0, cols-1) [all...] |
eigen2_sparse_solvers.cpp | 17 Matrix<Scalar,Dynamic,Dynamic> aux(refMat.rows(),refMat.cols()); 26 for (int j=0 ; j<sparseMat.cols(); ++j) 33 template<typename Scalar> void sparse_solvers(int rows, int cols) 35 double density = std::max(8./(rows*cols), 0.01); 48 SparseMatrix<Scalar> m2(rows, cols); 49 DenseMatrix refMat2 = DenseMatrix::Zero(rows, cols); 75 SparseMatrix<Scalar> m2(rows, cols); 76 DenseMatrix refMat2(rows, cols); 78 DenseVector b = DenseVector::Random(cols); 79 DenseVector refX(cols), x(cols) [all...] |
eigen2_miscmatrices.cpp | 22 int cols = m.cols(); local 24 int r = ei_random<int>(0, rows-1), r2 = ei_random<int>(0, rows-1), c = ei_random<int>(0, cols-1); 25 VERIFY_IS_APPROX(MatrixType::Ones(rows,cols)(r,c), static_cast<Scalar>(1)); 26 MatrixType m1 = MatrixType::Ones(rows,cols);
|
/external/eigen/test/ |
upperbidiagonalization.cpp | 16 const typename MatrixType::Index cols = m.cols(); local 21 MatrixType a = MatrixType::Random(rows,cols); 23 RealMatrixType b(rows, cols); 25 b.block(0,0,cols,cols) = ubd.bidiagonal();
|
mapstaticmethods.cpp | 72 int rows = m.rows(), cols = m.cols(); local 76 PlainObjectType::Map(ptr, rows, cols).setZero(); 77 PlainObjectType::MapAligned(ptr, rows, cols).setZero(); 78 PlainObjectType::Map(const_ptr, rows, cols).sum(); 79 PlainObjectType::MapAligned(const_ptr, rows, cols).sum(); 81 PlainObjectType::Map(ptr, rows, cols, InnerStride<>(i)).setZero(); 82 PlainObjectType::MapAligned(ptr, rows, cols, InnerStride<>(i)).setZero(); 83 PlainObjectType::Map(const_ptr, rows, cols, InnerStride<>(i)).sum(); 84 PlainObjectType::MapAligned(const_ptr, rows, cols, InnerStride<>(i)).sum() [all...] |
array.cpp | 21 Index cols = m.cols(); local 23 ArrayType m1 = ArrayType::Random(rows, cols), 24 m2 = ArrayType::Random(rows, cols), 25 m3(rows, cols); 28 RowVectorType rv1 = RowVectorType::Random(cols); 35 VERIFY_IS_APPROX(m1 + s1, ArrayType::Constant(rows,cols,s1) + m1); 37 VERIFY_IS_APPROX(m1 - s1, m1 - ArrayType::Constant(rows,cols,s1)); 38 VERIFY_IS_APPROX(s1 - m1, ArrayType::Constant(rows,cols,s1) - m1); 39 VERIFY_IS_APPROX((m1*Scalar(2)) - s2, (m1+m1) - ArrayType::Constant(rows,cols,s2) ) 92 Index cols = m.cols(); local 157 Index cols = m.cols(); local 219 Index cols = m.cols(); local 239 Index cols = m.cols(); local [all...] |
array_for_matrix.cpp | 21 Index cols = m.cols(); local 23 MatrixType m1 = MatrixType::Random(rows, cols), 24 m2 = MatrixType::Random(rows, cols), 25 m3(rows, cols); 28 RowVectorType rv1 = RowVectorType::Random(cols); 35 VERIFY_IS_APPROX((m1.array() + s1).matrix(), MatrixType::Constant(rows,cols,s1) + m1); 36 VERIFY_IS_APPROX(((m1*Scalar(2)).array() - s2).matrix(), (m1+m1) - MatrixType::Constant(rows,cols,s2) ); 62 VERIFY_IS_APPROX(m1.block(0,0,0,cols).colwise().sum(), RowVectorType::Zero(cols)); 82 Index cols = m.cols(); local 150 Index cols = m.cols(); local [all...] |
/external/ceres-solver/internal/ceres/ |
compressed_row_sparse_matrix_test.cc | 165 EXPECT_EQ(crsm->num_nonzeros(), crs_matrix.cols.size()); 173 EXPECT_EQ(crsm->cols()[i], crs_matrix.cols[i]); 225 int* cols = matrix_->mutable_cols(); local 229 cols[0] = 0; 233 cols[1] = 1; 237 cols[2] = 1; 239 cols[3] = 2; 243 cols[4] = 0; 245 cols[5] = 1 284 int* cols = matrix.mutable_cols(); local [all...] |
/external/eigen/Eigen/src/Core/products/ |
Parallelizer.h | 86 void parallelize_gemm(const Functor& func, Index rows, Index cols, bool transpose) 96 func(0,rows, 0,cols); 108 return func(0,rows, 0,cols); 110 Index size = transpose ? cols : rows; 120 return func(0,rows, 0,cols); 126 std::swap(rows,cols); 128 Index blockCols = (cols / threads) & ~Index(0x3); 140 Index actualBlockCols = (i+1==threads) ? cols-c0 : blockCols; 146 func(0, cols, r0, actualBlockRows, info); 148 func(r0, actualBlockRows, 0,cols, info) [all...] |
/external/qemu/distrib/sdl-1.2.15/src/video/ |
SDL_yuv_mmx.c | 83 int rows, int cols, int mod ) 88 unsigned char* y = lum +cols*rows; // Pointer to the end 91 row2 = (Uint32 *)out+cols+mod; // start of second row 92 mod = (mod+cols+mod)*4; // increment for row1 in byte 125 // L2=lum+cols 223 "addl %4,%2\n" // lum += cols 234 "r"(row1),"r"(cols),"r"(row2),"m"(x),"m"(y),"m"(mod), 244 int rows, int cols, int mod ) 249 unsigned char* y = lum +cols*rows; /* Pointer to the end */ 252 row2 = (Uint16 *)out+cols+mod; /* start of second row * [all...] |
/external/eigen/Eigen/src/Core/ |
PlainObjectBase.h | 25 EIGEN_ALWAYS_INLINE void check_rows_cols_for_overflow(Index rows, Index cols) 30 bool error = (rows < 0 || cols < 0) ? true 31 : (rows == 0 || cols == 0) ? false 32 : (rows > max_index / cols); 120 EIGEN_STRONG_INLINE Index cols() const { return m_storage.cols(); } function in class:Eigen::PlainObjectBase 125 return m_storage.data()[col + row * m_storage.cols()]; 138 return m_storage.data()[col + row * m_storage.cols()]; 151 return m_storage.data()[col + row * m_storage.cols()]; 167 ? col + row * m_storage.cols() 270 resize(rows(), cols); local 349 conservativeResize(rows(), cols); local [all...] |
CommaInitializer.h | 41 : m_xpr(xpr), m_row(0), m_col(other.cols()), m_currentBlockRows(other.rows()) 43 m_xpr.block(0, 0, other.rows(), other.cols()) = other; 49 if (m_col==m_xpr.cols()) 57 eigen_assert(m_col<m_xpr.cols() 68 if (m_col==m_xpr.cols()) 76 eigen_assert(m_col<m_xpr.cols() 84 m_xpr.block(m_row, m_col, other.rows(), other.cols()) = other; 85 m_col += other.cols(); 92 && m_col == m_xpr.cols()
|
Random.h | 31 * The parameters \a rows and \a cols are the number of rows and of columns of 35 * it is redundant to pass \a rows and \a cols as arguments, so Random() should be used 49 DenseBase<Derived>::Random(Index rows, Index cols) 51 return NullaryExpr(rows, cols, internal::scalar_random_op<Scalar>()); 112 return *this = Random(rows(), cols()); 135 * \param cols the new number of columns 144 PlainObjectBase<Derived>::setRandom(Index rows, Index cols) 146 resize(rows, cols);
|
/external/eigen/Eigen/src/QR/ |
HouseholderQR.h | 76 HouseholderQR(Index rows, Index cols) 77 : m_qr(rows, cols), 78 m_hCoeffs((std::min)(rows,cols)), 79 m_temp(cols), 83 : m_qr(matrix.rows(), matrix.cols()), 84 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())), 85 m_temp(matrix.cols()), 163 inline Index cols() const { return m_qr.cols(); } function in class:Eigen::HouseholderQR 177 eigen_assert(m_qr.rows() == m_qr.cols() && "You can't take the determinant of a non-square matrix!") 199 Index cols = mat.cols(); local 239 Index cols = mat.cols(); local 288 const Index rows = dec().rows(), cols = dec().cols(); local 316 Index cols = matrix.cols(); local [all...] |
/external/valgrind/main/drd/tests/ |
matinv.c | 36 int cols; member in struct:gj_threadinfo 56 static elem_t* new_matrix(const int rows, const int cols) 59 assert(cols > 0); 60 return malloc(rows * cols * sizeof(elem_t)); 70 static void init_matrix(elem_t* const a, const int rows, const int cols) 77 a[i * cols + j] = 1.0 / (1 + abs(i-j)); 84 const elem_t* const a, const int rows, const int cols) 90 for (j = 0; j < cols; j++) 92 printf("%g ", a[i * cols + j]); 175 const int cols = p->cols local [all...] |
omp_matinv.c | 44 static elem_t* new_matrix(const int rows, const int cols) 47 assert(cols > 0); 48 return malloc(rows * cols * sizeof(elem_t)); 58 static void init_matrix(elem_t* const a, const int rows, const int cols) 65 a[i * cols + j] = 1.0 / (1 + abs(i-j)); 72 const elem_t* const a, const int rows, const int cols) 78 for (j = 0; j < cols; j++) 80 printf("%g ", a[i * cols + j]); 158 static void gj(elem_t* const a, const int rows, const int cols) 169 if (a[k * cols + i] > a[j * cols + i] [all...] |
/external/eigen/bench/ |
sparse_product.cpp | 53 // mkl_scscmm(&n, lhs.rows(), rhs.cols(), lhs.cols(), &alpha, matdescra, 56 // // mkl_somatcopy('C', 'T', lhs.rows(), lhs.cols(), 1, 101 int cols = SIZE; local 104 EigenSparseMatrix sm1(rows,cols), sm2(rows,cols), sm3(rows,cols), sm4(rows,cols); 111 fillMatrix2(nnzPerCol, rows, cols, sm1); 112 fillMatrix2(nnzPerCol, rows, cols, sm2) [all...] |
/external/libvpx/libvpx/vp8/common/ |
debugmodes.c | 16 void vp8_print_modes_and_motion_vectors(MODE_INFO *mi, int rows, int cols, int frame) 30 for (mb_col = 0; mb_col < cols; mb_col++) 49 for (mb_col = 0; mb_col < cols; mb_col++) 69 for (mb_col = 0; mb_col < cols; mb_col++) 94 for (b_col = 0; b_col < 4 * cols; b_col++) 96 mb_index = (b_row >> 2) * (cols + 1) + (b_col >> 2); 117 for (mb_col = 0; mb_col < cols; mb_col++) 142 for (b_col = 0; b_col < 4 * cols; b_col++) 144 mb_index = (b_row >> 2) * (cols + 1) + (b_col >> 2);
|
/external/eigen/Eigen/src/misc/ |
Kernel.h | 27 // is the number of cols of the original matrix 47 m_cols(m_rank==dec.cols() ? 1 : dec.cols() - m_rank) 50 inline Index rows() const { return m_dec.cols(); } 51 inline Index cols() const { return m_cols; } function in struct:Eigen::internal::kernel_retval_base 76 using Base::cols; \
|