HomeSort by relevance Sort by last modified time
    Searched full:rows (Results 76 - 100 of 3134) sorted by null

1 2 34 5 6 7 8 91011>>

  /external/chromium-trace/trace-viewer/src/tracing/analysis/
stub_analysis_results.js 17 rows: []
31 table.rows.push({label: label,
36 table.rows.push({spacing: true});
40 table.rows.push({label: label,
46 table.rows.push({label: label,
  /external/eigen/blas/
GeneralRank1Update.h 22 static void run(Index rows, Index cols, Scalar* mat, Index stride, const Scalar* u, const Scalar* v, Scalar alpha)
29 Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i,rows) += alpha * cj(v[i]) * ConjRhsType(OtherMap(u,rows));
36 static void run(Index rows, Index cols, Scalar* mat, Index stride, const Scalar* u, const Scalar* v, Scalar alpha)
38 general_rank1_update<Scalar,Index,ColMajor,ConjRhs,ConjRhs>::run(rows,cols,mat,stride,u,v,alpha);
  /external/eigen/test/eigen2/
eigen2_triangular.cpp 20 int rows = m.rows(); local
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols),
25 m3(rows, cols),
26 m4(rows, cols),
27 r1(rows, cols),
28 r2(rows, cols),
29 mzero = MatrixType::Zero(rows, cols),
30 mones = MatrixType::Ones(rows, cols)
    [all...]
eigen2_cholesky.cpp 24 int rows = m.rows(); local
32 MatrixType a0 = MatrixType::Random(rows,cols);
33 VectorType vecB = VectorType::Random(rows), vecX(rows);
34 MatrixType matB = MatrixType::Random(rows,cols), matX(rows,cols);
37 MatrixType a1 = MatrixType::Random(rows,cols);
52 VectorType vecX(rows), _vecX, _vecB;
91 if (rows>4
    [all...]
eigen2_swap.cpp 31 int rows = m.rows(); 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));
eigen2_linearstructure.cpp 21 int rows = m.rows(); local
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2 = MatrixType::Random(rows, cols),
28 m3(rows, cols),
29 mzero = MatrixType::Zero(rows, cols);
34 int r = ei_random<int>(0, rows-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...]
  /external/eigen/test/
lu.cpp 21 Index rows, cols, cols2; local
24 rows = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE);
28 rows = MatrixType::RowsAtCompileTime;
51 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
54 VERIFY((MatrixType::Zero(rows,cols).fullPivLu().image(MatrixType::Zero(rows,cols)).cols() == 1));
56 MatrixType m1(rows, cols), m3(rows, cols2);
58 createRandomPIMatrixOfRank(rank, rows, cols, m1);
68 MatrixType u(rows,cols)
133 Index rows = internal::random<Index>(1,4); local
    [all...]
bandmatrix.cpp 19 Index rows = _m.rows(); local
24 MatrixType m(rows,cols,supers,subs);
26 DenseMatrixType dm1(rows,cols);
49 Index d = (std::min)(rows,cols);
51 Index b = std::max<Index>(0,rows-d-subs);
52 if(a>0) dm1.block(0,d+supers,rows,a).setZero();
54 dm1.block(subs+1,0,rows-subs-1-b,rows-subs-1-b).template triangularView<Lower>().setZero();
68 Index rows = internal::random<Index>(1,10) local
    [all...]
cwiseop.cpp 72 Index rows = m.rows(); local
75 MatrixType m1 = MatrixType::Random(rows, cols),
77 m2 = MatrixType::Random(rows, cols),
78 m3(rows, cols),
79 m4(rows, cols),
80 mzero = MatrixType::Zero(rows, cols),
81 mones = MatrixType::Ones(rows, cols),
83 ::Identity(rows, rows);
    [all...]
eigensolver_generalized_real.cpp 20 Index rows = m.rows(); local
26 MatrixType a = MatrixType::Random(rows,cols);
27 MatrixType b = MatrixType::Random(rows,cols);
28 MatrixType a1 = MatrixType::Random(rows,cols);
29 MatrixType b1 = MatrixType::Random(rows,cols);
eigen2support.cpp 19 Index rows = m.rows(); local
22 MatrixType m1 = MatrixType::Random(rows, cols),
23 m3(rows, cols);
30 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
31 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
43 VERIFY_IS_EQUAL((m1.col(0).end(1)), (m1.col(0).segment(rows-1,1)));
44 VERIFY_IS_EQUAL((m1.col(0).template end<1>()), (m1.col(0).segment(rows-1,1)));
swap.cpp 31 typename MatrixType::Index rows = m.rows(); 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));
triangular.cpp 22 typename MatrixType::Index rows = m.rows(); 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);
31 VectorType v2 = VectorType::Random(rows);
36 if (rows*cols>1
127 Index rows = m.rows(); local
    [all...]
  /external/chromium_org/third_party/libvpx/source/libvpx/third_party/libyuv/source/
convert_jpeg.cc 37 int rows) {
45 dest->w, rows);
46 dest->y += rows * dest->y_stride;
47 dest->u += ((rows + 1) >> 1) * dest->u_stride;
48 dest->v += ((rows + 1) >> 1) * dest->v_stride;
49 dest->h -= rows;
55 int rows) {
63 dest->w, rows);
64 dest->y += rows * dest->y_stride;
65 dest->u += ((rows + 1) >> 1) * dest->u_stride
    [all...]
  /external/chromium_org/third_party/libyuv/source/
convert_jpeg.cc 37 int rows) {
45 dest->w, rows);
46 dest->y += rows * dest->y_stride;
47 dest->u += ((rows + 1) >> 1) * dest->u_stride;
48 dest->v += ((rows + 1) >> 1) * dest->v_stride;
49 dest->h -= rows;
55 int rows) {
63 dest->w, rows);
64 dest->y += rows * dest->y_stride;
65 dest->u += ((rows + 1) >> 1) * dest->u_stride
    [all...]
  /external/eigen/bench/
benchEigenSolver.cpp 36 int rows = m.rows(); local
39 int stdRepeats = std::max(1,int((REPEAT*1000)/(rows*rows*sqrt(rows))));
45 MatrixType a = MatrixType::Random(rows,cols);
51 int r = internal::random<int>(0,covMat.rows()-1);
85 std::cout << covMat.rows() << " \t"
95 gmm::dense_matrix<Scalar> gmmCovMat(covMat.rows(),covMat.cols());
96 gmm::dense_matrix<Scalar> eigvect(covMat.rows(),covMat.cols())
    [all...]
benchCholesky.cpp 31 int rows = m.rows(); local
35 for (int j=0; j<rows; ++j)
37 int r = std::max(rows - j -1,0);
41 int repeats = (REPEAT*1000)/(rows*rows);
46 MatrixType a = MatrixType::Random(rows,cols);
52 int r = internal::random<int>(0,covMat.rows()-1);
80 std::cout << covMat.rows() << " \t"
92 gsl_matrix* gslCovMat = gsl_matrix_alloc(covMat.rows(),covMat.cols())
    [all...]
sparse_randomsetter.cpp 47 int rows = sm1.rows(); local
54 (*set1)(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1)) += 1;
67 int rows = 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...]
  /external/eigen/doc/examples/
Tutorial_simple_example_dynamic_size.cpp 12 for (int i=0; i<m.rows(); ++i) // loop over rows
13 m(i,j) = i+j*m.rows(); // to access matrix coefficients,
tut_matrix_resize.cpp 11 << m.rows() << "x" << m.cols() << std::endl;
17 << v.rows() << "x" << v.cols() << std::endl;
  /external/chromium_org/ui/views/controls/table/
table_grouper.h 17 // TableGrouper is used by TableView to group a set of rows and treat them
18 // as one. Rows that fall in the same group are selected together and sorted
  /external/ceres-solver/internal/ceres/
dense_sparse_matrix.cc 68 const int *rows = m.rows(); local
73 m_(rows[i], cols[i]) += values[i];
112 m_.resize(m_.rows() + m_.cols(), m_.cols());
114 m_.block(0, 0, tmp.rows(), tmp.cols()) = tmp;
131 return m_.rows() - m_.cols();
133 return m_.rows();
142 return (m_.rows() - m_.cols()) * m_.cols();
144 return m_.rows() * m_.cols();
151 ? m_.rows() - m_.cols(
    [all...]
block_sparse_matrix.cc 61 // Count the number of non-zero entries and the number of rows in
63 for (int i = 0; i < block_structure_->rows.size(); ++i) {
64 int row_block_size = block_structure_->rows[i].block.size;
67 const vector<Cell>& cells = block_structure_->rows[i].cells;
92 for (int i = 0; i < block_structure_->rows.size(); ++i) {
93 int row_block_pos = block_structure_->rows[i].block.position;
94 int row_block_size = block_structure_->rows[i].block.size;
95 const vector<Cell>& cells = block_structure_->rows[i].cells;
112 for (int i = 0; i < block_structure_->rows.size(); ++i) {
113 int row_block_pos = block_structure_->rows[i].block.position
    [all...]
  /packages/inputmethods/LatinIME/tests/src/com/android/inputmethod/keyboard/layout/expected/
ActualKeyboardBuilder.java 31 * An actual keyboard is an array of rows, and a row consists of an array of {@link Key}s.
47 * Create the keyboard that consists of the array of rows of the actual keyboard's keys.
50 * @return the actual keyboard grouped with rows.
53 // Filter out spacer to prepare to create rows.
56 // Grouping keys into rows.
57 final ArrayList<ArrayList<Key>> rows = new ArrayList<>(); local
64 rows.add(elements);
69 rows.add(elements); // Add the last row.
71 // Calculate each dimension of rows and create a builder.
72 final int[] dimensions = new int[rows.size()]
    [all...]
  /external/eigen/Eigen/src/Core/
PlainObjectBase.h 38 static EIGEN_ALWAYS_INLINE void run(Index rows, Index cols)
43 bool error = (rows == 0 || cols == 0) ? false
44 : (rows > max_index / cols);
135 EIGEN_STRONG_INLINE Index rows() const { return m_storage.rows(); } function in class:Eigen::PlainObjectBase
143 return m_storage.data()[rowId + colId * m_storage.rows()];
156 return m_storage.data()[rowId + colId * m_storage.rows()];
169 return m_storage.data()[rowId + colId * m_storage.rows()];
184 : rowId + colId * m_storage.rows()));
201 : rowId + colId * m_storage.rows()), val)
    [all...]

Completed in 709 milliseconds

1 2 34 5 6 7 8 91011>>