Searched defs:cols (Results 201 - 225 of 357) sorted by relevance

1234567891011>>

/external/eigen/Eigen/src/Core/
H A DReverse.h103 inline Index cols() const { return m_matrix.cols(); } function in class:Eigen::Reverse
112 eigen_assert(row >= 0 && row < rows() && col >= 0 && col < cols());
119 ReverseCol ? m_matrix.cols() - col - 1 : col);
125 ReverseCol ? m_matrix.cols() - col - 1 : col);
149 ReverseCol ? m_matrix.cols() - col - OffsetCol : col));
157 ReverseCol ? m_matrix.cols() - col - OffsetCol : col,
H A DSelfAdjointView.h76 inline Index cols() const { return m_matrix.cols(); } function in class:Eigen::SelfAdjointView
260 for(Index j = 0; j < dst.cols(); ++j)
H A DSolveTriangular.h73 ::run(actualLhs.cols(), actualLhs.data(), actualLhs.outerStride(), actualRhs);
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())) );
242 inline Index cols() const { return m_rhs.cols(); } function in struct:Eigen::internal::triangular_solve_retval
H A DTranspositions.h372 inline int cols() const { return m_matrix.cols(); } function in struct:Eigen::internal::transposition_matrix_product_retval
/external/eigen/Eigen/src/Core/products/
H A DCoeffBasedProduct.h155 eigen_assert(lhs.cols() == rhs.rows()
161 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); } function in class:Eigen::CoeffBasedProduct
265 eigen_assert(lhs.cols()>0 && "you are using a non initialized matrix");
267 for(Index i = 1; i < lhs.cols(); ++i)
417 eigen_assert(lhs.cols()>0 && "you are using a non initialized matrix");
419 for(Index i = 1; i < lhs.cols(); ++i)
430 eigen_assert(lhs.cols()>0 && "you are using a non initialized matrix");
432 for(Index i = 1; i < lhs.cols(); ++i)
H A DSelfadjointMatrixMatrix.h22 void pack(Scalar* blockA, const const_blas_data_mapper<Scalar,Index,StorageOrder>& lhs, Index cols, Index i, Index& count) argument
42 for(Index k=i+BlockRows; k<cols; k++)
46 void operator()(Scalar* blockA, const Scalar* _lhs, Index lhsStride, Index cols, Index rows) argument
53 pack<Pack1>(blockA, lhs, cols, i, count);
58 pack<Pack2>(blockA, lhs, cols, peeled_mc, count);
70 for(Index k=i+1; k<cols; k++)
80 void operator()(Scalar* blockB, const Scalar* _rhs, Index rhsStride, Index rows, Index cols, Index k2) argument
85 Index packet_cols = (cols/nr)*nr;
166 for(Index j2=packet_cols; j2<cols; ++j2)
210 Index rows, Index cols,
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.h60 Index rows, Index cols, Index depth,
74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking);
118 Index cols = _cols; local
127 std::size_t sizeB = kc*cols;
159 pack_rhs(blockB, &rhs(actual_k2,0), rhsStride, actual_kc, cols);
189 gebp_kernel(res+startBlock, resStride, blockA, blockB, actualPanelWidth, actualPanelWidth, cols, alpha,
199 gebp_kernel(res+startTarget, resStride, blockA, blockB, lengthTarget, actualPanelWidth, cols, alpha,
214 gebp_kernel(res+i2, resStride, blockA, blockB, actual_mc, actual_kc, cols, alpha, -1, -1, 0, 0, blockW);
259 Index cols = IsLower ? diagSize : _cols; local
268 std::size_t sizeB = kc*cols;
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
[all...]
H A DTriangularSolverMatrix.h22 Index size, Index cols,
32 ::run(size, cols, tri, triStride, _other, otherStride, blocking);
54 Index cols = otherSize; local
68 std::size_t sizeB = kc*cols;
84 Index subcols = cols>0 ? l2/(4 * sizeof(Scalar) * otherStride) : 0;
106 for(Index j2=0; j2<cols; j2+=subcols)
108 Index actual_cols = (std::min)(cols-j2,subcols);
177 gebp_kernel(_other+i2, otherStride, blockA, blockB, actual_mc, actual_kc, cols, Scalar(-1), -1, -1, 0, 0, blockW);
21 run( Index size, Index cols, const Scalar* tri, Index triStride, Scalar* _other, Index otherStride, level3_blocking<Scalar,Scalar>& blocking) argument
/external/eigen/Eigen/src/Eigenvalues/
H A DHessenbergDecomposition.h294 eigen_assert(matA.rows()==matA.cols());
363 Index cols() const { return m_hess.packedMatrix().cols(); } function in struct:Eigen::internal::HessenbergDecompositionMatrixHReturnType
H A DTridiagonalization.h131 m_hCoeffs(matrix.cols() > 1 ? matrix.cols()-1 : 1),
353 eigen_assert(n==matA.cols());
429 eigen_assert(mat.cols()==mat.rows() && diag.size()==mat.rows() && subdiag.size()==mat.rows()-1);
445 CoeffVectorType hCoeffs(mat.cols()-1);
547 Index cols() const { return m_matrix.cols(); } function in struct:Eigen::internal::TridiagonalizationMatrixTReturnType
/external/eigen/Eigen/src/Geometry/
H A DHomogeneous.h76 inline Index cols() const { return m_matrix.cols() + (int(Direction)==Horizontal ? 1 : 0); } function in class:Eigen::Homogeneous
81 || (int(Direction)==Horizontal && col==m_matrix.cols()))
180 Direction==Horizontal ? _expression().cols()-1 : _expression().cols()).cwiseQuotient(
186 Direction==Horizontal ? _expression().cols()-1:0,
188 Direction==Horizontal ? 1 : _expression().cols()),
190 Direction==Horizontal ? _expression().cols()-1 : 1));
247 inline Index cols() const { return m_rhs.cols(); } function in struct:Eigen::internal::homogeneous_left_product_impl
286 inline Index cols() const { return m_rhs.cols(); } function in struct:Eigen::internal::homogeneous_right_product_impl
[all...]
/external/eigen/Eigen/src/Householder/
H A DHouseholderSequence.h174 Index rows() const { return Side==OnTheLeft ? m_vectors.rows() : m_vectors.cols(); }
180 Index cols() const { return rows(); } function in class:Eigen::HouseholderSequence
260 for(Index k = 0; k<cols()-vecs ; ++k)
302 Matrix<Scalar,1,Dest::ColsAtCompileTime,RowMajor,1,Dest::MaxColsAtCompileTime> workspace(dst.cols());
310 workspace.resize(dst.cols());
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DIterativeSolverBase.h117 Index cols() const { return mp_matrix ? mp_matrix->cols() : 0; } function in class:Eigen::IterativeSolverBase
138 return (mp_matrix && m_maxIterations<0) ? mp_matrix->cols() : m_maxIterations;
202 int rhsCols = b.cols();
/external/eigen/Eigen/src/LU/
H A DInverse.h287 inline Index cols() const { return m_matrix.cols(); } 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.h150 (*this, MatrixType::Identity(m_lu.rows(), m_lu.cols()));
171 inline Index cols() const { return m_lu.cols(); } function in class:Eigen::PartialPivLU
242 const Index cols = lu.cols(); local
243 const Index size = (std::min)(rows,cols);
249 Index rcols = cols-k-1;
284 * by the variables \a rows, \a cols, \a lu_data, and \a lu_stride using a
298 static Index blocked_lu(Index rows, Index cols, Scalar* lu_data, Index luStride, PivIndex* row_transpositions, PivIndex& nb_transpositions, Index maxBlockSize=256) argument
300 MapLU lu1(lu_data,StorageOrder==RowMajor?rows:luStride,StorageOrder==RowMajor?luStride:cols);
[all...]
/external/eigen/Eigen/src/PardisoSupport/
H A DPardisoSupport.h129 inline Index cols() const { return m_size; } function in class:Eigen::PardisoImpl
288 eigen_assert(a.rows() == a.cols());
311 eigen_assert(m_size == a.cols());
334 eigen_assert(m_size == a.rows() && m_size == a.cols());
356 Index nrhs = Index(b.cols());
493 m_matrix.resize(matrix.rows(), matrix.cols());
552 m_matrix.resize(matrix.rows(), matrix.cols());
/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)),
79 m_temp(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())),
97 m_temp(matrix.cols()),
183 inline Index cols() const { return m_qr.cols(); } function in class:Eigen::HouseholderQR
225 Index cols = mat.cols(); local
264 Index cols = mat.cols(); local
313 const Index rows = dec().rows(), cols = dec().cols(); local
347 Index cols = matrix.cols(); local
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DMappedSparseMatrix.h50 inline Index cols() const { return IsRowMajor ? m_innerSize : m_outerSize; } 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.h62 EIGEN_STRONG_INLINE Index cols() const { return IsRowMajor ? m_matrix.cols() : m_outerSize.value(); } function in class:Eigen::BlockImpl
238 EIGEN_STRONG_INLINE Index cols() const { return IsRowMajor ? m_matrix.cols() : m_outerSize.value(); } function in class:Eigen::BlockImpl
272 IsRowMajor ? outerSize : rows(), IsRowMajor ? cols() : outerSize);
284 IsRowMajor ? outerSize : rows(), IsRowMajor ? cols() : outerSize);
308 m_blockCols(xpr.cols())
318 inline int cols() const { return m_blockCols.value(); } function in class:Eigen::BlockImpl
H A DSparseDenseProduct.h106 EIGEN_STRONG_INLINE Index cols() const { return Tr ? m_lhs.cols() : m_rhs.cols(); } function in class:Eigen::SparseDenseOuterProduct
175 for(Index c=0; c<rhs.cols(); ++c)
199 for(Index c=0; c<rhs.cols(); ++c)
H A DSparseDiagonalProduct.h90 eigen_assert(lhs.cols() == rhs.rows() && "invalid sparse matrix * diagonal matrix product");
94 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); } function in class:Eigen::SparseDiagonalProduct
H A DSparseProduct.h125 EIGEN_STRONG_INLINE Index cols() const { return m_rhs.cols(); } function in class:Eigen::SparseSparseProduct
133 eigen_assert(m_lhs.cols() == m_rhs.rows());
/external/eigen/bench/
H A Dsparse_setter.cpp64 int cols = SIZE; local
73 pool.reserve(cols*NBPERROW);
75 for (int i=0; i<cols*NBPERROW; )
78 Vector2i ij(internal::random<int>(0,rows-1),internal::random<int>(0,cols-1));
88 int n = cols*NBPERROW*KK;
100 for (int j=0; j<cols; ++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.cpp68 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);
119 MatrixType m1 = MatrixType::Random(rows,cols), m2(rows,cols);
251 Index cols = m.cols(); local
[all...]

Completed in 226 milliseconds

1234567891011>>