HomeSort by relevance Sort by last modified time
    Searched full:cols (Results 26 - 50 of 825) sorted by null

12 3 4 5 6 7 8 91011>>

  /external/llvm/include/llvm/CodeGen/PBQP/
Math.h 116 Matrix(unsigned rows, unsigned cols) :
117 rows(rows), cols(cols), data(new PBQPNum[rows * cols]) {
122 Matrix(unsigned rows, unsigned cols, PBQPNum initVal) :
123 rows(rows), cols(cols), data(new PBQPNum[rows * cols]) {
124 std::fill(data, data + (rows * cols), initVal);
129 rows(m.rows), cols(m.cols), data(new PBQPNum[rows * cols])
    [all...]
  /external/eigen/bench/
sparse_dense_product.cpp 55 int cols = SIZE; local
58 EigenSparseMatrix sm1(rows,cols);
59 DenseVector v1(cols), v2(cols);
65 //fillMatrix(density, rows, cols, sm1);
66 fillMatrix2(7, rows, cols, sm1);
72 DenseMatrix m1(rows,cols);
93 std::cout << "Eigen sparse\t" << sm1.nonZeros()/float(sm1.rows()*sm1.cols())*100 << "%\n";
106 // std::cout << "Eigen dyn-sparse\t" << m1.nonZeros()/float(m1.rows()*m1.cols())*100 << "%\n";
119 //GmmDynSparse gmmT3(rows,cols);
    [all...]
spmv.cpp 28 // mkl_scscmm(&n, lhs.rows(), rhs.cols(), lhs.cols(), &alpha, matdescra,
31 // // mkl_somatcopy('C', 'T', lhs.rows(), lhs.cols(), 1,
41 int cols = size; local
55 cols = atoi(argv[i]+1);
80 std::cout << "SpMV " << rows << " x " << cols << " with " << nnzPerCol << " non zeros per column. (" << repeats << " repeats, and " << tries << " tries)\n\n";
82 EigenSparseMatrix sm(rows,cols);
83 DenseVector dv(cols), res(rows);
91 fillMatrix2(nnzPerCol, rows, cols, sm);
96 DenseMatrix dm(rows,cols), (rows,cols) local
    [all...]
  /external/eigen/test/
mapstaticmethods.cpp 72 int rows = m.rows(), cols = m.cols(); local
76 PlainObjectType::Map(ptr, rows, cols).setZero();
77 PlainObjectType::MapAligned(ptr, rows, cols).setZero();
78 PlainObjectType::Map(const_ptr, rows, cols).sum();
79 PlainObjectType::MapAligned(const_ptr, rows, cols).sum();
81 PlainObjectType::Map(ptr, rows, cols, InnerStride<>(i)).setZero();
82 PlainObjectType::MapAligned(ptr, rows, cols, InnerStride<>(i)).setZero();
83 PlainObjectType::Map(const_ptr, rows, cols, InnerStride<>(i)).sum();
84 PlainObjectType::MapAligned(const_ptr, rows, cols, InnerStride<>(i)).sum()
    [all...]
array.cpp 21 Index cols = m.cols(); local
23 ArrayType m1 = ArrayType::Random(rows, cols),
24 m2 = ArrayType::Random(rows, cols),
25 m3(rows, cols);
28 RowVectorType rv1 = RowVectorType::Random(cols);
35 VERIFY_IS_APPROX(m1 + s1, ArrayType::Constant(rows,cols,s1) + m1);
37 VERIFY_IS_APPROX(m1 - s1, m1 - ArrayType::Constant(rows,cols,s1));
38 VERIFY_IS_APPROX(s1 - m1, ArrayType::Constant(rows,cols,s1) - m1);
39 VERIFY_IS_APPROX((m1*Scalar(2)) - s2, (m1+m1) - ArrayType::Constant(rows,cols,s2) )
92 Index cols = m.cols(); local
157 Index cols = m.cols(); local
219 Index cols = m.cols(); local
239 Index cols = m.cols(); local
    [all...]
qr.cpp 18 Index cols = m.cols(); local
24 MatrixType a = MatrixType::Random(rows,cols);
36 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
38 Matrix<Scalar,Rows,Cols> m1 = Matrix<Scalar,Rows,Cols>::Random();
39 HouseholderQR<Matrix<Scalar,Rows,Cols> > qr(m1);
41 Matrix<Scalar,Rows,Cols> r = qr.matrixQR();
43 for(int i = 0; i < Rows; i++) for(int j = 0; j < Cols; j++) if(i>j) r(i,j) = Scalar(0);
47 Matrix<Scalar,Cols,Cols2> m2 = Matrix<Scalar,Cols,Cols2>::Random(Cols,Cols2)
    [all...]
diagonalmatrices.cpp 17 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
19 typedef Matrix<Scalar, 1, Cols> RowVectorType;
22 typedef DiagonalMatrix<Scalar, Cols> RightDiagonalMatrix;
23 typedef Matrix<Scalar, Rows==Dynamic?Dynamic:2*Rows, Cols==Dynamic?Dynamic:2*Cols> BigMatrix;
25 Index cols = m.cols(); local
27 MatrixType m1 = MatrixType::Random(rows, cols),
28 m2 = MatrixType::Random(rows, cols);
31 RowVectorType rv1 = RowVectorType::Random(cols),
    [all...]
bandmatrix.cpp 20 Index cols = _m.cols(); local
24 MatrixType m(rows,cols,supers,subs);
26 DenseMatrixType dm1(rows,cols);
44 for (int i=0; i<cols; ++i)
49 Index d = (std::min)(rows,cols);
50 Index a = std::max<Index>(0,cols-d-supers);
53 dm1.block(0,supers+1,cols-supers-1-a,cols-supers-1-a).template triangularView<Upper>().setZero();
55 if(b>0) dm1.block(d+subs,0,b,cols).setZero()
69 Index cols = internal::random<Index>(1,10); local
    [all...]
permutationmatrices.cpp 18 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime,
23 typedef PermutationMatrix<Cols> RightPermutationType;
24 typedef Matrix<int, Cols, 1> RightPermutationVectorType;
28 Index cols = m.cols(); local
30 MatrixType m_original = MatrixType::Random(rows,cols);
35 randomPermutationVector(rv, cols);
40 for (int j=0; j<cols; j++)
44 Matrix<Scalar,Cols,Cols> rm(rp)
    [all...]
array_for_matrix.cpp 21 Index cols = m.cols(); local
23 MatrixType m1 = MatrixType::Random(rows, cols),
24 m2 = MatrixType::Random(rows, cols),
25 m3(rows, cols);
28 RowVectorType rv1 = RowVectorType::Random(cols);
35 VERIFY_IS_APPROX((m1.array() + s1).matrix(), MatrixType::Constant(rows,cols,s1) + m1);
36 VERIFY_IS_APPROX(((m1*Scalar(2)).array() - s2).matrix(), (m1+m1) - MatrixType::Constant(rows,cols,s2) );
62 VERIFY_IS_APPROX(m1.block(0,0,0,cols).colwise().sum(), RowVectorType::Zero(cols));
82 Index cols = m.cols(); local
150 Index cols = m.cols(); local
    [all...]
lu.cpp 22 Index rows, cols, cols2; local
33 cols = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE);
38 cols2 = cols = MatrixType::ColsAtCompileTime;
52 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
55 VERIFY((MatrixType::Zero(rows,cols).fullPivLu().image(MatrixType::Zero(rows,cols)).cols() == 1));
57 MatrixType m1(rows, cols), m3(rows, cols2);
58 CMatrixType m2(cols, cols2);
59 createRandomPIMatrixOfRank(rank, rows, cols, m1)
138 Index cols = rows; local
    [all...]
qr_colpivoting.cpp 18 Index rows = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols2 = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE); local
19 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
26 createRandomPIMatrixOfRank(rank,rows,cols,m1);
29 VERIFY(cols - qr.rank() == qr.dimensionOfKernel());
41 MatrixType m2 = MatrixType::Random(cols,cols2);
43 m2 = MatrixType::Random(cols,cols2);
50 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
52 int rank = internal::random<int>(1, (std::min)(int(Rows), int(Cols))-1);
53 Matrix<Scalar,Rows,Cols> m1;
54 createRandomPIMatrixOfRank(rank,Rows,Cols,m1)
    [all...]
product.h 36 Index cols = m.cols(); local
40 MatrixType m1 = MatrixType::Random(rows, cols),
41 m2 = MatrixType::Random(rows, cols),
42 m3(rows, cols);
48 square2 = ColSquareMatrixType::Random(cols, cols),
49 res2 = ColSquareMatrixType::Random(cols, cols);
51 ColVectorType vc2 = ColVectorType::Random(cols), vcres(cols)
    [all...]
array_replicate.cpp 25 Index cols = m.cols(); local
27 MatrixType m1 = MatrixType::Random(rows, cols),
28 m2 = MatrixType::Random(rows, cols);
38 x1.resize(rows*f1,cols*f2);
41 x1.block(i*rows,j*cols,rows,cols) = m1;
44 x2.resize(2*rows,3*cols);
  /external/eigen/test/eigen2/
eigen2_array.cpp 24 int cols = m.cols(); local
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2 = MatrixType::Random(rows, cols),
28 m3(rows, cols);
35 VERIFY_IS_APPROX(m1.cwise() + s1, MatrixType::Constant(rows,cols,s1) + m1);
36 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
59 int cols = m.cols(); local
62 c = ei_random<int>(0, cols-1)
    [all...]
eigen2_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);
75 SparseMatrix<Scalar> m2(rows, cols);
76 DenseMatrix refMat2(rows, cols);
78 DenseVector b = DenseVector::Random(cols);
79 DenseVector refX(cols), x(cols)
    [all...]
eigen2_svd.cpp 19 int cols = m.cols(); local
23 MatrixType a = MatrixType::Random(rows,cols);
26 Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> x(cols,1), x2(cols,1);
34 MatrixType sigma = MatrixType::Zero(rows,cols);
36 sigma.block(0,0,cols,cols) = svd.singularValues().asDiagonal();
37 matU.block(0,0,rows,cols) = svd.matrixU();
42 if (rows==cols)
    [all...]
eigen2_inverse.cpp 20 int cols = m.cols(); local
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2(rows, cols),
28 mzero = MatrixType::Zero(rows, cols),
33 m1 = MatrixType::Random(rows, cols);
eigen2_nomalloc.cpp 31 int cols = m.cols(); local
33 MatrixType m1 = MatrixType::Random(rows, cols),
34 m2 = MatrixType::Random(rows, cols),
35 m3(rows, cols),
36 mzero = MatrixType::Zero(rows, cols),
48 c = ei_random<int>(0, cols-1);
52 VERIFY_IS_APPROX(m1.cwise() * m1.block(0,0,rows,cols), m1.cwise() * m1);
  /external/ceres-solver/internal/ceres/
dense_sparse_matrix.cc 69 const int *cols = m.cols(); local
73 m_(rows[i], cols[i]) += values[i];
112 m_.resize(m_.rows() + m_.cols(), m_.cols());
114 m_.block(0, 0, tmp.rows(), tmp.cols()) = tmp;
118 m_.bottomLeftCorner(m_.cols(), m_.cols()) =
119 ConstVectorRef(d, m_.cols()).asDiagonal();
131 return m_.rows() - m_.cols();
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/
QR.h 37 MatrixType ret = MatrixType::Identity(this->rows(), this->cols());
49 int cols = this->cols(); local
50 return MatrixRBlockType(this->matrixQR(), 0, 0, cols, cols).template triangularView<UpperTriangular>();
  /external/linux-tools-perf/util/ui/
progress.c 15 int cols; local
19 newtGetScreenSize(&cols, NULL);
20 cols -= 4;
21 newtCenteredWindow(cols, 1, title);
25 self->scale = newtScale(0, 0, cols, total);
  /external/eigen/Eigen/src/Core/
PlainObjectBase.h 25 EIGEN_ALWAYS_INLINE void check_rows_cols_for_overflow(Index rows, Index cols)
30 bool error = (rows < 0 || cols < 0) ? true
31 : (rows == 0 || cols == 0) ? false
32 : (rows > max_index / cols);
120 EIGEN_STRONG_INLINE Index cols() const { return m_storage.cols(); } function in class:Eigen::PlainObjectBase
125 return m_storage.data()[col + row * m_storage.cols()];
138 return m_storage.data()[col + row * m_storage.cols()];
151 return m_storage.data()[col + row * m_storage.cols()];
167 ? col + row * m_storage.cols()
270 resize(rows(), cols); local
349 conservativeResize(rows(), cols); local
    [all...]
DenseStorage.h 95 static inline DenseIndex cols(void) {return _Cols;} function in class:Eigen::DenseStorage
111 static inline DenseIndex cols(void) {return _Cols;} function in class:Eigen::DenseStorage
138 inline DenseStorage(DenseIndex, DenseIndex rows, DenseIndex cols) : m_rows(rows), m_cols(cols) {}
142 inline DenseIndex cols(void) const {return m_cols;} function in class:Eigen::DenseStorage
143 inline void conservativeResize(DenseIndex, DenseIndex rows, DenseIndex cols) { m_rows = rows; m_cols = cols; }
144 inline void resize(DenseIndex, DenseIndex rows, DenseIndex cols) { m_rows = rows; m_cols = cols; }
161 inline DenseIndex cols(void) const {return _Cols; function in class:Eigen::DenseStorage
180 inline DenseIndex cols(void) const {return m_cols;} function in class:Eigen::DenseStorage
204 inline DenseIndex cols(void) const {return m_cols;} function in class:Eigen::DenseStorage
242 inline DenseIndex cols(void) const {return m_cols;} function in class:Eigen::DenseStorage
278 static inline DenseIndex cols(void) {return _Cols;} function in class:Eigen::DenseStorage
    [all...]
  /external/eigen/doc/examples/
tut_matrix_resize.cpp 11 << m.rows() << "x" << m.cols() << std::endl;
17 << v.rows() << "x" << v.cols() << std::endl;

Completed in 2918 milliseconds

12 3 4 5 6 7 8 91011>>