HomeSort by relevance Sort by last modified time
    Searched refs:Cols (Results 1 - 15 of 15) sorted by null

  /external/eigen/test/
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...]
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...]
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...]
product_trsolve.cpp 30 template<typename Scalar,int Size, int Cols> void trsolve(int size=Size,int cols=Cols)
38 rowmajor = Cols==1 ? ColMajor : RowMajor };
39 Matrix<Scalar,Size,Cols,colmajor> cmRhs(size,cols);
40 Matrix<Scalar,Size,Cols,rowmajor> rmRhs(size,cols);
41 Matrix<Scalar,Dynamic,Dynamic,colmajor> ref(size,cols);
71 int c = internal::random<int>(0,cols-1)
    [all...]
main.h 311 void createRandomPIMatrixOfRank(typename MatrixType::Index desired_rank, typename MatrixType::Index rows, typename MatrixType::Index cols, MatrixType& m)
315 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
319 typedef Matrix<Scalar, Cols, Cols> MatrixBType;
323 m.setZero(rows,cols);
330 m = VectorType::Random(rows).normalized() * VectorType::Random(cols).normalized().transpose();
335 MatrixType d = MatrixType::Identity(rows,cols);
336 MatrixBType b = MatrixBType::Random(cols,cols);
339 const Index diag_size = (std::min)(d.rows(),d.cols());
    [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);
131 Index cols = m.cols(); local
    [all...]
  /external/eigen/Eigen/src/Core/
NumTraits.h 124 template<typename Scalar, int Rows, int Cols, int Options, int MaxRows, int MaxCols>
125 struct NumTraits<Array<Scalar, Rows, Cols, Options, MaxRows, MaxCols> >
127 typedef Array<Scalar, Rows, Cols, Options, MaxRows, MaxCols> ArrayType;
129 typedef Array<RealScalar, Rows, Cols, Options, MaxRows, MaxCols> Real;
131 typedef Array<NonIntegerScalar, Rows, Cols, Options, MaxRows, MaxCols> NonInteger;
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...]
GeneralProduct.h 45 template<int Rows, int Cols, int Depth> struct product_type_selector;
65 Cols = _Rhs::ColsAtCompileTime,
78 cols_select = product_size_category<Cols,MaxCols>::value,
91 EIGEN_DEBUG_VAR(Cols);
261 const Index cols = dest.cols(); local
262 for (Index j=0; j<cols; ++j)
325 eigen_assert(m_lhs.rows() == dst.rows() && m_rhs.cols() == dst.cols());
441 actualLhs.rows(), actualLhs.cols(),
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseUtil.h 94 template<typename T,int Rows,int Cols> struct sparse_eval;
100 template<typename T,int Cols> struct sparse_eval<T,1,Cols> {
114 template<typename T,int Rows,int Cols> struct sparse_eval {
  /external/eigen/Eigen/src/Core/util/
XprHelper.h 105 template<typename Scalar, int Rows, int Cols, int Options, int MaxRows, int MaxCols>
216 Cols = traits<T>::ColsAtCompileTime,
222 Cols,
234 Cols = traits<T>::ColsAtCompileTime,
240 Cols,
ForwardDeclarations.h 134 template<typename _Scalar, int Rows=Dynamic, int Cols=Dynamic, int Supers=Dynamic, int Subs=Dynamic, int Options=0> class BandMatrix;
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixFunction.h 75 static const int Cols = Traits::ColsAtCompileTime;
81 typedef Matrix<ComplexScalar, Rows, Cols, Options, MaxRows, MaxCols> ComplexMatrix;
368 m_fT.resize(m_T.rows(), m_T.cols());
437 eigen_assert(A.rows() == A.cols());
439 eigen_assert(B.rows() == B.cols());
442 eigen_assert(C.cols() == B.rows());
528 Index cols() const { return m_A.cols(); } function in class:Eigen::MatrixFunctionReturnValue
552 eigen_assert(rows() == cols());
559 eigen_assert(rows() == cols());
    [all...]
  /external/eigen/Eigen/src/SuperLUSupport/
SuperLUSupport.h 160 res.ncol = mat.cols();
174 res.nrow = mat.cols();
181 res.ncol = mat.cols();
205 template<typename Scalar, int Rows, int Cols, int Options, int MRows, int MCols>
206 struct SluMatrixMapHelper<Matrix<Scalar,Rows,Cols,Options,MRows,MCols> >
208 typedef Matrix<Scalar,Rows,Cols,Options,MRows,MCols> MatrixType;
217 res.ncol = mat.cols();
233 res.nrow = mat.cols();
240 res.ncol = mat.cols();
316 inline Index cols() const { return m_matrix.cols(); function in class:Eigen::SuperLUBase
    [all...]

Completed in 171 milliseconds