/external/eigen/Eigen/src/Core/ |
SolveTriangular.h | 93 const Index size = lhs.rows(); 94 const Index othersize = Side==OnTheLeft? rhs.cols() : rhs.rows(); 99 BlockingType blocking(rhs.rows(), rhs.cols(), size); 177 eigen_assert( cols() == rows() && ((Side==OnTheLeft && cols() == other.rows()) || (Side==OnTheRight && cols() == other.cols())) ); 241 inline Index rows() const { return m_rhs.rows(); } function in struct:Eigen::internal::triangular_solve_retval
|
Transpose.h | 69 inline Index rows() const { return m_matrix.cols(); } function in class:Eigen::Transpose 70 inline Index cols() const { return m_matrix.rows(); } 262 if (m.rows()==m.cols())
|
/external/eigen/Eigen/src/Core/products/ |
CoeffBasedProduct.h | 155 eigen_assert(lhs.cols() == rhs.rows() 160 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } function in class:Eigen::CoeffBasedProduct
|
TriangularMatrixMatrix.h | 21 // void operator()(Scalar* blockA, const EIGEN_RESTRICT Scalar* _lhs, int lhsStride, int depth, int rows) 26 // const int peeled_mc = (rows/mr)*mr; 33 // for(int i=peeled_mc; i<rows; i++) 60 Index rows, Index cols, Index depth, 74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking); 103 Index rows = IsLower ? _rows : diagSize; local 111 Index mc = (std::min)(rows,blocking.mc()); // cache block size along the M direction 140 if((!IsLower)&&(k2<rows)&&(k2+actual_kc>rows)) 142 actual_kc = rows-k2 232 Index rows = _rows; local [all...] |
TriangularMatrixVector.h | 34 Index rows = IsLower ? _rows : (std::min)(_rows,_cols); local 38 const LhsMap lhs(_lhs,rows,cols,OuterStride<>(lhsStride)); 46 ResMap res(_res,rows); 61 Index r = IsLower ? rows - pi - actualPanelWidth : pi; 75 rows, cols-size, 97 Index rows = IsLower ? _rows : diagSize; local 101 const LhsMap lhs(_lhs,rows,cols,OuterStride<>(lhsStride)); 109 ResMap res(_res,rows,InnerStride<>(resIncr)); 135 if(IsLower && rows>diagSize) 138 rows-diagSize, cols [all...] |
TriangularSolverMatrix.h | 143 // update the respective rows of B from other 189 Index rows = otherSize; local 201 Index mc = (std::min)(rows,blocking.mc()); // cache block size along the M direction 248 for(Index i2=0; i2<rows; i2+=mc) 250 const Index actual_mc = (std::min)(mc,rows-i2);
|
/external/eigen/Eigen/src/Eigenvalues/ |
Tridiagonalization.h | 158 m_hCoeffs.resize(matrix.rows()-1, 1); 242 .setLength(m_matrix.rows() - 1) 316 Index n = m_matrix.rows(); 351 Index n = matA.rows(); 408 * vector \p diag should equal the number of rows in \p mat, and the 429 //Index n = mat.rows(); 430 eigen_assert(mat.cols()==mat.rows() && diag.size()==mat.rows() && subdiag.size()==mat.rows()-1); 452 .setLength(mat.rows() - 1 546 Index rows() const { return m_matrix.rows(); } function in struct:Eigen::internal::TridiagonalizationMatrixTReturnType [all...] |
/external/eigen/Eigen/src/Geometry/ |
Homogeneous.h | 75 inline Index rows() const { return m_matrix.rows() + (int(Direction)==Vertical ? 1 : 0); } function in class:Eigen::Homogeneous 80 if( (int(Direction)==Vertical && row==m_matrix.rows()) 179 Direction==Vertical ? _expression().rows()-1 : _expression().rows(), 185 Direction==Vertical ? _expression().rows()-1:0, 187 Direction==Vertical ? 1 : _expression().rows(), 189 Direction==Vertical ? _expression().rows()-1 : 1, 246 inline Index rows() const { return m_lhs.rows(); } function in struct:Eigen::internal::homogeneous_left_product_impl 285 inline Index rows() const { return m_lhs.rows(); } function in struct:Eigen::internal::homogeneous_right_product_impl [all...] |
/external/eigen/Eigen/src/Householder/ |
HouseholderSequence.h | 85 return Block<const VectorsType,Dynamic,1>(h.m_vectors, start, k, h.rows()-start, 1); 98 return Block<const VectorsType,1,Dynamic>(h.m_vectors, k, start, 1, h.rows()-start).transpose(); 144 * i-th column). If \p v has fewer columns than rows, then the Householder sequence contains as many 170 /** \brief Number of rows of transformation viewed as a matrix. 171 * \returns Number of rows 174 Index rows() const { return Side==OnTheLeft ? m_vectors.rows() : m_vectors.cols(); } function in class:Eigen::HouseholderSequence 180 Index cols() const { return rows(); } 230 AutoAlign|ColMajor, DestType::MaxRowsAtCompileTime, 1> workspace(rows()); 238 workspace.resize(rows()); [all...] |
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
IncompleteLUT.h | 70 Index rows() const { return m_lu.rows(); } function in class:Eigen::IncompleteLUT 122 eigen_assert(cols()==b.rows() 123 && "IncompleteLUT::solve(): invalid number of rows of the right hand side matrix b"); 246 eigen_assert((amat.rows() == amat.cols()) && "The factorization should be done on a square matrix"); 273 // global loop over the rows of the sparse matrix 322 // 3 - eliminate the previous nonzero rows
|
IterativeSolverBase.h | 115 Index rows() const { return mp_matrix ? mp_matrix->rows() : 0; } function in class:Eigen::IterativeSolverBase 170 eigen_assert(rows()==b.rows() 171 && "IterativeSolverBase::solve(): invalid number of rows of the right hand side matrix b"); 184 eigen_assert(rows()==b.rows() 185 && "IterativeSolverBase::solve(): invalid number of rows of the right hand side matrix b"); 200 eigen_assert(rows()==b.rows()); [all...] |
/external/eigen/Eigen/src/LU/ |
PartialPivLU.h | 119 * b.rows()==A.rows(), where A is the matrix of which *this is the LU decomposition. 150 (*this, MatrixType::Identity(m_lu.rows(), m_lu.cols())); 170 inline Index rows() const { return m_lu.rows(); } function in class:Eigen::PartialPivLU 203 : m_lu(matrix.rows(), matrix.rows()), 204 m_p(matrix.rows()), 205 m_rowsTranspositions(matrix.rows()), 241 const Index rows = lu.rows() local [all...] |
/external/eigen/Eigen/src/PaStiXSupport/ |
PaStiXSupport.h | 94 for(i = 0; i <= mat.rows(); ++i) 109 for(i = 0; i <= mat.rows(); ++i) 152 eigen_assert(rows()==b.rows() 153 && "PastixBase::solve(): invalid number of rows of the right hand side matrix b"); 165 eigen_assert(rows()==b.rows()); 170 int size = b.rows(); 228 inline Index rows() const { return m_size; } function in class:Eigen::PastixBase 253 eigen_assert(rows()==b.rows( [all...] |
/external/eigen/Eigen/src/QR/ |
ColPivHouseholderQR.h | 81 ColPivHouseholderQR(Index rows, Index cols) 82 : m_qr(rows, cols), 83 m_hCoeffs((std::min)(rows,cols)), 92 : m_qr(matrix.rows(), matrix.cols()), 93 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())), 227 return rank() == rows(); 253 (*this, MatrixType::Identity(m_qr.rows(), m_qr.cols())); 256 inline Index rows() const { return m_qr.rows(); } function in class:Eigen::ColPivHouseholderQR 346 eigen_assert(m_qr.rows() == m_qr.cols() && "You can't take the determinant of a non-square matrix!") 361 Index rows = matrix.rows(); local [all...] |
HouseholderQR.h | 76 HouseholderQR(Index rows, Index cols) 77 : m_qr(rows, cols), 78 m_hCoeffs((std::min)(rows,cols)), 83 : m_qr(matrix.rows(), matrix.cols()), 84 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())), 162 inline Index rows() const { return m_qr.rows(); } function in class:Eigen::HouseholderQR 177 eigen_assert(m_qr.rows() == m_qr.cols() && "You can't take the determinant of a non-square matrix!"); 185 eigen_assert(m_qr.rows() == m_qr.cols() && "You can't take the determinant of a non-square matrix!"); 198 Index rows = mat.rows() local 238 Index rows = mat.rows(); local 288 const Index rows = dec().rows(), cols = dec().cols(); local 315 Index rows = matrix.rows(); local [all...] |
/external/eigen/Eigen/src/SparseCore/ |
MappedSparseMatrix.h | 49 inline Index rows() const { return IsRowMajor ? m_outerSize : m_innerSize; } function in class:Eigen::MappedSparseMatrix 106 inline MappedSparseMatrix(Index rows, Index cols, Index nnz, Index* outerIndexPtr, Index* innerIndexPtr, Scalar* valuePtr) 107 : m_outerSize(IsRowMajor?rows:cols), m_innerSize(IsRowMajor?cols:rows), m_nnz(nnz), m_outerIndex(outerIndexPtr),
|
SparseBlock.h | 92 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); } function in class:Eigen::SparseInnerVectorSet 274 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); } function in class:Eigen::SparseInnerVectorSet
|
SparseDenseProduct.h | 99 EIGEN_STRONG_INLINE Index rows() const { return Tr ? m_rhs.rows() : m_lhs.rows(); } function in class:Eigen::SparseDenseOuterProduct
|
SparseMatrixBase.h | 51 /**< The number of rows at compile-time. This is just a copy of the value provided 54 * \sa MatrixBase::rows(), MatrixBase::cols(), ColsAtCompileTime, SizeAtCompileTime */ 60 * \sa MatrixBase::rows(), MatrixBase::cols(), RowsAtCompileTime, SizeAtCompileTime */ 66 * rows times the number of columns, or to \a Dynamic if this is not 76 /**< This is set to true if either the number of rows or the number of 146 /** \returns the number of rows. \sa cols() */ 147 inline Index rows() const { return derived().rows(); } function in class:Eigen::SparseMatrixBase 148 /** \returns the number of columns. \sa rows() */ 150 /** \returns the number of coefficients, which is \a rows()*cols() [all...] |
SparseProduct.h | 122 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } function in class:Eigen::SparseSparseProduct 131 eigen_assert(m_lhs.cols() == m_rhs.rows());
|
SparseSelfAdjointView.h | 62 eigen_assert(rows()==cols() && "SelfAdjointView is only for squared matrices"); 65 inline Index rows() const { return m_matrix.rows(); } function in class:Eigen::SparseSelfAdjointView 108 SparseMatrix<DestScalar,ColMajor,Index> tmp(_dest.rows(),_dest.cols()); 302 Index size = mat.rows(); 390 Index size = mat.rows(); 458 inline Index rows() const { return m_matrix.rows(); } function in class:Eigen::SparseSymmetricPermutationProduct
|
/external/eigen/bench/ |
sparse_setter.cpp | 63 int rows = SIZE; local 78 Vector2i ij(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1)); 103 coords.push_back(Vector2i(internal::random<int>(0,rows-1),j));
|
/external/eigen/test/ |
jacobisvd.cpp | 21 Index rows = m.rows(); local 36 MatrixType sigma = MatrixType::Zero(rows,cols); 52 Index rows = m.rows(); local 54 Index diagSize = (std::min)(rows, cols); 74 Index rows = m.rows(); local 85 RhsType rhs = RhsType::Random(rows, internal::random<Index>(1, cols)); 95 if (QRPreconditioner == NoQRPreconditioner && m.rows() != m.cols() 143 Index rows = m.rows(); local [all...] |
/external/eigen/unsupported/Eigen/src/MatrixFunctions/ |
MatrixLogarithm.h | 85 MatrixType result(A.rows(), A.rows()); 86 if (A.rows() == 1) 88 else if (A.rows() == 2) 151 RealScalar normTminusI = (T - MatrixType::Identity(T.rows(), T.rows())).cwiseAbs().colwise().sum().maxCoeff(); 250 MatrixType TminusI = T - MatrixType::Identity(T.rows(), T.rows()); 251 result.setZero(T.rows(), T.rows()); 465 Index rows() const { return m_A.rows(); } function in class:Eigen::MatrixLogarithmReturnValue [all...] |
MatrixSquareRoot.h | 42 eigen_assert(A.rows() == A.cols()); 88 MatrixType sqrtT = MatrixType::Zero(m_A.rows(), m_A.rows()); 102 const Index size = m_A.rows(); 121 const Index size = m_A.rows(); 270 eigen_assert(A.rows() == A.cols()); 299 result.resize(m_A.rows(), m_A.cols()); 301 for (Index i = 0; i < m_A.rows(); i++) { 363 eigen_assert(A.rows() == A.cols()); 375 MatrixType sqrtT = MatrixType::Zero(m_A.rows(), m_A.rows()) 458 Index rows() const { return m_src.rows(); } function in class:Eigen::MatrixSquareRootReturnValue [all...] |