Searched refs:m_matrix (Results 1 - 25 of 43) sorted by relevance

12

/external/eigen/Eigen/src/Core/
H A DFlagged.h51 inline Flagged(const ExpressionType& matrix) : m_matrix(matrix) {}
53 inline Index rows() const { return m_matrix.rows(); }
54 inline Index cols() const { return m_matrix.cols(); }
55 inline Index outerStride() const { return m_matrix.outerStride(); }
56 inline Index innerStride() const { return m_matrix.innerStride(); }
60 return m_matrix.coeff(row, col);
65 return m_matrix.coeff(index);
70 return m_matrix.const_cast_derived().coeffRef(row, col);
75 return m_matrix.const_cast_derived().coeffRef(index);
80 return m_matrix
121 ExpressionTypeNested m_matrix; member in class:Eigen::Flagged
[all...]
H A DReverse.h98 inline Reverse(const MatrixType& matrix) : m_matrix(matrix) { }
102 inline Index rows() const { return m_matrix.rows(); }
103 inline Index cols() const { return m_matrix.cols(); }
107 return -m_matrix.innerStride();
118 return m_matrix.const_cast_derived().coeffRef(ReverseRow ? m_matrix.rows() - row - 1 : row,
119 ReverseCol ? m_matrix.cols() - col - 1 : col);
124 return m_matrix.coeff(ReverseRow ? m_matrix.rows() - row - 1 : row,
125 ReverseCol ? m_matrix
180 typename MatrixType::Nested m_matrix; member in class:Eigen::Reverse
[all...]
H A DSelfCwiseBinaryOp.h55 inline SelfCwiseBinaryOp(Lhs& xpr, const BinaryOp& func = BinaryOp()) : m_matrix(xpr), m_functor(func) {}
57 inline Index rows() const { return m_matrix.rows(); }
58 inline Index cols() const { return m_matrix.cols(); }
59 inline Index outerStride() const { return m_matrix.outerStride(); }
60 inline Index innerStride() const { return m_matrix.innerStride(); }
61 inline const Scalar* data() const { return m_matrix.data(); }
68 return m_matrix.const_cast_derived().coeffRef(row, col);
72 return m_matrix.coeffRef(row, col);
80 return m_matrix.const_cast_derived().coeffRef(index);
84 return m_matrix
164 Lhs& m_matrix; member in class:Eigen::SelfCwiseBinaryOp
[all...]
H A DDiagonal.h73 inline Diagonal(MatrixType& matrix, Index a_index = DiagIndex) : m_matrix(matrix), m_index(a_index) {}
78 { return m_index.value()<0 ? (std::min<Index>)(m_matrix.cols(),m_matrix.rows()+m_index.value()) : (std::min<Index>)(m_matrix.rows(),m_matrix.cols()-m_index.value()); }
84 return m_matrix.outerStride() + 1;
98 inline ScalarWithConstIfNotLvalue* data() { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), colOffset())); }
99 inline const Scalar* data() const { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), colOffset())); }
104 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset());
109 return m_matrix
145 typename MatrixType::Nested m_matrix; member in class:Eigen::Diagonal
[all...]
H A DSelfAdjointView.h72 inline SelfAdjointView(MatrixType& matrix) : m_matrix(matrix)
75 inline Index rows() const { return m_matrix.rows(); }
76 inline Index cols() const { return m_matrix.cols(); }
77 inline Index outerStride() const { return m_matrix.outerStride(); }
78 inline Index innerStride() const { return m_matrix.innerStride(); }
86 return m_matrix.coeff(row, col);
95 return m_matrix.const_cast_derived().coeffRef(row, col);
99 const MatrixTypeNestedCleaned& _expression() const { return m_matrix; }
101 const MatrixTypeNestedCleaned& nestedExpression() const { return m_matrix; }
102 MatrixTypeNestedCleaned& nestedExpression() { return *const_cast<MatrixTypeNestedCleaned*>(&m_matrix); }
189 MatrixTypeNested m_matrix; member in class:Eigen::SelfAdjointView
[all...]
H A DVectorwiseOp.h79 : m_matrix(mat), m_functor(func) {}
81 Index rows() const { return (Direction==Vertical ? 1 : m_matrix.rows()); }
82 Index cols() const { return (Direction==Horizontal ? 1 : m_matrix.cols()); }
87 return m_functor(m_matrix.col(j));
89 return m_functor(m_matrix.row(i));
95 return m_functor(m_matrix.col(index));
97 return m_functor(m_matrix.row(index));
101 MatrixTypeNested m_matrix; member in class:Eigen::PartialReduxExpr
208 return SubVector(m_matrix.derived(),i);
214 { return Direction==Vertical?m_matrix
587 ExpressionTypeNested m_matrix; member in class:Eigen::VectorwiseOp
[all...]
H A DReplicate.h74 : m_matrix(a_matrix), m_rowFactor(RowFactor), m_colFactor(ColFactor)
83 : m_matrix(a_matrix), m_rowFactor(rowFactor), m_colFactor(colFactor)
89 inline Index rows() const { return m_matrix.rows() * m_rowFactor.value(); }
90 inline Index cols() const { return m_matrix.cols() * m_colFactor.value(); }
97 : rowId%m_matrix.rows();
100 : colId%m_matrix.cols();
102 return m_matrix.coeff(actual_row, actual_col);
109 : rowId%m_matrix.rows();
112 : colId%m_matrix.cols();
114 return m_matrix
123 MatrixTypeNested m_matrix; member in class:Eigen::Replicate
[all...]
H A DCwiseUnaryView.h67 : m_matrix(mat), m_functor(func) {}
71 EIGEN_STRONG_INLINE Index rows() const { return m_matrix.rows(); }
72 EIGEN_STRONG_INLINE Index cols() const { return m_matrix.cols(); }
79 nestedExpression() const { return m_matrix; }
83 nestedExpression() { return m_matrix.const_cast_derived(); }
87 typename internal::nested<MatrixType>::type m_matrix; member in class:Eigen::CwiseUnaryView
H A DTriangularMatrix.h192 inline TriangularView(const MatrixType& matrix) : m_matrix(matrix)
195 inline Index rows() const { return m_matrix.rows(); }
196 inline Index cols() const { return m_matrix.cols(); }
197 inline Index outerStride() const { return m_matrix.outerStride(); }
198 inline Index innerStride() const { return m_matrix.innerStride(); }
201 template<typename Other> TriangularView& operator+=(const DenseBase<Other>& other) { return *this = m_matrix + other.derived(); }
203 template<typename Other> TriangularView& operator-=(const DenseBase<Other>& other) { return *this = m_matrix - other.derived(); }
205 TriangularView& operator*=(const typename internal::traits<MatrixType>::Scalar& other) { return *this = m_matrix * other; }
207 TriangularView& operator/=(const typename internal::traits<MatrixType>::Scalar& other) { return *this = m_matrix / other; }
225 return m_matrix
432 MatrixTypeNested m_matrix; member in class:Eigen::TriangularView
[all...]
/external/eigen/unsupported/Eigen/src/SparseExtra/
H A DBlockOfDynamicSparseMatrix.h39 : MatrixType::InnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
48 : m_matrix(matrix), m_outerStart(outerStart), m_outerSize(outerSize)
54 : m_matrix(matrix), m_outerStart(outer), m_outerSize(Size)
75 m_matrix.const_cast_derived()._data()[m_outerStart+j].swap(aux._data());
90 count += m_matrix._data()[m_outerStart+j].size();
97 eigen_assert(m_matrix.data()[m_outerStart].size()>0);
98 return m_matrix.data()[m_outerStart].vale(m_matrix.data()[m_outerStart].size()-1);
107 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); }
108 EIGEN_STRONG_INLINE Index cols() const { return IsRowMajor ? m_matrix
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseBlock.h33 : XprType::InnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
45 : XprType::ReverseInnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
54 : m_matrix(xpr), m_outerStart(i), m_outerSize(OuterSize)
58 : m_matrix(xpr), m_outerStart(IsRowMajor ? startRow : startCol), m_outerSize(IsRowMajor ? blockRows : blockCols)
61 EIGEN_STRONG_INLINE Index rows() const { return IsRowMajor ? m_outerSize.value() : m_matrix.rows(); }
62 EIGEN_STRONG_INLINE Index cols() const { return IsRowMajor ? m_matrix.cols() : m_outerSize.value(); }
66 typename XprType::Nested m_matrix; member in class:Eigen::BlockImpl
99 : SparseMatrixType::InnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
110 : SparseMatrixType::ReverseInnerIterator(xpr.m_matrix, xpr.m_outerStart + outer), m_outer(outer)
119 : m_matrix(xp
245 typename SparseMatrixType::Nested m_matrix; member in class:Eigen::BlockImpl
332 typename SparseMatrixType::Nested m_matrix; member in class:Eigen::BlockImpl
489 typename XprType::Nested m_matrix; member in class:Eigen::BlockImpl
[all...]
H A DSparsePermutation.h49 : m_permutation(perm), m_matrix(matrix)
52 inline int rows() const { return m_matrix.rows(); }
53 inline int cols() const { return m_matrix.cols(); }
59 SparseMatrix<Scalar,SrcStorageOrder,Index> tmp(m_matrix.rows(), m_matrix.cols());
60 Matrix<Index,Dynamic,1> sizes(m_matrix.outerSize());
61 for(Index j=0; j<m_matrix.outerSize(); ++j)
64 sizes[((Side==OnTheLeft) ^ Transposed) ? jp : j] = m_matrix.innerVector(((Side==OnTheRight) ^ Transposed) ? jp : j).nonZeros();
67 for(Index j=0; j<m_matrix.outerSize(); ++j)
72 for(typename MatrixTypeNestedCleaned::InnerIterator it(m_matrix,jsr
101 typename MatrixType::Nested m_matrix; member in struct:Eigen::internal::permut_sparsematrix_product_retval
[all...]
H A DSparseView.h40 m_matrix(mat), m_reference(m_reference), m_epsilon(m_epsilon) {}
44 inline Index rows() const { return m_matrix.rows(); }
45 inline Index cols() const { return m_matrix.cols(); }
47 inline Index innerSize() const { return m_matrix.innerSize(); }
48 inline Index outerSize() const { return m_matrix.outerSize(); }
51 MatrixTypeNested m_matrix; member in class:Eigen::SparseView
63 IterBase(view.m_matrix, outer), m_view(view)
H A DMappedSparseMatrix.h122 : m_matrix(mat),
131 inline Scalar value() const { return m_matrix.valuePtr()[m_id]; }
132 inline Scalar& valueRef() { return const_cast<Scalar&>(m_matrix.valuePtr()[m_id]); }
134 inline Index index() const { return m_matrix.innerIndexPtr()[m_id]; }
141 const MappedSparseMatrix& m_matrix; member in class:Eigen::MappedSparseMatrix::InnerIterator
153 : m_matrix(mat),
162 inline Scalar value() const { return m_matrix.valuePtr()[m_id-1]; }
163 inline Scalar& valueRef() { return const_cast<Scalar&>(m_matrix.valuePtr()[m_id-1]); }
165 inline Index index() const { return m_matrix.innerIndexPtr()[m_id-1]; }
172 const MappedSparseMatrix& m_matrix; member in class:Eigen::MappedSparseMatrix::ReverseInnerIterator
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DHessenbergDecomposition.h101 : m_matrix(size,size),
119 : m_matrix(matrix),
129 _compute(m_matrix, m_hCoeffs, m_temp);
152 m_matrix = matrix;
159 _compute(m_matrix, m_hCoeffs, m_temp);
215 return m_matrix;
235 return HouseholderSequenceType(m_matrix, m_hCoeffs.conjugate())
236 .setLength(m_matrix.rows() - 1)
273 MatrixType m_matrix; member in class:Eigen::HessenbergDecomposition
H A DTridiagonalization.h114 : m_matrix(size,size),
130 : m_matrix(matrix),
134 internal::tridiagonalization_inplace(m_matrix, m_hCoeffs);
157 m_matrix = matrix;
159 internal::tridiagonalization_inplace(m_matrix, m_hCoeffs);
220 return m_matrix;
241 return HouseholderSequenceType(m_matrix, m_hCoeffs.conjugate())
242 .setLength(m_matrix.rows() - 1)
266 return MatrixTReturnType(m_matrix.real());
298 MatrixType m_matrix; member in class:Eigen::Tridiagonalization
550 typename MatrixType::Nested m_matrix; member in struct:Eigen::internal::TridiagonalizationMatrixTReturnType
[all...]
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DTransform.h74 MatrixType m_matrix; member in class:Eigen::Transform
83 m_matrix = other.m_matrix;
92 { m_matrix = other.m_matrix; return *this; }
124 { m_matrix = other; return *this; }
135 /** shortcut for m_matrix(row,col);
137 inline Scalar operator() (int row, int col) const { return m_matrix(row,col); }
138 /** shortcut for m_matrix(row,col);
140 inline Scalar& operator() (int row, int col) { return m_matrix(ro
[all...]
/external/eigen/Eigen/src/Eigen2Support/
H A DMinor.h63 : m_matrix(matrix), m_row(row), m_col(col)
71 inline Index rows() const { return m_matrix.rows() - 1; }
72 inline Index cols() const { return m_matrix.cols() - 1; }
76 return m_matrix.const_cast_derived().coeffRef(row + (row >= m_row), col + (col >= m_col));
81 return m_matrix.coeff(row + (row >= m_row), col + (col >= m_col));
85 const typename MatrixType::Nested m_matrix; member in class:Eigen::Minor
H A DTriangularSolver.h30 return m_matrix.template triangularView<Added>().solve(other.derived());
37 m_matrix.template triangularView<Added>().solveInPlace(other.derived());
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DScaling.h81 m_matrix = mat;
91 for (int k=0; k<m_matrix.outerSize(); ++k)
93 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
115 for (int k=0; k<m_matrix.outerSize(); ++k)
117 for (typename MatrixType::InnerIterator it(m_matrix, k); it; ++it)
144 mat = m_matrix;
176 MatrixType m_matrix; member in class:Eigen::IterScaling
/external/eigen/Eigen/src/SparseCholesky/
H A DSimplicialCholesky_impl.h54 m_matrix.resize(size, size);
85 Index* Lp = m_matrix.outerIndexPtr();
90 m_matrix.resizeNonZeros(Lp[size]);
111 const Index* Lp = m_matrix.outerIndexPtr();
112 Index* Li = m_matrix.innerIndexPtr();
113 Scalar* Lx = m_matrix.valuePtr();
H A DSimplicialCholesky.h68 inline Index cols() const { return m_matrix.cols(); }
69 inline Index rows() const { return m_matrix.rows(); }
142 s << " L: " << ((total+=(m_matrix.cols()+1) * sizeof(int) + m_matrix.nonZeros()*(sizeof(int)+sizeof(Scalar))) >> 20) << "Mb" << "\n";
156 eigen_assert(m_matrix.rows()==b.rows());
166 if(m_matrix.nonZeros()>0) // otherwise L==I
172 if (m_matrix.nonZeros()>0) // otherwise U==I
233 CholMatrixType m_matrix; member in class:Eigen::SimplicialCholeskyBase
330 return Traits::getL(Base::m_matrix);
336 return Traits::getU(Base::m_matrix);
[all...]
/external/eigen/Eigen/src/Geometry/
H A DTransform.h226 MatrixType m_matrix; member in class:Eigen::Transform
235 internal::transform_make_affine<(int(Mode)==Affine) ? Affine : AffineCompact>::run(m_matrix);
241 m_matrix = other.m_matrix;
262 { m_matrix = other.m_matrix; return *this; }
293 m_matrix = other.matrix();
319 m_matrix.template block<Dim,Dim+1>(0,0) = other.matrix().template block<Dim,Dim+1>(0,0);
360 /** shortcut for m_matrix(row,col);
362 inline Scalar operator() (Index row, Index col) const { return m_matrix(ro
[all...]
/external/eigen/Eigen/src/PardisoSupport/
H A DPardisoSupport.h271 mutable SparseMatrixType m_matrix;
297 m_matrix.valuePtr(), m_matrix.outerIndexPtr(), m_matrix.innerIndexPtr(),
320 m_matrix.valuePtr(), m_matrix.outerIndexPtr(), m_matrix.innerIndexPtr(),
340 m_matrix.valuePtr(), m_matrix.outerIndexPtr(), m_matrix
[all...]
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h76 : m_matrix(),
89 : m_matrix(size, size),
102 : m_matrix(matrix.rows(), matrix.cols()),
123 return Traits::getU(m_matrix);
130 return Traits::getL(m_matrix);
145 return m_matrix.diagonal();
189 eigen_assert(m_matrix.rows()==b.rows()
218 return m_matrix;
223 inline Index rows() const { return m_matrix.rows(); }
224 inline Index cols() const { return m_matrix
245 MatrixType m_matrix; member in class:Eigen::LDLT
[all...]

Completed in 615 milliseconds

12