HomeSort by relevance Sort by last modified time
    Searched full:cols (Results 126 - 150 of 1079) sorted by null

1 2 3 4 56 7 8 91011>>

  /external/eigen/Eigen/src/Core/products/
SelfadjointMatrixMatrix.h 22 void pack(Scalar* blockA, const const_blas_data_mapper<Scalar,Index,StorageOrder>& lhs, Index cols, Index i, Index& count)
42 for(Index k=i+BlockRows; k<cols; k++)
46 void operator()(Scalar* blockA, const Scalar* _lhs, Index lhsStride, Index cols, Index rows)
53 pack<Pack1>(blockA, lhs, cols, i, count);
58 pack<Pack2>(blockA, lhs, cols, peeled_mc, count);
70 for(Index k=i+1; k<cols; k++)
80 void operator()(Scalar* blockB, const Scalar* _rhs, Index rhsStride, Index rows, Index cols, Index k2)
85 Index packet_cols = (cols/nr)*nr;
166 for(Index j2=packet_cols; j2<cols; ++j2)
210 Index rows, Index cols,
    [all...]
  /external/eigen/Eigen/src/Core/
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;
53 const_cast<CommaInitializer&>(o).m_col = m_xpr.cols();
60 if (m_col==m_xpr.cols())
68 eigen_assert(m_col<m_xpr.cols()
79 if(other.cols()==0 || other.rows()==0)
81 if (m_col==m_xpr.cols())
89 eigen_assert(m_col<m_xpr.cols()
97 m_xpr.block(m_row, m_col, other.rows(), other.cols()) = other;
98 m_col += other.cols();
    [all...]
  /external/eigen/Eigen/src/SVD/
UpperBidiagonalization.h 56 : m_householder(matrix.rows(), matrix.cols()),
57 m_bidiagonal(matrix.cols(), matrix.cols()),
78 .setLength(m_householder.cols()-1)
92 Index cols = matrix.cols(); local
94 eigen_assert(rows >= cols && "UpperBidiagonalization is only for matrices satisfying rows>=cols.");
100 for (Index k = 0; /* breaks at k==cols-1 below */ ; ++k)
103 Index remainingCols = cols - k - 1
    [all...]
  /frameworks/base/docs/html/auto/
index.jd 30 .auto-img-container-cols {
35 .auto-img-frame-cols {
40 .auto-img-shot-cols {
62 .cols-leftp {
116 <div class="cols">
118 <div class="auto-img-container-cols">
119 <img class="auto-img-frame-cols" src="{@docRoot}auto/images/assets/00_frame.png" />
120 <img class="auto-img-shot-cols" src="{@docRoot}auto/images/assets/01_b_now.png" />
124 <div class="auto-img-container-cols">
125 <img class="auto-img-frame-cols" src="{@docRoot}auto/images/assets/00_frame.png" /
    [all...]
  /packages/apps/OMA-DM/DMService/src/com/android/omadm/service/
DMDatabaseTable.java 94 boolean rowValid(ArrayList<String> cols) {
95 for (String col : cols) {
113 ArrayList<String> cols = new ArrayList<String>(); local
122 cols.add(key);
126 if (rowValid(cols)) {
128 insertRow(db, cols, vals);
144 * @param cols list of columns
147 void insertRow(SQLiteDatabase db, ArrayList<String> cols, ArrayList<String> vals)
149 int numberColumns = cols.size();
153 throw new IllegalArgumentException("vals.size() != cols.size()")
    [all...]
  /external/ceres-solver/include/ceres/
crs_matrix.h 49 // rows, cols and values.
51 // rows is a num_rows + 1 sized array that points into the cols and
54 // cols[rows[i]] ... cols[rows[i + 1] - 1] are the indices of the
60 // cols and values contain as many entries as there are non-zeros in
74 // cols = [ 1, 3, 1, 2, 3, 0, 1]
77 vector<int> cols; member in struct:ceres::CRSMatrix
  /external/eigen/test/eigen2/
eigen2_adjoint.cpp 23 int cols = m.cols(); local
29 MatrixType m1 = MatrixType::Random(rows, cols),
30 m2 = MatrixType::Random(rows, cols),
31 m3(rows, cols),
32 mzero = MatrixType::Zero(rows, cols),
68 c = ei_random<int>(0, cols-1);
eigen2_eigensolver.cpp 23 int cols = m.cols(); local
33 MatrixType a = MatrixType::Random(rows,cols);
34 MatrixType a1 = MatrixType::Random(rows,cols);
37 MatrixType b = MatrixType::Random(rows,cols);
38 MatrixType b1 = MatrixType::Random(rows,cols);
106 int cols = m.cols(); local
116 MatrixType a = MatrixType::Random(rows,cols);
117 MatrixType a1 = MatrixType::Random(rows,cols);
    [all...]
gsl_helper.h 28 static Matrix createMatrix(int rows, int cols) { return gsl_matrix_alloc(rows,cols); }
63 static Matrix createMatrix(int rows, int cols) { return gsl_matrix_complex_alloc(rows,cols); }
100 res = gsl_matrix_alloc(m.rows(), m.cols());
102 for (int j=0 ; j<m.cols(); ++j)
111 for (int j=0 ; j<res.cols(); ++j)
135 res = gsl_matrix_complex_alloc(m.rows(), m.cols());
137 for (int j=0 ; j<m.cols(); ++j)
149 for (int j=0 ; j<res.cols(); ++j
    [all...]
  /external/eigen/Eigen/src/LU/
FullPivLU.h 80 FullPivLU(Index rows, Index cols);
315 return cols() - rank();
328 return rank() == cols();
353 return isInjective() && (m_lu.rows() == m_lu.cols());
366 eigen_assert(m_lu.rows() == m_lu.cols() && "You can't take the inverse of a non-square matrix!");
368 (*this, MatrixType::Identity(m_lu.rows(), m_lu.cols()));
374 inline Index cols() const { return m_lu.cols(); } function in class:Eigen::FullPivLU
394 FullPivLU<MatrixType>::FullPivLU(Index rows, Index cols)
395 : m_lu(rows, cols),
429 const Index cols = matrix.cols(); local
556 const Index cols = dec().matrixLU().cols(), dimker = cols - rank(); local
682 const Index rows = dec().rows(), cols = dec().cols(), local
    [all...]
  /external/eigen/test/
vectorwiseop.cpp 22 Index cols = m.cols(); local
24 c = internal::random<Index>(0, cols-1);
26 ArrayType m1 = ArrayType::Random(rows, cols),
27 m2(rows, cols),
28 m3(rows, cols);
31 RowVectorType rowvec = RowVectorType::Random(cols);
127 Index cols = m.cols(); local
129 c = internal::random<Index>(0, cols-1)
    [all...]
product_extra.cpp 22 Index cols = m.cols(); local
24 MatrixType m1 = MatrixType::Random(rows, cols),
25 m2 = MatrixType::Random(rows, cols),
26 m3(rows, cols),
27 mzero = MatrixType::Zero(rows, cols),
31 square2 = MatrixType::Random(cols, cols),
32 res2 = MatrixType::Random(cols, cols);
    [all...]
householder.cpp 22 Index cols = m.cols(); local
34 Matrix<Scalar, EIGEN_SIZE_MAX(MatrixType::RowsAtCompileTime,MatrixType::ColsAtCompileTime), 1> _tmp((std::max)(rows,cols));
52 MatrixType m1(rows, cols),
53 m2(rows, cols);
62 if(rows>=2) VERIFY_IS_MUCH_SMALLER_THAN(m1.block(1,0,rows-1,cols).norm(), m1.norm());
82 m1.setRandom(rows, cols);
83 HBlockMatrixType hbm = m1.block(shift,0,brows,cols);
86 m2.block(shift,0,brows,cols) = qr.matrixQR();
94 m5.block(shift,0,brows,cols).template triangularView<StrictlyLower>().setZero()
    [all...]
  /external/eigen/unsupported/Eigen/src/KroneckerProduct/
KroneckerTensorProduct.h 47 inline Index cols() const { return m_A.cols() * m_B.cols(); } function in class:Eigen::KroneckerProduct
51 return m_A.coeff(row / m_B.rows(), col / m_B.cols()) *
52 m_B.coeff(row % m_B.rows(), col % m_B.cols());
95 inline Index cols() const { return m_A.cols() * m_B.cols(); } function in class:Eigen::KroneckerProductSparse
117 Bc = m_B.cols();
119 for (Index j=0; j < m_A.cols(); ++j
    [all...]
  /external/opencv/cv/src/
cvtemplmatch.cpp 103 if( img->cols < templ->cols || img->rows < templ->rows )
108 corr->cols > img->cols + templ->cols - 1 )
112 blocksize.width = cvRound(templ->cols*block_scale);
113 blocksize.width = MAX( blocksize.width, min_block_size - templ->cols + 1 );
114 blocksize.width = MIN( blocksize.width, corr->cols );
119 dftsize.width = cvGetOptimalDFTSize(blocksize.width + templ->cols - 1);
127 blocksize.width = dftsize.width - templ->cols + 1
    [all...]
  /external/ceres-solver/internal/ceres/
triplet_sparse_matrix_test.cc 81 EXPECT_EQ(m.cols()[0], 1);
82 EXPECT_EQ(m.cols()[1], 4);
122 EXPECT_EQ(cpy.cols()[0], 1);
123 EXPECT_EQ(cpy.cols()[1], 4);
168 EXPECT_EQ(cpy.cols()[0], 1);
169 EXPECT_EQ(cpy.cols()[1], 4);
221 EXPECT_EQ(m.cols()[0], 1);
222 EXPECT_EQ(m.cols()[1], 4);
223 EXPECT_EQ(m.cols()[2], 1);
224 EXPECT_EQ(m.cols()[3], 4)
    [all...]
block_sparse_matrix.cc 57 for (int i = 0; i < block_structure_->cols.size(); ++i) {
58 num_cols_ += block_structure_->cols[i].size;
70 int col_block_size = block_structure_->cols[col_block_id].size;
98 int col_block_size = block_structure_->cols[col_block_id].size;
99 int col_block_pos = block_structure_->cols[col_block_id].position;
118 int col_block_size = block_structure_->cols[col_block_id].size;
119 int col_block_pos = block_structure_->cols[col_block_id].position;
136 int col_block_size = block_structure_->cols[col_block_id].size;
137 int col_block_pos = block_structure_->cols[col_block_id].position;
153 int col_block_size = block_structure_->cols[col_block_id].size
    [all...]
program_test.cc 273 int* cols = expected_block_sparse_jacobian.mutable_cols(); local
276 cols[0] = 0;
279 cols[1] = 1;
281 cols[2] = 1;
284 cols[3] = 2;
286 cols[4] = 2;
289 cols[5] = 3;
291 cols[6] = 3;
294 cols[7] = 4;
296 cols[8] = 4
370 int* cols = expected_block_sparse_jacobian.mutable_cols(); local
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseSparseProductWithPruning.h 29 Index cols = rhs.outerSize(); local
46 res.resize(cols, rows);
48 res.resize(rows, cols);
51 double ratioColRes = double(estimated_nnz_prod)/double(lhs.rows()*rhs.cols());
52 for (Index j=0; j<cols; ++j)
55 //double ratioColRes = (double(rhs.innerVector(j).nonZeros()) + double(lhs.nonZeros())/double(lhs.cols()))/double(lhs.rows());
90 typename remove_all<ResultType>::type _res(res.rows(), res.cols());
104 SparseTemporaryType _res(res.rows(), res.cols());
117 typename remove_all<ResultType>::type _res(res.rows(), res.cols());
137 // SparseTemporaryType _res(res.cols(), res.rows())
    [all...]
  /external/eigen/bench/
benchEigenSolver.cpp 37 int cols = m.cols(); local
45 MatrixType a = MatrixType::Random(rows,cols);
52 int c = internal::random<int>(0,covMat.cols()-1);
95 gmm::dense_matrix<Scalar> gmmCovMat(covMat.rows(),covMat.cols());
96 gmm::dense_matrix<Scalar> eigvect(covMat.rows(),covMat.cols());
133 gsl_matrix* gslCovMat = gsl_matrix_alloc(covMat.rows(),covMat.cols());
134 gsl_matrix* gslCopy = gsl_matrix_alloc(covMat.rows(),covMat.cols());
135 gsl_matrix* eigvect = gsl_matrix_alloc(covMat.rows(),covMat.cols());
139 gsl_matrix_complex* eigvectz = gsl_matrix_complex_alloc(covMat.rows(),covMat.cols());
    [all...]
  /external/eigen/unsupported/Eigen/src/Skyline/
SkylineMatrixBase.h 38 * \sa MatrixBase::rows(), MatrixBase::cols(), ColsAtCompileTime, SizeAtCompileTime */
44 * \sa MatrixBase::rows(), MatrixBase::cols(), RowsAtCompileTime, SizeAtCompileTime */
104 /** \returns the number of rows. \sa cols(), RowsAtCompileTime */
110 inline Index cols() const { function in class:Eigen::SkylineMatrixBase
111 return derived().cols();
114 /** \returns the number of coefficients, which is \a rows()*cols().
115 * \sa rows(), cols(), SizeAtCompileTime. */
117 return rows() * cols();
129 return (int(Flags) & RowMajorBit) ? this->rows() : this->cols();
133 * i.e., the number of rows for a columns major matrix, and the number of cols otherwise *
    [all...]
  /external/eigen/unsupported/test/
svd_common.h 31 Index cols = m.cols(); local
42 MatrixType sigma = MatrixType::Zero(rows, cols);
61 Index cols = m.cols(); local
62 Index diagSize = (std::min)(rows, cols);
85 Index cols = m.cols(); local
95 RhsType rhs = RhsType::Random(rows, internal::random<Index>(1, cols));
133 Index diagSize = (std::min)(m.rows(), m.cols());
145 Index cols = m.cols(); local
    [all...]
  /external/eigen/unsupported/Eigen/src/SVD/
JacobiSVD.h 79 if (svd.rows() != m_qr.rows() || svd.cols() != m_qr.cols())
82 ::new (&m_qr) QRType(svd.rows(), svd.cols());
89 if(matrix.rows() > matrix.cols())
92 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.cols(),matrix.cols()).template triangularView<Upper>();
124 if (svd.cols() != m_qr.rows() || svd.rows() != m_qr.cols())
127 ::new (&m_qr) QRType(svd.cols(), svd.rows());
129 m_adjoint.resize(svd.cols(), svd.rows())
    [all...]
  /external/eigen/Eigen/src/QR/
FullPivHouseholderQR.h 94 FullPivHouseholderQR(Index rows, Index cols)
95 : m_qr(rows, cols),
96 m_hCoeffs((std::min)(rows,cols)),
97 m_rows_transpositions((std::min)(rows,cols)),
98 m_cols_transpositions((std::min)(rows,cols)),
99 m_cols_permutation(cols),
100 m_temp(cols),
110 * FullPivHouseholderQR<MatrixType> qr(matrix.rows(), matrix.cols());
117 : m_qr(matrix.rows(), matrix.cols()),
118 m_hCoeffs((std::min)(matrix.rows(), matrix.cols())),
293 inline Index cols() const { return m_qr.cols(); } function in class:Eigen::FullPivHouseholderQR
412 Index cols = matrix.cols(); local
498 const Index rows = dec().rows(), cols = dec().cols(); local
571 const Index cols = m_qr.cols(); local
584 Index cols() const { return m_qr.rows(); } function in struct:Eigen::internal::FullPivHouseholderQRMatrixQReturnType
    [all...]
  /external/opencv/ml/src/
mlann_mlp.cpp 180 for( i = 1; i < layer_sizes->cols; i++ )
198 if( i < layer_sizes->cols - 1 )
223 _layer_sizes->cols != 1 && _layer_sizes->rows != 1 ||
230 l_count = _layer_sizes->rows + _layer_sizes->cols - 1;
286 if( _inputs->cols != layer_sizes->data.i[0] )
290 if( _outputs->cols != layer_sizes->data.i[layer_sizes->cols - 1] )
305 l_count = layer_sizes->cols;
313 cvInitMatHeader( layer_out, dn, layer_in->cols, CV_64F, buf );
321 int cols = layer_sizes->data.i[j] local
343 int i, j, cols = _src->cols; local
371 int i, j, cols = _src->cols; local
399 int i, j, n = sums->rows, cols = sums->cols; local
479 int i, j, n = _xf->rows, cols = _xf->cols; local
    [all...]

Completed in 841 milliseconds

1 2 3 4 56 7 8 91011>>