/external/eigen/test/eigen2/ |
eigen2_swap.cpp | 32 int cols = m.cols(); local 35 MatrixType m1 = MatrixType::Random(rows,cols); 36 MatrixType m2 = MatrixType::Random(rows,cols) + Scalar(100) * MatrixType::Identity(rows,cols); 37 OtherMatrixType m3 = OtherMatrixType::Random(rows,cols) + Scalar(200) * OtherMatrixType::Identity(rows,cols); 58 m1.swap(m2.block(0,0,rows,cols));
|
product.h | 37 int cols = m.cols(); local 41 MatrixType m1 = MatrixType::Random(rows, cols), 42 m2 = MatrixType::Random(rows, cols), 43 m3(rows, cols), 44 mzero = MatrixType::Zero(rows, cols); 50 square2 = ColSquareMatrixType::Random(cols, cols), 51 res2 = ColSquareMatrixType::Random(cols, cols); [all...] |
eigen2_basicstuff.cpp | 18 int cols = m.cols(); local 22 MatrixType m1 = MatrixType::Random(rows, cols), 23 m2 = MatrixType::Random(rows, cols), 24 m3(rows, cols), 25 mzero = MatrixType::Zero(rows, cols), 36 c = ei_random<int>(0, cols-1); 68 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows,cols)(r,c), static_cast<Scalar>(1)); 78 if(cols!=1 && rows!=1 && MatrixType::SizeAtCompileTime!=Dynamic) 80 VERIFY_RAISES_ASSERT(m1 = (m2.block(0,0, rows-1, cols-1))) [all...] |
eigen2_linearstructure.cpp | 22 int cols = m.cols(); local 26 MatrixType m1 = MatrixType::Random(rows, cols), 27 m2 = MatrixType::Random(rows, cols), 28 m3(rows, cols), 29 mzero = MatrixType::Zero(rows, cols); 35 c = ei_random<int>(0, cols-1); 66 VERIFY_IS_APPROX(m1+m1.block(0,0,rows,cols), m1+m1); 67 VERIFY_IS_APPROX(m1.cwise() * m1.block(0,0,rows,cols), m1.cwise() * m1); 68 VERIFY_IS_APPROX(m1 - m1.block(0,0,rows,cols), m1 - m1) [all...] |
eigen2_sum.cpp | 17 int cols = m.cols(); local 19 MatrixType m1 = MatrixType::Random(rows, cols); 21 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows, cols).sum(), Scalar(1)); 22 VERIFY_IS_APPROX(MatrixType::Ones(rows, cols).sum(), Scalar(float(rows*cols))); // the float() here to shut up excessive MSVC warning about int->complex conversion being lossy 24 for(int i = 0; i < rows; i++) for(int j = 0; j < cols; j++) x += m1(i,j);
|
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/ |
swap.cpp | 32 typename MatrixType::Index cols = m.cols(); local 35 MatrixType m1 = MatrixType::Random(rows,cols); 36 MatrixType m2 = MatrixType::Random(rows,cols) + Scalar(100) * MatrixType::Identity(rows,cols); 37 OtherMatrixType m3 = OtherMatrixType::Random(rows,cols) + Scalar(200) * OtherMatrixType::Identity(rows,cols); 58 m1.swap(m2.block(0,0,rows,cols));
|
array_reverse.cpp | 23 Index cols = m.cols(); local 27 MatrixType m1 = MatrixType::Random(rows, cols); 33 for ( int j = 0; j < cols; j++ ) { 34 VERIFY_IS_APPROX(m1_r(i, j), m1(rows - 1 - i, cols - 1 - j)); 41 for ( int j = 0; j < cols; j++ ) { 42 VERIFY_IS_APPROX(m1_rd(i, j), m1(rows - 1 - i, cols - 1 - j)); 49 for ( int j = 0; j < cols; j++ ) { 50 VERIFY_IS_APPROX(m1_rb(i, j), m1(rows - 1 - i, cols - 1 - j)); 57 for ( int j = 0; j < cols; j++ ) [all...] |
linearstructure.cpp | 21 Index cols = m.cols(); local 25 MatrixType m1 = MatrixType::Random(rows, cols), 26 m2 = MatrixType::Random(rows, cols), 27 m3(rows, cols); 33 c = internal::random<Index>(0, cols-1); 64 VERIFY_IS_APPROX(m1+m1.block(0,0,rows,cols), m1+m1); 65 VERIFY_IS_APPROX(m1.cwiseProduct(m1.block(0,0,rows,cols)), m1.cwiseProduct(m1)); 66 VERIFY_IS_APPROX(m1 - m1.block(0,0,rows,cols), m1 - m1); 67 VERIFY_IS_APPROX(m1.block(0,0,rows,cols) * s1, m1 * s1) [all...] |
product_trsolve.cpp | 30 template<typename Scalar,int Size, int Cols> void trsolve(int size=Size,int cols=Cols) 38 rowmajor = Cols==1 ? ColMajor : RowMajor }; 39 Matrix<Scalar,Size,Cols,colmajor> cmRhs(size,cols); 40 Matrix<Scalar,Size,Cols,rowmajor> rmRhs(size,cols); 41 Matrix<Scalar,Dynamic,Dynamic,colmajor> ref(size,cols); 71 int c = internal::random<int>(0,cols-1) [all...] |
miscmatrices.cpp | 22 Index cols = m.cols(); local 24 Index r = internal::random<Index>(0, rows-1), r2 = internal::random<Index>(0, rows-1), c = internal::random<Index>(0, cols-1); 25 VERIFY_IS_APPROX(MatrixType::Ones(rows,cols)(r,c), static_cast<Scalar>(1)); 26 MatrixType m1 = MatrixType::Ones(rows,cols);
|
sizeoverflow.cpp | 24 void triggerMatrixBadAlloc(Index rows, Index cols) 26 VERIFY_THROWS_BADALLOC( MatrixType m(rows, cols) ); 27 VERIFY_THROWS_BADALLOC( MatrixType m; m.resize(rows, cols) ); 28 VERIFY_THROWS_BADALLOC( MatrixType m; m.conservativeResize(rows, cols) ); 41 // there are 2 levels of overflow checking. first in PlainObjectBase.h we check for overflow in rows*cols computations.
|
triangular.cpp | 23 typename MatrixType::Index cols = m.cols(); local 25 MatrixType m1 = MatrixType::Random(rows, cols), 26 m2 = MatrixType::Random(rows, cols), 27 m3(rows, cols), 28 m4(rows, cols), 29 r1(rows, cols), 30 r2(rows, cols); 36 if (rows*cols>1) 66 m1 = MatrixType::Random(rows, cols); 131 Index cols = m.cols(); local [all...] |
/external/eigen/bench/ |
sparse_randomsetter.cpp | 48 int cols = sm1.cols(); local 54 (*set1)(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1)) += 1; 68 int cols = SIZE; local 71 EigenSparseMatrix sm1(rows,cols), sm2(rows,cols); 74 nentries = rows*cols*density; 81 dummy = internal::random<int>(0,rows-1) + internal::random<int>(0,cols-1); 97 // set1(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1)) += 1; 106 // set1(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1)) += 1 [all...] |
basicbenchmark.h | 44 const int cols = mat.cols(); local 46 MatrixType I(rows,cols); 47 MatrixType m(rows,cols);
|
sparse_trisolver.cpp | 40 void fillMatrix(float density, int rows, int cols, EigenSparseTriMatrix& dst) 42 dst.startFill(rows*cols*density); 43 for(int j = 0; j < cols; j++) 59 int cols = SIZE; local 63 EigenSparseTriMatrix sm1(rows,cols); 65 DenseVector b = DenseVector::Random(cols); 66 DenseVector x = DenseVector::Random(cols); 72 EigenSparseTriMatrix sm1(rows, cols); 73 fillMatrix(density, rows, cols, sm1); 81 DenseMatrix m1(rows,cols); [all...] |
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...] |
sparse_cholesky.cpp | 44 void fillSpdMatrix(float density, int rows, int cols, EigenSparseSelfAdjointMatrix& dst) 46 dst.startFill(rows*cols*density); 47 for(int j = 0; j < cols; j++) 80 int cols = SIZE; local 84 VectorXf b = VectorXf::Random(cols); 85 VectorXf x = VectorXf::Random(cols); 92 EigenSparseSelfAdjointMatrix sm1(rows, cols); 94 fillSpdMatrix(density, rows, cols, sm1); 103 DenseMatrix m1(rows,cols); 117 for (int j=0; j<cols; ++j [all...] |
/external/e2fsprogs/ext2ed/ |
win.c | 45 wmove (title_win,TITLE_WIN_LINES/2,(COLS-strlen (title_string))/2); 56 show_pad_info.display_cols=COLS; 75 title_win=newwin (TITLE_WIN_LINES,COLS,0,0); 76 show_win=newwin (SHOW_WIN_LINES,COLS,TITLE_WIN_LINES,0); 78 mt_win1=newwin (1,COLS,TITLE_WIN_LINES+SHOW_WIN_LINES,0); 79 mt_win2=newwin (1,COLS,LINES-COMMAND_WIN_LINES-1,0); 80 command_win=newwin (COMMAND_WIN_LINES,COLS,LINES-COMMAND_WIN_LINES,0); 114 wmove (show_win,2,COLS-18); 117 wmove (show_win,2,COLS-18); 203 if ((ws.ws_row != LINES) || (ws.ws_col != COLS)) { [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/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/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/chromium_org/third_party/sqlite/src/test/ |
bindxfer.test | 20 proc sqlite_step {stmt VALS COLS} { 22 upvar #0 $COLS cols 24 set cols [list] 28 lappend cols [sqlite3_column_name $stmt $i]
|