/external/eigen/bench/ |
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/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/test/ |
eigensolver_generic.cpp | 22 Index cols = m.cols(); local 30 MatrixType a = MatrixType::Random(rows,cols); 31 MatrixType a1 = MatrixType::Random(rows,cols); 53 MatrixType id = MatrixType::Identity(rows, cols); 73 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) { 101 const Index cols = m.cols(); local 104 A.setIdentity(rows, cols); 106 VERIFY(equalsIdentity(MatrixType::Identity(rows, cols)));
|
dontalign.cpp | 28 Index cols = m.cols(); local 30 MatrixType a = MatrixType::Random(rows,cols);
|
product_symm.cpp | 24 Index cols = size; local 26 MatrixType m1 = MatrixType::Random(rows, cols), 27 m2 = MatrixType::Random(rows, cols), m3; 31 Rhs1 rhs1 = Rhs1::Random(cols, othersize), rhs12(cols, othersize), rhs13(cols, othersize); 33 Rhs3 rhs3 = Rhs3::Random(cols, othersize), rhs32(cols, othersize), rhs33(cols, othersize);
|
product_trmm.cpp | 14 int cols=internal::random<int>(1,EIGEN_TEST_MAX_SIZE), 26 TriMatrix mat(rows,cols), tri(rows,cols), triTr(cols,rows); 28 OnTheRight ge_right(cols,otherCols); 65 void trmv(int rows=internal::random<int>(1,EIGEN_TEST_MAX_SIZE), int cols=internal::random<int>(1,EIGEN_TEST_MAX_SIZE)) 67 trmm<Scalar,Mode,TriOrder,ColMajor,ColMajor,1>(rows,cols,1); 71 void trmm(int rows=internal::random<int>(1,EIGEN_TEST_MAX_SIZE), int cols=internal::random<int>(1,EIGEN_TEST_MAX_SIZE), int otherCols = internal::random<int>(1,EIGEN_TEST_MAX_SIZE)) 73 trmm<Scalar,Mode,TriOrder,OtherOrder,ResOrder,Dynamic>(rows,cols,otherCols);
|
sparse_basic.cpp | 18 const Index cols = ref.cols(); local 22 double density = (std::max)(8./(rows*cols), 0.01); 27 SparseMatrixType m(rows, cols); 28 DenseMatrix refMat = DenseMatrix::Zero(rows, cols); 56 int j = internal::random<int>(0,cols-1); 58 int w = internal::random<int>(1,cols-j-1); 80 for(int c=0; c<cols; c++) 95 DenseMatrix m1(rows,cols); 97 SparseMatrixType m2(rows,cols); [all...] |
cholesky.cpp | 68 Index cols = m.cols(); local 75 MatrixType a0 = MatrixType::Random(rows,cols); 77 MatrixType matB = MatrixType::Random(rows,cols), matX(rows,cols); 82 MatrixType a1 = MatrixType::Random(rows,cols); 171 MatrixType m1 = MatrixType::Random(rows,cols), m2(rows,cols); 200 Index cols = m.cols(); local [all...] |
/external/eigen/unsupported/Eigen/src/KroneckerProduct/ |
KroneckerTensorProduct.h | 31 Ac = A.cols(), 33 Bc = B.cols(); 51 Ac = A.cols(), 53 Bc = B.cols(); 93 c.resize(a.rows()*b.rows(),a.cols()*b.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,
|
/external/eigen/Eigen/src/Eigenvalues/ |
ComplexSchur_MKL.h | 52 assert(matrix.cols() == matrix.rows()); \ 55 if(matrix.cols() == 1) \ 64 lapack_int n = matrix.cols(), sdim, info; \
|
/external/chromium_org/third_party/skia/include/utils/ |
SkBoundaryPatch.h | 41 bool evalPatch(SkPoint verts[], int rows, int cols);
|
/external/chromium_org/third_party/skia/src/utils/ |
SkBoundaryPatch.cpp | 46 bool SkBoundaryPatch::evalPatch(SkPoint verts[], int rows, int cols) { 47 if (rows < 2 || cols < 2) { 52 const SkScalar invC = SkScalarInvert(SkIntToScalar(cols - 1)); 54 for (int y = 0; y < cols; y++) {
|
/external/eigen/Eigen/src/Householder/ |
Householder.h | 102 * this->cols() * essential.size() entries 120 Map<typename internal::plain_row_type<PlainObject>::type> tmp(workspace,cols()); 121 Block<Derived, EssentialPart::SizeAtCompileTime, Derived::ColsAtCompileTime> bottom(derived(), 1, 0, rows()-1, cols()); 139 * this->cols() * essential.size() entries 151 if(cols() == 1) 158 Block<Derived, Derived::RowsAtCompileTime, EssentialPart::SizeAtCompileTime> right(derived(), 0, 1, rows(), cols()-1);
|
/external/eigen/doc/examples/ |
Tutorial_simple_example_dynamic_size.cpp | 11 for (int j=0; j<m.cols(); ++j) // loop over columns
|
/external/eigen/test/eigen2/ |
eigen2_sparse_vector.cpp | 12 template<typename Scalar> void sparse_vector(int rows, int cols) 14 double densityMat = std::max(8./(rows*cols), 0.01); 22 SparseMatrixType m1(rows,cols); 24 DenseMatrix refM1 = DenseMatrix::Zero(rows, cols);
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
IncompleteLU.h | 35 Index cols() const { return m_lu.cols(); } function in class:Eigen::IncompleteLU 41 int size = mat.cols(); 84 eigen_assert(cols()==b.rows()
|
/external/skia/include/utils/ |
SkBoundaryPatch.h | 41 bool evalPatch(SkPoint verts[], int rows, int cols);
|
/external/skia/src/utils/ |
SkBoundaryPatch.cpp | 46 bool SkBoundaryPatch::evalPatch(SkPoint verts[], int rows, int cols) { 47 if (rows < 2 || cols < 2) { 52 const SkScalar invC = SkScalarInvert(SkIntToScalar(cols - 1)); 54 for (int y = 0; y < cols; y++) {
|
/external/eigen/Eigen/src/Core/ |
Array.h | 151 /** constructs an uninitialized matrix with \a rows rows and \a cols columns. 156 Array(Index rows, Index cols); 186 : Base(other.rows() * other.cols(), other.rows(), other.cols()) 193 : Base(other.rows() * other.cols(), other.rows(), other.cols()) 203 Base::resize(other.rows(), other.cols()); 210 : Base(other.derived().rows() * other.derived().cols(), other.derived().rows(), other.derived().cols()) 213 Base::resize(other.rows(), other.cols()); [all...] |
MapBase.h | 62 using Base::cols; 80 inline Index cols() const { return m_cols.value(); } function in class:Eigen::MapBase 143 inline MapBase(PointerType data, Index rows, Index cols) 144 : m_data(data), m_rows(rows), m_cols(cols) 148 && cols >= 0 && (ColsAtCompileTime == Dynamic || ColsAtCompileTime == cols))); 182 using Base::cols; 229 inline MapBase(PointerType data, Index rows, Index cols) : Base(data, rows, cols) {}
|
Matrix.h | 238 /** \brief Constructs an uninitialized matrix with \a rows rows and \a cols columns. 243 Matrix(Index rows, Index cols); 273 : Base(other.rows() * other.cols(), other.rows(), other.cols()) 285 : Base(other.rows() * other.cols(), other.rows(), other.cols()) 295 Base::resize(other.rows(), other.cols()); 304 : Base(other.derived().rows() * other.derived().cols(), other.derived().rows(), other.derived().cols()) 307 Base::resize(other.rows(), other.cols()); [all...] |
BandMatrix.h | 51 using Base::cols; 85 { return Block<CoefficientsType,1,SizeAtCompileTime>(coeffs(),supers(),0,1,(std::min)(rows(),cols())); } 89 { return Block<const CoefficientsType,1,SizeAtCompileTime>(coeffs(),supers(),0,1,(std::min)(rows(),cols())); } 136 dst.resize(rows(),cols()); 147 DenseMatrixType res(rows(),cols()); 155 { return i<0 ? (std::min)(cols(),rows()+i) : (std::min)(rows(),cols()-i); } 166 * \param Cols Number of columns, or \b Dynamic 198 template<typename _Scalar, int Rows, int Cols, int Supers, int Subs, int Options> 199 class BandMatrix : public BandMatrixBase<BandMatrix<_Scalar,Rows,Cols,Supers,Subs,Options> 217 inline Index cols() const { return m_coeffs.cols(); } function in class:Eigen::internal::BandMatrix 281 inline Index cols() const { return m_coeffs.cols(); } function in class:Eigen::internal::BandMatrixWrapper [all...] |
/external/eigen/Eigen/src/Core/products/ |
TriangularMatrixMatrix.h | 60 Index rows, Index cols, Index depth, 74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking); 105 Index cols = _cols; local 114 std::size_t sizeB = kc*cols; 146 pack_rhs(blockB, &rhs(actual_k2,0), rhsStride, actual_kc, cols); 176 gebp_kernel(res+startBlock, resStride, blockA, blockB, actualPanelWidth, actualPanelWidth, cols, alpha, 186 gebp_kernel(res+startTarget, resStride, blockA, blockB, lengthTarget, actualPanelWidth, cols, alpha, 201 gebp_kernel(res+i2, resStride, blockA, blockB, actual_mc, actual_kc, cols, alpha, -1, -1, 0, 0, blockW); 234 Index cols = IsLower ? diagSize : _cols; local 243 std::size_t sizeB = kc*cols; [all...] |