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

1 2 3 4 5 67 8 91011>>

  /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...]
  /packages/apps/Terminal/jni/
com_android_terminal_Terminal.cpp 78 inline ScrollbackLine(dimen_t _cols) : cols(_cols) {
79 mCells = new VTermScreenCell[cols];
85 inline dimen_t copyFrom(dimen_t cols, const VTermScreenCell* cells) {
86 dimen_t n = this->cols > cols ? cols : this->cols;
91 inline dimen_t copyTo(dimen_t cols, VTermScreenCell* cells) {
92 dimen_t n = cols > this->cols ? this->cols : cols
101 const dimen_t cols; member in class:android::ScrollbackLine
    [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...]
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);
128 Index cols = m.cols(); local
    [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...]
eigensolver_generic.cpp 22 Index cols = m.cols(); local
29 MatrixType a = MatrixType::Random(rows,cols);
30 MatrixType a1 = MatrixType::Random(rows,cols);
63 MatrixType id = MatrixType::Identity(rows, cols);
83 MatrixType a = MatrixType::Random(m.rows(),m.cols());
nullary.cpp 21 for (Index j = i+1; j < A.cols(); ++j) {
26 for (Index j = 0; j < (std::min)(i, A.cols()); ++j) {
107 const Index cols = m.cols(); local
110 A.setIdentity(rows, cols);
112 VERIFY(equalsIdentity(MatrixType::Identity(rows, cols)));
dontalign.cpp 28 Index cols = m.cols(); local
30 MatrixType a = MatrixType::Random(rows,cols);
  /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/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...]
benchCholesky.cpp 32 int cols = m.cols(); local
46 MatrixType a = MatrixType::Random(rows,cols);
53 int c = internal::random<int>(0,covMat.cols()-1);
92 gsl_matrix* gslCovMat = gsl_matrix_alloc(covMat.rows(),covMat.cols());
93 gsl_matrix* gslCopy = gsl_matrix_alloc(covMat.rows(),covMat.cols());
  /external/eigen/debug/gdb/
printers.py 60 self.cols = val['m_storage']['m_cols']
62 self.cols = int(template_params[2])
81 def __init__ (self, rows, cols, dataPtr, rowMajor):
83 self.cols = cols
97 if self.currentCol >= self.cols:
109 if self.currentCol >= self.cols:
116 if (self.cols == 1): #if it's a column vector
124 return self._iterator(self.rows, self.cols, self.data, self.rowMajor)
127 return "Eigen::%s<%s,%d,%d,%s> (data ptr: %s)" % (self.variety, self.innerType, self.rows, self.cols, "RowMajor" if self.rowMajor else "ColMajor", self.data
    [all...]
  /external/eigen/test/eigen2/
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...]
  /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/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...]
  /external/ceres-solver/internal/ceres/
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/chromium_org/third_party/libvpx/source/libvpx/vp8/common/ppc/
systemdependent.c 22 int cols,
27 extern void (*vp8_mbpost_proc_down)(unsigned char *dst, int pitch, int rows, int cols, int flimit);
28 extern void vp8_mbpost_proc_down_c(unsigned char *dst, int pitch, int rows, int cols, int flimit);
29 extern void (*vp8_mbpost_proc_across_ip)(unsigned char *src, int pitch, int rows, int cols, int flimit);
30 extern void vp8_mbpost_proc_across_ip_c(unsigned char *src, int pitch, int rows, int cols, int flimit);
38 int cols,
  /external/eigen/Eigen/src/SparseLU/
SparseLU.h 121 inline Index cols() const { return m_mat.cols(); } function in class:Eigen::SparseLU
231 X.resize(B.rows(),B.cols());
234 for(Index j = 0; j < B.cols(); ++j)
242 for (Index j = 0; j < B.cols(); ++j)
265 for (Index j = 0; j < this->cols(); ++j)
292 for (Index j = 0; j < this->cols(); ++j)
389 Index *outerIndexPtr_t = new Index[mat.cols()+1];
390 for(Index i = 0; i <= mat.cols(); i++) outerIndexPtr_t[i] = m_mat.outerIndexPtr()[i];
393 for (Index i = 0; i < mat.cols(); i++
663 Index cols() { return m_mapL.cols(); } function in struct:Eigen::SparseLUMatrixLReturnType
681 Index cols() { return m_mapL.cols(); } function in struct:Eigen::SparseLUMatrixUReturnType
    [all...]
  /external/eigen/demos/mix_eigen_and_c/
binary_library.cpp 72 C_MatrixXd* MatrixXd_new(int rows, int cols)
74 return eigen_to_c(*new MatrixXd(rows,cols));
92 void MatrixXd_resize(C_MatrixXd *m, int rows, int cols)
94 c_to_eigen(m).resize(rows,cols);
137 C_Map_MatrixXd* Map_MatrixXd_new(double *array, int rows, int cols)
139 return eigen_to_c(*new Map<MatrixXd>(array,rows,cols));
  /external/eigen/unsupported/Eigen/src/SVD/
SVDBase.h 161 inline Index cols() const { return m_cols; } function in class:Eigen::SVDBase
166 bool allocate(Index rows, Index cols, unsigned int computationOptions) ;
194 bool SVDBase<MatrixType>::allocate(Index rows, Index cols, unsigned int computationOptions)
196 eigen_assert(rows >= 0 && cols >= 0);
200 cols == m_cols &&
207 m_cols = cols;
  /external/libvpx/libvpx/vp8/common/ppc/
systemdependent.c 22 int cols,
27 extern void (*vp8_mbpost_proc_down)(unsigned char *dst, int pitch, int rows, int cols, int flimit);
28 extern void vp8_mbpost_proc_down_c(unsigned char *dst, int pitch, int rows, int cols, int flimit);
29 extern void (*vp8_mbpost_proc_across_ip)(unsigned char *src, int pitch, int rows, int cols, int flimit);
30 extern void vp8_mbpost_proc_across_ip_c(unsigned char *src, int pitch, int rows, int cols, int flimit);
38 int cols,
  /hardware/intel/common/omx-components/videocodec/libvpx_internal/libvpx/vp8/common/ppc/
systemdependent.c 22 int cols,
27 extern void (*vp8_mbpost_proc_down)(unsigned char *dst, int pitch, int rows, int cols, int flimit);
28 extern void vp8_mbpost_proc_down_c(unsigned char *dst, int pitch, int rows, int cols, int flimit);
29 extern void (*vp8_mbpost_proc_across_ip)(unsigned char *src, int pitch, int rows, int cols, int flimit);
30 extern void vp8_mbpost_proc_across_ip_c(unsigned char *src, int pitch, int rows, int cols, int flimit);
38 int cols,
  /external/ceres-solver/examples/
libmv_homography.cc 203 assert(4 <= x1.cols());
205 assert(x1.cols() == x2.cols());
207 int n = x1.cols();
295 for (int i = 0; i < x1_.cols(); i++) {
300 average_distance /= x1_.cols();
322 assert(4 <= x1.cols());
324 assert(x1.cols() == x2.cols());
337 for (int i = 0; i < x1.cols(); i++)
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
ComplexSchur_MKL.h 52 eigen_assert(matrix.cols() == matrix.rows()); \
55 if(matrix.cols() == 1) \
64 lapack_int n = matrix.cols(), sdim, info; \
  /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...]

Completed in 512 milliseconds

1 2 3 4 5 67 8 91011>>