HomeSort by relevance Sort by last modified time
    Searched refs:cols (Results 351 - 375 of 805) sorted by null

<<11121314151617181920>>

  /external/eigen/unsupported/test/
kronecker_product.cpp 19 void check_dimension(const MatrixType& ab, const int rows, const int cols)
22 VERIFY_IS_EQUAL(ab.cols(), cols);
30 VERIFY_IS_EQUAL(ab.cols(), 6);
75 VERIFY_IS_EQUAL(ab.cols(), 10);
117 for(int j=0;j<DM_fix_ab.cols();++j)
  /external/opencv/cv/src/
cvstereogc.cpp 444 int k, x, y, rows = left->rows, cols = left->cols; local
460 for( x = 0; x < cols; x++, dptr += 3 )
470 if( x < cols-1 )
489 int x, y, x1, d, i, j, rows = state->left->rows, cols = state->left->cols, n = 0; local
499 for( x = 0; x < cols; x++ )
504 if( (unsigned)x1 >= (unsigned)cols )
528 int x, y, rows = state->left->rows, cols = state->left->cols; local
666 int k, a, d, d1, x, y, x1, y1, rows = state->left->rows, cols = state->left->cols; local
    [all...]
cvsurf.cpp 120 int* xofs = (int*)cvStackAlloc(sum->cols*sizeof(xofs[0]));
134 hessian_cols = (sum->cols)*SIZE0/scale;
138 icvResizeHaarPattern( dx_s, Dx, NX, SIZE0, size, sum->cols );
139 icvResizeHaarPattern( dy_s, Dy, NY, SIZE0, size, sum->cols );
140 icvResizeHaarPattern( dxy_s, Dxy, NXY, SIZE0, size, sum->cols );
160 const int* sum_ptr = sum->data.i + sum->cols*(i*scale/SIZE0);
191 hessian_cols = hessians[k]->cols;
192 icvResizeHaarPattern( dm, &Dm, 1, SIZE0, size, mask_sum ? mask_sum->cols : sum->cols );
207 mask_sum->cols*((i-SIZE0/2)*scale/SIZE0)
    [all...]
cvhough.cpp 111 width = img->cols;
244 w = img->cols;
511 width = image->cols;
789 if( !CV_IS_MAT_CONT( mat->type ) || (mat->rows != 1 && mat->cols != 1) )
798 mat->rows + mat->cols - 1, &lines_header, &lines_block ));
830 if( mat->cols > mat->rows )
831 mat->cols = lines->total;
869 int rows, cols, arows, acols; local
876 CV_CALL( edges = cvCreateMat( img->rows, img->cols, CV_8UC1 ));
879 CV_CALL( dx = cvCreateMat( img->rows, img->cols, CV_16SC1 ))
    [all...]
cvinpaint.cpp 90 for( j = 0; j < f->cols; j++ )
120 for (j=0; j<f->cols; j++) {
252 if ((i<=0)||(j<=0)||(i>f->rows)||(j>f->cols)) continue;
268 for(j=0; j<f->cols; j++) {
294 if ((i<=1)||(j<=1)||(i>t->rows-1)||(j>t->cols-1)) continue;
336 int lm=l-1+(l==1),lp=l-1-(l==t->cols-2);
337 if (k>0&&l>0&&k<t->rows-1&&l<t->cols-1) {
407 if ((i<=1)||(j<=1)||(i>t->rows-1)||(j>t->cols-1)) continue;
449 int lm=l-1+(l==1),lp=l-1-(l==t->cols-2);
450 if (k>0&&l>0&&k<t->rows-1&&l<t->cols-1)
    [all...]
  /external/eigen/Eigen/src/Core/
BooleanRedux.h 93 for(Index j = 0; j < cols(); ++j)
117 for(Index j = 0; j < cols(); ++j)
ForceAlignedAccess.h 45 EIGEN_DEVICE_FUNC inline Index cols() const { return m_expression.cols(); } function in class:Eigen::ForceAlignedAccess
Assign_MKL.h 88 eigen_assert(dst.rows() == src.rows() && dst.cols() == src.cols()); \
148 eigen_assert(dst.rows() == src.rows() && dst.cols() == src.cols()); \
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrix_BLAS.h 58 static void run(Index rows, Index cols, Index depth, \
80 n = convert_index<BlasIndex>(cols); \
SelfadjointMatrixMatrix_BLAS.h 51 Index rows, Index cols, \
66 n = convert_index<BlasIndex>(cols); \
97 Index rows, Index cols, \
113 n = convert_index<BlasIndex>(cols); \
168 Index rows, Index cols, \
182 n = convert_index<BlasIndex>(cols); \
213 Index rows, Index cols, \
228 n = convert_index<BlasIndex>(cols); \
  /external/eigen/Eigen/src/SparseCore/
SparseMatrixBase.h 63 * \sa MatrixBase::rows(), MatrixBase::cols(), ColsAtCompileTime, SizeAtCompileTime */
69 * \sa MatrixBase::rows(), MatrixBase::cols(), RowsAtCompileTime, SizeAtCompileTime */
170 /** \returns the number of rows. \sa cols() */
173 inline Index cols() const { return derived().cols(); } function in class:Eigen::SparseMatrixBase
174 /** \returns the number of coefficients, which is \a rows()*cols().
175 * \sa rows(), cols(). */
176 inline Index size() const { return rows() * cols(); }
179 * \code rows()==1 || cols()==1 \endcode
180 * \sa rows(), cols(), IsVectorAtCompileTime. *
    [all...]
  /external/eigen/bench/spbench/
sp_solver.cpp 55 n = A.cols();
94 cout<< "Rows and columns "<< A.rows() <<" " <<A.cols() <<"\n";
  /external/eigen/test/
adjoint.cpp 81 Index cols = m.cols(); local
83 MatrixType m1 = MatrixType::Random(rows, cols),
84 m2 = MatrixType::Random(rows, cols),
85 m3(rows, cols),
113 c = internal::random<Index>(0, cols-1);
124 if(PacketSize<m3.rows() && PacketSize<m3.cols())
128 Index j = internal::random<Index>(0,m3.cols()-PacketSize);
real_qz.cpp 24 Index dim = m.cols();
54 for (Index i=0; i<A.cols(); i++)
sparse_permutations.cpp 47 const Index cols = ref.cols(); local
56 double density = (std::max)(8./(rows*cols), 0.01);
58 SparseMatrixType mat(rows, cols), up(rows,cols), lo(rows,cols);
60 DenseMatrix mat_d = DenseMatrix::Zero(rows, cols), up_sym_d, lo_sym_d, res_d;
76 randomPermutationVector(pi, cols);
  /external/eigen/unsupported/Eigen/src/SparseExtra/
BlockOfDynamicSparseMatrix.h 108 EIGEN_STRONG_INLINE Index cols() const { return IsRowMajor ? m_matrix.cols() : m_outerSize.value(); }
  /external/gemmlowp/internal/
unpack.h 62 int cols; member in struct:gemmlowp::MatrixBlockBounds
68 cols(cols_) {}
71 template <int Rows, int Cols, typename SrcMapType>
82 for (int c = 0; c < Cols; c++) {
142 assert(dst_block.start_col + dst_block.cols <= dst->cols());
147 rhs_sums_of_each_slice_ptr, dst_block.cols);
173 for (; c8 <= dst_block.cols - 8; c8 += 8) {
220 for (; c <= dst_block.cols - 4; c += 4) {
247 for (; c < dst_block.cols; c++)
    [all...]
  /external/opencv/cxcore/src/
cxminmaxloc.cpp 407 if( minloc.x >= mat->cols )
409 minloc.y = minloc.x / mat->cols;
410 minloc.x -= minloc.y * mat->cols;
413 if( maxloc.x >= mat->cols )
415 maxloc.y = maxloc.x / mat->cols;
416 maxloc.x -= maxloc.y * mat->cols;
419 if( matmask && ((unsigned)minloc.x >= (unsigned)mat->cols ||
422 (unsigned)maxloc.x >= (unsigned)mat->cols ||
cxsvd.cpp 1230 t_svd; /* special case: a->rows < a->cols */
1245 if( a->rows >= a->cols )
1248 n = a->cols;
1250 w_cols = w->cols;
1260 m = a->cols;
1262 w_rows = w->cols;
1283 u_cols = u->cols;
1287 u_rows = u->cols;
    [all...]
  /packages/apps/Music/src/com/android/music/
VideoBrowserActivity.java 83 String[] cols = new String[] {MediaStore.Video.Media._ID, MediaStore.Video.Media.TITLE, local
92 mCursor = resolver.query(MediaStore.Video.Media.EXTERNAL_CONTENT_URI, cols,
  /packages/apps/Terminal/src/com/android/terminal/
TerminalLineView.java 35 public int cols; field in class:TerminalLineView
64 for (int col = 0; col < cols;) {
  /external/libvterm/src/
state.c 64 state->cols = vt->cols;
87 if(rect.start_col == 0 && rect.end_col == state->cols && rightward == 0) {
1034 rect.start_col = state->pos.col; rect.end_col = state->cols;
1048 rect.start_col = 0; rect.end_col = state->cols;
1062 rect.start_col = 0; rect.end_col = state->cols;
1232 for(col = 0; col < state->cols; col++)
    [all...]
  /external/opencv/cvaux/src/
cvlevmarprojbandle.cpp 91 numPoints = points4D->cols;
108 if( projMatr->rows != 3 || projMatr->cols != 4 )
118 if( status->rows != 1 || status->cols != numPoints )
128 if( derivProj->cols != 12 )
249 numPoints = presPoints->cols;
266 if( projMatr->rows != 3 || projMatr->cols != 4 )
276 if( presPoints->rows != 1 || presPoints->cols != numPoints )
332 if( derivPoint->rows != 2 || derivPoint->cols != currVisPoint*4 )
390 numPoints = presPoints[0]->cols;
478 numPoints = presPoints[0]->cols;
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
EigenSolver.h 148 : m_eivec(matrix.rows(), matrix.cols()),
149 m_eivalues(matrix.cols()),
152 m_realSchur(matrix.cols()),
153 m_matT(matrix.rows(), matrix.cols()),
154 m_tmp(matrix.cols())
350 Index n = m_eivec.cols();
386 eigen_assert(matrix.cols() == matrix.rows());
400 m_eivalues.resize(matrix.cols());
402 while (i < matrix.cols())
404 if (i == matrix.cols() - 1 || m_matT.coeff(i+1, i) == Scalar(0))
    [all...]
  /device/google/accessory/arduino/USB_Host_Shield/
Max_LCD.h 84 void begin(uint8_t cols, uint8_t rows, uint8_t charsize = LCD_5x8DOTS);

Completed in 940 milliseconds

<<11121314151617181920>>