Searched defs:rows (Results 251 - 275 of 469) sorted by relevance

<<111213141516171819

/external/eigen/Eigen/src/Core/
H A DTranspositions.h26 * the rows \c i and \c indices[i] of the matrix \c M.
339 /** \returns the \a matrix with the \a transpositions applied to the rows.
371 inline int rows() const { return m_matrix.rows(); } function in struct:Eigen::internal::transposition_matrix_product_retval
421 /** \returns the \a matrix with the inverse transpositions applied to the rows.
/external/eigen/Eigen/src/Core/products/
H A DCoeffBasedProduct.h155 eigen_assert(lhs.cols() == rhs.rows()
160 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } function in class:Eigen::CoeffBasedProduct
H A DSelfadjointMatrixMatrix.h46 void operator()(Scalar* blockA, const Scalar* _lhs, Index lhsStride, Index cols, Index rows) argument
50 Index peeled_mc = (rows/Pack1)*Pack1;
56 if(rows-peeled_mc>=Pack2)
63 for(Index i=peeled_mc; i<rows; i++)
80 void operator()(Scalar* blockB, const Scalar* _rhs, Index rhsStride, Index rows, Index cols, Index k2) argument
82 Index end_k = k2 + rows;
104 for(Index j2=k2; j2<(std::min)(k2+rows,packet_cols); j2+=nr)
150 for(Index j2=k2+rows; j2<packet_cols; j2+=nr)
176 if(half==j2 && half<k2+rows)
185 for(Index k=half+1; k<k2+rows;
209 run( Index rows, Index cols, const Scalar* lhs, Index lhsStride, const Scalar* rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha) argument
243 run( Index rows, Index cols, const Scalar* _lhs, Index lhsStride, const Scalar* _rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha) argument
334 run( Index rows, Index cols, const Scalar* _lhs, Index lhsStride, const Scalar* _rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha) argument
[all...]
H A DTriangularMatrixMatrix.h21 // 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);
116 Index rows = IsLower ? _rows : diagSize; local
124 Index mc = (std::min)(rows,blocking.mc()); // cache block size along the M direction
153 if((!IsLower)&&(k2<rows)&&(k2+actual_kc>rows))
155 actual_kc = rows
59 run( Index rows, Index cols, Index depth, const Scalar* lhs, Index lhsStride, const Scalar* rhs, Index rhsStride, Scalar* res, Index resStride, const Scalar& alpha, level3_blocking<Scalar,Scalar>& blocking) argument
257 Index rows = _rows; local
[all...]
H A DTriangularSolverMatrix.h150 // update the respective rows of B from other
202 Index rows = otherSize; local
214 Index mc = (std::min)(rows,blocking.mc()); // cache block size along the M direction
261 for(Index i2=0; i2<rows; i2+=mc)
263 const Index actual_mc = (std::min)(mc,rows-i2);
/external/eigen/Eigen/src/Eigenvalues/
H A DHessenbergDecomposition.h120 m_temp(matrix.rows()),
123 if(matrix.rows()<2)
128 m_hCoeffs.resize(matrix.rows()-1,1);
153 if(matrix.rows()<2)
158 m_hCoeffs.resize(matrix.rows()-1,1);
236 .setLength(m_matrix.rows() - 1)
294 eigen_assert(matA.rows()==matA.cols());
295 Index n = matA.rows();
357 Index n = result.rows();
362 Index rows() cons function in struct:Eigen::internal::HessenbergDecompositionMatrixHReturnType
[all...]
H A DTridiagonalization.h158 m_hCoeffs.resize(matrix.rows()-1, 1);
242 .setLength(m_matrix.rows() - 1)
316 Index n = m_matrix.rows();
352 Index n = matA.rows();
409 * vector \p diag should equal the number of rows in \p mat, and the
429 eigen_assert(mat.cols()==mat.rows() && diag.size()==mat.rows() && subdiag.size()==mat.rows()-1);
451 .setLength(mat.rows() - 1)
546 Index rows() cons function in struct:Eigen::internal::TridiagonalizationMatrixTReturnType
[all...]
/external/eigen/Eigen/src/Geometry/
H A DHomogeneous.h75 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/
H A DHouseholderSequence.h85 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/
H A DIterativeSolverBase.h115 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/
H A DInverse.h286 inline Index rows() const { return m_matrix.rows(); } function in struct:Eigen::internal::inverse_impl
323 eigen_assert(rows() == cols());
355 eigen_assert(rows() == cols());
394 eigen_assert(rows() == cols());
H A DPartialPivLU.h119 * 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 local
298 blocked_lu(Index rows, Index cols, Scalar* lu_data, Index luStride, PivIndex* row_transpositions, PivIndex& nb_transpositions, Index maxBlockSize=256) argument
[all...]
/external/eigen/Eigen/src/PardisoSupport/
H A DPardisoSupport.h130 inline Index rows() const { return m_size; } function in class:Eigen::PardisoImpl
178 eigen_assert(rows()==b.rows()
179 && "PardisoImpl::solve(): invalid number of rows of the right hand side matrix b");
192 eigen_assert(rows()==b.rows()
193 && "PardisoImpl::solve(): invalid number of rows of the right hand side matrix b");
287 m_size = a.rows();
288 eigen_assert(a.rows() == a.cols());
310 m_size = a.rows();
[all...]
/external/eigen/Eigen/src/QR/
H A DHouseholderQR.h76 HouseholderQR(Index rows, Index cols) argument
77 : m_qr(rows, cols),
78 m_hCoeffs((std::min)(rows,cols)),
88 * HouseholderQR<MatrixType> qr(matrix.rows(), matrix.cols());
95 : m_qr(matrix.rows(), matrix.cols()),
96 m_hCoeffs((std::min)(matrix.rows(),matrix.cols())),
182 inline Index rows() const { return m_qr.rows(); } function in class:Eigen::HouseholderQR
203 eigen_assert(m_qr.rows() == m_qr.cols() && "You can't take the determinant of a non-square matrix!");
211 eigen_assert(m_qr.rows()
224 Index rows = mat.rows(); local
263 Index rows = mat.rows(); local
313 const Index rows = dec().rows(), cols = dec().cols(); local
346 Index rows = matrix.rows(); local
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DMappedSparseMatrix.h49 inline Index rows() const { return IsRowMajor ? m_outerSize : m_innerSize; } function in class:Eigen::MappedSparseMatrix
108 inline MappedSparseMatrix(Index rows, Index cols, Index nnz, Index* outerIndexPtr, Index* innerIndexPtr, Scalar* valuePtr) argument
109 : m_outerSize(IsRowMajor?rows:cols), m_innerSize(IsRowMajor?cols:rows), m_nnz(nnz), m_outerIndex(outerIndexPtr),
H A DSparseBlock.h61 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); } function in class:Eigen::BlockImpl
237 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); } function in class:Eigen::BlockImpl
272 IsRowMajor ? outerSize : rows(), IsRowMajor ? cols() : outerSize);
284 IsRowMajor ? outerSize : rows(), IsRowMajor ? cols() : outerSize);
307 m_blockRows(xpr.rows()),
317 inline int rows() const { return m_blockRows.value(); } function in class:Eigen::BlockImpl
H A DSparseDenseProduct.h105 EIGEN_STRONG_INLINE Index rows() const { return Tr ? m_rhs.rows() : m_lhs.rows(); } function in class:Eigen::SparseDenseOuterProduct
H A DSparseDiagonalProduct.h90 eigen_assert(lhs.cols() == rhs.rows() && "invalid sparse matrix * diagonal matrix product");
93 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } function in class:Eigen::SparseDiagonalProduct
H A DSparseProduct.h124 EIGEN_STRONG_INLINE Index rows() const { return m_lhs.rows(); } function in class:Eigen::SparseSparseProduct
133 eigen_assert(m_lhs.cols() == m_rhs.rows());
/external/eigen/bench/
H A Dsparse_setter.cpp63 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/blas/
H A Dcommon.h103 matrix(T* data, int rows, int cols, int stride) argument
105 return Map<Matrix<T,Dynamic,Dynamic,ColMajor>, 0, OuterStride<> >(data, rows, cols, OuterStride<>(stride));
/external/eigen/test/
H A Dcholesky.cpp44 VectorType vec = VectorType::Random(symm.rows());
67 Index rows = m.rows(); local
75 MatrixType a0 = MatrixType::Random(rows,cols);
76 VectorType vecB = VectorType::Random(rows), vecX(rows);
77 MatrixType matB = MatrixType::Random(rows,cols), matX(rows,cols);
82 MatrixType a1 = MatrixType::Random(rows,cols);
119 MatrixType m1 = MatrixType::Random(rows,col
250 Index rows = m.rows(); local
[all...]
H A Dref.cpp50 Index rows = m.rows(), cols = m.cols(); local
52 MatrixType m1 = MatrixType::Random(rows, cols),
55 Index i = internal::random<Index>(0,rows-1);
57 Index brows = internal::random<Index>(1,rows-i);
H A Dsparse_basic.cpp19 const Index rows = ref.rows(); local
24 double density = (std::max)(8./(rows*cols), 0.01);
31 SparseMatrixType m(rows, cols);
32 DenseMatrix refMat = DenseMatrix::Zero(rows, cols);
33 DenseVector vec1 = DenseVector::Random(rows);
60 int i = internal::random<int>(0,rows-1);
62 int h = internal::random<int>(1,rows-i-1);
89 for(int r=0; r<rows; r++)
103 DenseMatrix m1(rows,col
[all...]
H A Dsparse_product.cpp27 Index r = internal::random<Index>(0,m2.rows()-1);
42 const Index rows = internal::random<Index>(1,n); local
48 double density = (std::max)(8./(rows*cols), 0.1);
60 DenseMatrix refMat2 = DenseMatrix::Zero(rows, depth);
61 DenseMatrix refMat2t = DenseMatrix::Zero(depth, rows);
64 DenseMatrix refMat4 = DenseMatrix::Zero(rows, cols);
65 DenseMatrix refMat4t = DenseMatrix::Zero(cols, rows);
67 DenseMatrix refMat6 = DenseMatrix::Random(rows, rows);
68 DenseMatrix dm4 = DenseMatrix::Zero(rows, row
[all...]

Completed in 250 milliseconds

<<111213141516171819