/external/eigen/Eigen/src/plugins/ |
BlockMethods.h | 35 template<int Rows, int Cols> struct FixedBlockXpr { typedef Block<Derived,Rows,Cols> Type; }; 36 template<int Rows, int Cols> struct ConstFixedBlockXpr { typedef Block<const Derived,Rows,Cols> Type; }; 94 return BlockXpr(derived(), 0, cols() - cCols, cRows, cCols); 101 return ConstBlockXpr(derived(), 0, cols() - cCols, cRows, cCols); 120 return typename FixedBlockXpr<CRows,CCols>::Type(derived(), 0, cols() - CCols); 128 return typename ConstFixedBlockXpr<CRows,CCols>::Type(derived(), 0, cols() - CCols); 153 return typename FixedBlockXpr<CRows,CCols>::Type(derived(), 0, cols() - cCols, cRows, cCols); 160 return typename ConstFixedBlockXpr<CRows,CCols>::Type(derived(), 0, cols() - cCols, cRows, cCols) [all...] |
MatrixCwiseBinaryOps.h | 91 return cwiseMin(Derived::Constant(rows(), cols(), other)); 117 return cwiseMax(Derived::Constant(rows(), cols(), other)); 151 return CwiseScalarEqualReturnType(derived(), Derived::Constant(rows(), cols(), s), internal::scalar_cmp_op<Scalar,Scalar,internal::cmp_EQ>());
|
/external/eigen/bench/ |
dense_solvers.cpp | 17 if(A.rows()!=A.cols()) 52 HouseholderQR<Mat> qr(A.rows(),A.cols()); 53 ColPivHouseholderQR<Mat> cpqr(A.rows(),A.cols()); 54 CompleteOrthogonalDecomposition<Mat> cod(A.rows(),A.cols()); 55 FullPivHouseholderQR<Mat> fpqr(A.rows(),A.cols()); 56 JacobiSVD<MatDyn> jsvd(A.rows(),A.cols()); 57 BDCSVD<MatDyn> bdcsvd(A.rows(),A.cols());
|
/external/eigen/test/ |
qr_fullpivoting.cpp | 21 cols = internal::random<Index>(min_size,max_size), local 23 rank = internal::random<Index>(1, (std::min)(rows, cols)-1); 28 createRandomPIMatrixOfRank(rank,rows,cols,m1); 31 VERIFY_IS_EQUAL(cols - qr.rank(), qr.dimensionOfKernel()); 42 for(int i = 0; i < rows; i++) for(int j = 0; j < cols; j++) if(i>j) r(i,j) = Scalar(0); 52 MatrixType m2 = MatrixType::Random(cols,cols2); 54 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());
|
nomalloc.cpp | 31 Index cols = m.cols(); local 33 MatrixType m1 = MatrixType::Random(rows, cols), 34 m2 = MatrixType::Random(rows, cols), 35 m3(rows, cols); 40 c = internal::random<Index>(0, cols-1); 44 VERIFY_IS_APPROX(m1.cwiseProduct(m1.block(0,0,rows,cols)), (m1.array()*m1.array()).matrix()); 176 typename MatrixType::Index rows = m.rows(), cols=m.cols(); local 184 Ref r2(m.block(rows/3, cols/4, rows/2, cols/2)) [all...] |
redux.cpp | 22 Index cols = m.cols(); local 24 MatrixType m1 = MatrixType::Random(rows, cols); 28 MatrixType m1_for_prod = MatrixType::Ones(rows, cols) + RealScalar(0.2) * m1; 30 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows, cols).sum(), Scalar(1)); 31 VERIFY_IS_APPROX(MatrixType::Ones(rows, cols).sum(), Scalar(float(rows*cols))); // the float() here to shut up excessive MSVC warning about int->complex conversion being lossy 33 for(int j = 0; j < cols; j++) 41 const Scalar mean = s/Scalar(RealScalar(rows*cols)); 51 Index c0 = internal::random<Index>(0,cols-1) [all...] |
sparse_product.cpp | 35 const Index cols = internal::random<Index>(1,n); local 40 double density = (std::max)(8./(rows*cols), 0.2); 54 DenseMatrix refMat3 = DenseMatrix::Zero(depth, cols); 55 DenseMatrix refMat3t = DenseMatrix::Zero(cols, depth); 56 DenseMatrix refMat4 = DenseMatrix::Zero(rows, cols); 57 DenseMatrix refMat4t = DenseMatrix::Zero(cols, rows); 58 DenseMatrix refMat5 = DenseMatrix::Random(depth, cols); 64 SparseMatrixType m3 (depth, cols); 65 SparseMatrixType m3t(cols, depth); 66 SparseMatrixType m4 (rows, 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) roi.roi_map[i] = i % 4; 102 map.cols = (cfg->g_w + 15) / 16; 104 map.active_map = (uint8_t *)malloc(map.rows * map.cols); 105 for (i = 0; i < map.rows * map.cols; ++i) map.active_map[i] = i % 2; 118 map.cols = (cfg->g_w + 15) / 16;
|
/external/toybox/lib/ |
linestack.c | 87 int (*escout)(FILE *out, int cols, int wc)) 121 int crunch_escape(FILE *out, int cols, int wc) 130 if (rc > cols) buf[rc = cols] = 0; 137 int crunch_rev_escape(FILE *out, int cols, int wc) 142 rc = crunch_escape(out, cols, wc); 174 int (*escout)(FILE *out, int cols, int wc))
|
/external/eigen/Eigen/src/Core/ |
SolveTriangular.h | 73 ::run(actualLhs.cols(), actualLhs.data(), actualLhs.outerStride(), actualRhs); 93 const Index othersize = Side==OnTheLeft? rhs.cols() : rhs.rows(); 98 BlockingType blocking(rhs.rows(), rhs.cols(), size, 1, false); 170 eigen_assert( derived().cols() == derived().rows() && ((Side==OnTheLeft && derived().cols() == other.rows()) || (Side==OnTheRight && derived().cols() == other.cols())) ); 214 inline Index cols() const { return m_rhs.cols(); } function in struct:Eigen::internal::triangular_solve_retval
|
Inverse.h | 59 EIGEN_DEVICE_FUNC Index cols() const { return m_xpr.cols(); } function in class:Eigen::Inverse 104 : m_result(inv_xpr.rows(), inv_xpr.cols())
|
ReturnByValue.h | 64 EIGEN_DEVICE_FUNC inline Index cols() const { return static_cast<const Derived*>(this)->cols(); } function in class:Eigen::ReturnByValue 103 : m_result(xpr.rows(), xpr.cols())
|
DenseBase.h | 79 using Base::cols; 104 * \sa MatrixBase::rows(), MatrixBase::cols(), ColsAtCompileTime, SizeAtCompileTime */ 110 * \sa MatrixBase::rows(), MatrixBase::cols(), RowsAtCompileTime, SizeAtCompileTime */ 221 : int(IsRowMajor) ? this->rows() : this->cols(); 233 : int(IsRowMajor) ? this->cols() : this->rows(); 252 void resize(Index rows, Index cols) 255 EIGEN_ONLY_USED_FOR_DEBUG(cols); 256 eigen_assert(rows == this->rows() && cols == this->cols() 329 Constant(Index rows, Index cols, const Scalar& value) [all...] |
/external/eigen/Eigen/src/Eigenvalues/ |
GeneralizedEigenSolver.h | 156 : m_eivec(A.rows(), A.cols()), 157 m_alphas(A.cols()), 158 m_betas(A.cols()), 161 m_realQZ(A.cols()), 162 m_tmp(A.cols()) 293 eigen_assert(A.cols() == A.rows() && B.cols() == A.rows() && B.cols() == B.rows()); 294 Index size = A.cols();
|
ComplexSchur_LAPACKE.h | 49 eigen_assert(matrix.cols() == matrix.rows()); \ 52 if(matrix.cols() == 1) \ 61 lapack_int n = internal::convert_index<lapack_int>(matrix.cols()), sdim, info; \
|
GeneralizedSelfAdjointEigenSolver.h | 108 : Base(matA.cols()) 165 eigen_assert(matA.cols()==matA.rows() && matB.rows()==matA.rows() && matB.cols()==matB.rows());
|
/external/eigen/Eigen/src/Core/products/ |
TriangularMatrixMatrix_BLAS.h | 104 Index cols = _cols; \ 128 rows, cols, depth, aa_tmp.data(), aStride, _rhs, rhsStride, res, resStride, alpha, gemm_blocking, 0); \ 141 n = convert_index<BlasIndex>(cols); \ 147 Map<const MatrixRhs, 0, OuterStride<> > rhs(_rhs,depth,cols,OuterStride<>(rhsStride)); \ 178 Map<MatrixX##EIGPREFIX, 0, OuterStride<> > res_tmp(res,rows,cols,OuterStride<>(resStride)); \ 215 Index cols = IsLower ? diagSize : _cols; \ 221 if (cols != depth) { \ 225 if ((nthr==1) && (((std::max)(cols,depth)-diagSize)/(double)diagSize < 0.5)) { \ 233 Map<const MatrixRhs, 0, OuterStride<> > rhsMap(_rhs,depth,cols, OuterStride<>(rhsStride)); \ 238 rows, cols, depth, _lhs, lhsStride, aa_tmp.data(), aStride, res, resStride, alpha, gemm_blocking, 0); [all...] |
/external/eigen/Eigen/src/Householder/ |
BlockHouseholder.h | 25 // const Index nbVecs = vectors.cols(); 26 // eigen_assert(triFactor.rows() == nbVecs && triFactor.cols() == nbVecs && vectors.rows()>=nbVecs); 53 const Index nbVecs = vectors.cols(); 54 eigen_assert(triFactor.rows() == nbVecs && triFactor.cols() == nbVecs && vectors.rows()>=nbVecs); 82 Index nbVecs = vectors.cols();
|
/external/eigen/Eigen/src/MetisSupport/ |
MetisSupport.h | 31 Index m = A.cols(); 32 eigen_assert((A.rows() == A.cols()) && "ONLY FOR SQUARED MATRICES"); 105 StorageIndex m = internal::convert_index<StorageIndex>(A.cols()); // must be StorageIndex, because it is passed by address to METIS
|
/external/gemmlowp/internal/ |
compute.h | 77 void ComputeL1(int start_row, int rows, int start_col, int cols, 80 assert(cols % Format::kCols == 0); 83 for (int c = 0; c < cols; c += Format::kCols) {
|
/external/shflags/src/ |
shflags_test_private.sh | 15 cols=`_flags_columns` 16 value=`expr "${cols}" : '\([0-9]*\)'` 17 assertNotNull "unexpected screen width (${cols})" "${value}"
|
/external/syslinux/core/ |
font.c | 156 uint8_t rows, cols; local 173 cols = oreg.eax.b[1]; 175 VidCols = --cols; /* Store count-1 (same as rows) */
|
/external/opencv/cxcore/src/ |
cxutils.cpp | 78 if( (labels->rows != 1 && (labels->cols != 1 || !CV_IS_MAT_CONT(labels->type))) || 79 labels->rows + labels->cols - 1 != samples->rows ) 91 dims = samples->cols*CV_MAT_CN(samples->type); 102 counters->cols = cluster_count; // cut down counters 289 coeff_count = coeffs->rows + coeffs->cols - 1; 291 if( (coeffs->rows != 1 && coeffs->cols != 1) || (coeff_count != 3 && coeff_count != 4) ) 295 if( (roots->rows != 1 && roots->cols != 1) || 296 roots->rows + roots->cols - 1 != 3 ) 657 m = a->rows * a->cols; 658 n = r->rows * r->cols; 819 int cont_flag, arr_size, elem_size, cols, step; local 918 int rows, cols; local [all...] |