HomeSort by relevance Sort by last modified time
    Searched refs:cols (Results 226 - 250 of 787) sorted by null

1 2 3 4 5 6 7 8 91011>>

  /external/eigen/test/
product_syrk.cpp 22 Index cols = m.cols(); local
24 MatrixType m1 = MatrixType::Random(rows, cols),
25 m2 = MatrixType::Random(rows, cols),
26 m3 = MatrixType::Random(rows, cols);
27 RMatrixType rm2 = MatrixType::Random(rows, cols);
29 Rhs1 rhs1 = Rhs1::Random(internal::random<int>(1,320), cols); Rhs1 rhs11 = Rhs1::Random(rhs1.rows(), cols);
30 Rhs2 rhs2 = Rhs2::Random(rows, internal::random<int>(1,320)); Rhs2 rhs22 = Rhs2::Random(rows, rhs2.cols());
35 Index c = internal::random<Index>(0,cols-1)
    [all...]
eigensolver_selfadjoint.cpp 22 Index cols = m.cols(); local
29 MatrixType a = MatrixType::Random(rows,cols);
30 MatrixType a1 = MatrixType::Random(rows,cols);
34 MatrixType b = MatrixType::Random(rows,cols);
35 MatrixType b1 = MatrixType::Random(rows,cols);
82 MatrixType id = MatrixType::Identity(rows, cols);
mapstride.cpp 56 Index rows = _m.rows(), cols = _m.cols(); local
58 MatrixType m = MatrixType::Random(rows,cols);
60 Index arraysize = 2*(rows+4)*(cols+4);
69 Map<MatrixType, Alignment, OuterStride<Dynamic> > map(array, rows, cols, OuterStride<Dynamic>(m.innerSize()+1));
88 map(array, rows, cols, OuterStride<OuterStrideAtCompileTime>(m.innerSize()+4));
101 Map<MatrixType, Alignment, Stride<Dynamic,Dynamic> > map(array, rows, cols, Stride<Dynamic,Dynamic>(2*m.innerSize()+1, 2));
qr_fullpivoting.cpp 18 Index rows = internal::random<Index>(20,200), cols = internal::random<int>(20,200), cols2 = internal::random<int>(20,200); local
19 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
24 createRandomPIMatrixOfRank(rank,rows,cols,m1);
27 VERIFY(cols - qr.rank() == qr.dimensionOfKernel());
38 for(int i = 0; i < rows; i++) for(int j = 0; j < cols; j++) if(i>j) r(i,j) = Scalar(0);
44 MatrixType m2 = MatrixType::Random(cols,cols2);
46 m2 = MatrixType::Random(cols,cols2);
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);
64 //Index rows, Index cols, Index nnz, Index* outerIndexPtr, Index* innerIndexPtr, Scalar* valuePtr
65 MappedSparseMatrix<Scalar> mm2(rows, cols, cm2.nonZeros(), cm2.outerIndexPtr(), cm2.innerIndexPtr(), cm2.valuePtr());
  /external/eigen/unsupported/Eigen/src/SparseExtra/
DynamicSparseMatrix.h 81 inline Index cols() const { return IsRowMajor ? m_innerSize : outerSize(); } function in class:Eigen::DynamicSparseMatrix
197 void resize(Index rows, Index cols)
199 const Index outerSize = IsRowMajor ? rows : cols;
200 m_innerSize = IsRowMajor ? cols : rows;
208 void resizeAndKeepData(Index rows, Index cols)
210 const Index outerSize = IsRowMajor ? rows : cols;
211 const Index innerSize = IsRowMajor ? cols : rows;
233 EIGEN_DEPRECATED inline DynamicSparseMatrix(Index rows, Index cols)
236 resize(rows, cols);
269 resize(other.rows(), other.cols());
    [all...]
  /external/libvterm/src/
vterm.c 30 VTerm *vterm_new(int rows, int cols)
32 return vterm_new_with_allocator(rows, cols, &default_allocator, NULL);
35 VTerm *vterm_new_with_allocator(int rows, int cols, VTermAllocatorFunctions *funcs, void *allocdata)
44 vt->cols = cols;
88 *colsp = vt->cols;
91 void vterm_set_size(VTerm *vt, int rows, int cols)
94 vt->cols = cols;
97 (*vt->parser_callbacks->resize)(rows, cols, vt->cbdata)
    [all...]
screen.c 54 int cols; member in struct:VTermScreen
73 if(col < 0 || col >= screen->cols)
75 return screen->buffer + (screen->cols * row) + col;
86 if(buffer && row < screen->rows && col < screen->cols)
87 *new_cell = buffer[row * screen->cols + col];
164 .end_col = screen->cols,
209 dest.end_col == screen->cols && // full width
213 for(pos.col = 0; pos.col < screen->cols; pos.col++)
216 (screen->callbacks->sb_pushline)(screen->cols, screen->sb_buffer, screen->cbdata);
220 int cols = src.end_col - src.start_col local
590 int rows, cols; local
785 int rows, cols; local
    [all...]
  /external/skia/src/images/
bmpdecoderhelper.cpp 41 int cols = 0; local
56 cols = GetInt();
78 if (cols < 0 || cols > 256) {
82 if (cols == 0 && bpp_ <= 8) {
83 cols = 1 << bpp_;
85 if (bpp_ <= 8 || cols > 0) {
90 if (cols > 0) {
91 if (pos_ + (cols * colLen) > len_) {
94 for (int i = 0; i < cols; ++i)
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseMatrixBase.h 54 * \sa MatrixBase::rows(), MatrixBase::cols(), ColsAtCompileTime, SizeAtCompileTime */
60 * \sa MatrixBase::rows(), MatrixBase::cols(), RowsAtCompileTime, SizeAtCompileTime */
149 /** \returns the number of rows. \sa cols() */
152 inline Index cols() const { return derived().cols(); } function in class:Eigen::SparseMatrixBase
153 /** \returns the number of coefficients, which is \a rows()*cols().
154 * \sa rows(), cols(). */
155 inline Index size() const { return rows() * cols(); }
161 * \code rows()==1 || cols()==1 \endcode
162 * \sa rows(), cols(), IsVectorAtCompileTime. *
    [all...]
  /external/opencv/cv/src/
cvundistort.cpp 150 if( !CV_IS_MAT(A) || A->rows != 3 || A->cols != 3 ||
154 if( !CV_IS_MAT(dist_coeffs) || (dist_coeffs->rows != 1 && dist_coeffs->cols != 1) ||
155 (dist_coeffs->rows*dist_coeffs->cols*CV_MAT_CN(dist_coeffs->type) != 4 &&
156 dist_coeffs->rows*dist_coeffs->cols*CV_MAT_CN(dist_coeffs->type) != 5) ||
163 _k = cvMat( dist_coeffs->rows, dist_coeffs->cols,
213 if( !CV_IS_MAT(A) || A->rows != 3 || A->cols != 3 ||
217 if( !CV_IS_MAT(dist_coeffs) || (dist_coeffs->rows != 1 && dist_coeffs->cols != 1) ||
218 (dist_coeffs->rows*dist_coeffs->cols*CV_MAT_CN(dist_coeffs->type) != 4 &&
219 dist_coeffs->rows*dist_coeffs->cols*CV_MAT_CN(dist_coeffs->type) != 5) ||
226 _k = cvMat( dist_coeffs->rows, dist_coeffs->cols,
    [all...]
  /external/ceres-solver/internal/ceres/
covariance_impl.cc 140 const int* cols = covariance_matrix_->cols(); local
142 const int* cols_begin = cols + rows[row_begin];
323 int* cols = covariance_matrix_->mutable_cols(); local
367 cols[cursor++] = col_begin++;
425 transpose_rows[jacobian.cols[idx] + 1] += 1;
434 const int c = jacobian.cols[idx];
510 const int* cols = covariance_matrix_->cols(); local
548 const int c = cols[idx]
642 const int* cols = covariance_matrix_->cols(); local
694 const int* cols = covariance_matrix_->cols(); local
    [all...]
incomplete_lq_factorization.cc 70 const int* a_cols = a.cols();
74 const int* b_cols = b.cols();
120 int* cols = matrix->mutable_cols(); local
154 cols[num_nonzeros] = entry.first;
173 const int* cols = matrix.cols(); local
212 q_i(cols[idx]) = values[idx];
block_random_access_sparse_matrix.cc 82 int* cols = tsm_->mutable_cols(); local
109 cols[pos] = col_layout[col_block_id] + c;
112 DCHECK_LT(cols[pos], tsm_->num_rows());
  /external/chromium_org/third_party/libvpx/source/libvpx/examples/
set_maps.c 71 roi.cols = (cfg->g_w + 15) / 16;
88 roi.roi_map = (uint8_t *)malloc(roi.rows * roi.cols);
89 for (i = 0; i < roi.rows * roi.cols; ++i)
104 map.cols = (cfg->g_w + 15) / 16;
106 map.active_map = (uint8_t *)malloc(map.rows * map.cols);
107 for (i = 0; i < map.rows * map.cols; ++i)
121 map.cols = (cfg->g_w + 15) / 16;
  /external/eigen/Eigen/src/Core/
Reverse.h 103 inline Index cols() const { return m_matrix.cols(); } function in class:Eigen::Reverse
112 eigen_assert(row >= 0 && row < rows() && col >= 0 && col < cols());
119 ReverseCol ? m_matrix.cols() - col - 1 : col);
125 ReverseCol ? m_matrix.cols() - col - 1 : col);
149 ReverseCol ? m_matrix.cols() - col - OffsetCol : col));
157 ReverseCol ? m_matrix.cols() - col - OffsetCol : col,
SolveTriangular.h 73 ::run(actualLhs.cols(), actualLhs.data(), actualLhs.outerStride(), actualRhs);
94 const Index othersize = Side==OnTheLeft? rhs.cols() : rhs.rows();
99 BlockingType blocking(rhs.rows(), rhs.cols(), size);
177 eigen_assert( cols() == rows() && ((Side==OnTheLeft && cols() == other.rows()) || (Side==OnTheRight && cols() == other.cols())) );
242 inline Index cols() const { return m_rhs.cols(); } function in struct:Eigen::internal::triangular_solve_retval
DenseCoeffsBase.h 60 using Base::cols;
97 && col >= 0 && col < cols());
114 && col >= 0 && col < cols());
211 && col >= 0 && col < cols());
288 using Base::cols;
317 && col >= 0 && col < cols());
337 && col >= 0 && col < cols());
433 && col >= 0 && col < cols());
479 && col >= 0 && col < cols());
520 && col >= 0 && col < cols());
    [all...]
  /external/libedit/src/
filecomplete.c 360 size_t line, lines, col, cols, thisguy; local
371 cols = (size_t)screenwidth / (width + 1);
372 if (cols == 0)
373 cols = 1;
376 lines = (num + cols - 1) / cols;
385 for (col = 0; col < cols; col++) {
  /external/libvpx/libvpx/examples/
set_maps.c 70 roi.cols = (cfg->g_w + 15) / 16;
87 roi.roi_map = (uint8_t *)malloc(roi.rows * roi.cols);
88 for (i = 0; i < roi.rows * roi.cols; ++i)
103 map.cols = (cfg->g_w + 15) / 16;
105 map.active_map = (uint8_t *)malloc(map.rows * map.cols);
106 for (i = 0; i < map.rows * map.cols; ++i)
120 map.cols = (cfg->g_w + 15) / 16;
  /hardware/intel/common/omx-components/videocodec/libvpx_internal/libvpx/examples/
set_maps.c 70 roi.cols = (cfg->g_w + 15) / 16;
87 roi.roi_map = (uint8_t *)malloc(roi.rows * roi.cols);
88 for (i = 0; i < roi.rows * roi.cols; ++i)
103 map.cols = (cfg->g_w + 15) / 16;
105 map.active_map = (uint8_t *)malloc(map.rows * map.cols);
106 for (i = 0; i < map.rows * map.cols; ++i)
120 map.cols = (cfg->g_w + 15) / 16;
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 106 Index col = matrix.cols();
128 inline Index cols() const { return m_cR->ncol; } function in class:Eigen::SPQR
147 eigen_assert(b.cols()==1 && "This method is for vectors only");
155 y.bottomRows(cols()-rk).setZero();
157 dest.topRows(cols()) = colsPermutation() * y.topRows(cols());
190 * It should be equal to matrixQR().cols if the matrix is full-rank
244 inline Index rows() const { return m_transpose ? m_spqr.rows() : m_spqr.cols(); }
245 inline Index cols() const { return m_other.cols(); } function in struct:Eigen::SPQR_QProduct
    [all...]
  /external/eigen/Eigen/src/Core/products/
TriangularMatrixMatrix_MKL.h 104 Index cols = _cols; \
127 rows, cols, depth, aa_tmp.data(), aStride, _rhs, rhsStride, res, resStride, alpha, gemm_blocking, 0); \
144 n = (MKL_INT)cols; \
150 Map<const MatrixRhs, 0, OuterStride<> > rhs(_rhs,depth,cols,OuterStride<>(rhsStride)); \
181 Map<MatrixX##EIGPREFIX, 0, OuterStride<> > res_tmp(res,rows,cols,OuterStride<>(resStride)); \
218 Index cols = IsLower ? diagSize : _cols; \
224 if (cols != depth) { \
228 if ((nthr==1) && (((std::max)(cols,depth)-diagSize)/(double)diagSize < 0.5)) { \
236 Map<const MatrixRhs, 0, OuterStride<> > rhsMap(_rhs,depth,cols, OuterStride<>(rhsStride)); \
241 rows, cols, depth, _lhs, lhsStride, aa_tmp.data(), aStride, res, resStride, alpha, gemm_blocking, 0);
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/
Minor.h 66 && col >= 0 && col < matrix.cols());
72 inline Index cols() const { return m_matrix.cols() - 1; } function in class:Eigen::Minor
  /external/eigen/Eigen/src/Eigenvalues/
GeneralizedSelfAdjointEigenSolver.h 109 : Base(matA.cols())
166 eigen_assert(matA.cols()==matA.rows() && matB.rows()==matA.rows() && matB.cols()==matB.rows());

Completed in 539 milliseconds

1 2 3 4 5 6 7 8 91011>>