HomeSort by relevance Sort by last modified time
    Searched refs:Transpose (Results 1 - 25 of 40) sorted by null

1 2

  /external/eigen/failtest/
const_qualified_transpose_method_retval.cpp 12 Transpose<Matrix3d> b(m.transpose());
transpose_nonconst_ctor_on_const_xpr.cpp 12 Transpose<Matrix3d> t(m);
transpose_on_const_type_actually_const.cpp 13 Transpose<CV_QUALIFIER MatrixXf>(m).coeffRef(0, 0) = 1.0f;
  /external/eigen/Eigen/src/SparseCore/
SparseTranspose.h 16 : public SparseMatrixBase<Transpose<MatrixType> >
21 EIGEN_SPARSE_PUBLIC_INTERFACE(Transpose<MatrixType>)
SparseDenseProduct.h 110 template<typename Lhs, typename Rhs, bool Transpose>
111 class SparseDenseOuterProduct<Lhs,Rhs,Transpose>::InnerIterator : public _LhsNested::InnerIterator
121 inline Index row() const { return Transpose ? Base::row() : m_outer; }
122 inline Index col() const { return Transpose ? m_outer : Base::row(); }
279 Transpose<const _LhsNested> lhs_t(m_lhs);
280 Transpose<const _RhsNested> rhs_t(m_rhs);
281 Transpose<Dest> dest_t(dest);
SparseMatrixBase.h 100 CwiseUnaryOp<internal::scalar_conjugate_op<Scalar>, Eigen::Transpose<const Derived> >,
101 Transpose<const Derived>
201 const bool transpose = (Flags & RowMajorBit) != (OtherDerived::Flags & RowMajorBit); local
203 if ((!transpose) && other.isRValue())
230 //const bool transpose = (Flags & RowMajorBit) != (OtherDerived::Flags & RowMajorBit);
233 "the transpose operation is supposed to be handled in SparseMatrix::operator=");
238 //typedef typename internal::conditional<transpose, LinkedVectorMatrix<Scalar,Flags&RowMajorBit>, Derived>::type TempType;
391 Transpose<Derived> transpose() { return derived(); } function in class:Eigen::SparseMatrixBase
392 const Transpose<const Derived> transpose() const { return derived(); function in class:Eigen::SparseMatrixBase
    [all...]
SparseDiagonalProduct.h 156 Transpose<const typename Rhs::DiagonalVectorType> >::InnerIterator
161 Transpose<const typename Rhs::DiagonalVectorType> >::InnerIterator Base;
166 : Base(expr.lhs().innerVector(outer) .cwiseProduct(expr.rhs().diagonal().transpose()), 0)
SparsePermutation.h 86 perm = m_permutation.transpose();
132 operator*(const SparseMatrixBase<SparseDerived>& matrix, const Transpose<PermutationBase<PermDerived> >& tperm)
141 operator*(const Transpose<PermutationBase<PermDerived> >& tperm, const SparseMatrixBase<SparseDerived>& matrix)
SparseUtil.h 85 template<typename Lhs, typename Rhs, bool Transpose> class SparseDenseOuterProduct;
  /external/eigen/Eigen/src/Core/
Transpose.h 16 /** \class Transpose
19 * \brief Expression of the transpose of a matrix
21 * \param MatrixType the type of the object of which we are taking the transpose
23 * This class represents an expression of the transpose of a matrix.
24 * It is the return type of MatrixBase::transpose() and MatrixBase::adjoint()
27 * \sa MatrixBase::transpose(), MatrixBase::adjoint()
32 struct traits<Transpose<MatrixType> > : traits<MatrixType>
57 template<typename MatrixType> class Transpose
63 EIGEN_GENERIC_PUBLIC_INTERFACE(Transpose)
65 inline Transpose(MatrixType& matrix) : m_matrix(matrix) {
198 DenseBase<Derived>::transpose() function in class:Eigen::DenseBase
210 DenseBase<Derived>::transpose() const function in class:Eigen::DenseBase
    [all...]
Transpositions.h 136 inline Transpose<TranspositionsBase> inverse() const
137 { return Transpose<TranspositionsBase>(derived()); }
140 inline Transpose<TranspositionsBase> transpose() const function in class:Eigen::TranspositionsBase
141 { return Transpose<TranspositionsBase>(derived()); }
402 class Transpose<TranspositionsBase<TranspositionsDerived> >
408 Transpose(const TranspositionType& t) : m_transpositions(t) {}
416 operator*(const MatrixBase<Derived>& matrix, const Transpose& trt)
PermutationMatrix.h 201 inline Transpose<PermutationBase> inverse() const
207 inline Transpose<PermutationBase> transpose() const function in class:Eigen::PermutationBase
243 inline PlainPermutationType operator*(const Transpose<PermutationBase<Other> >& other) const
251 inline PlainPermutationType operator*(const Transpose<PermutationBase<Other> >& other, const PermutationBase& perm)
367 PermutationMatrix(const Transpose<PermutationBase<Other> >& other)
606 struct traits<Transpose<PermutationBase<Derived> > >
613 class Transpose<PermutationBase<Derived> >
614 : public EigenBase<Transpose<PermutationBase<Derived> > >
635 Transpose(const PermutationType& p) : m_permutation(p) {
    [all...]
SolveTriangular.h 125 rhs.coeffRef(I) -= lhs.row(I).template segment<Index>(S).transpose()
150 Transpose<const Lhs> trLhs(lhs);
151 Transpose<Rhs> trRhs(rhs);
153 triangular_solver_unroller<Transpose<const Lhs>,Transpose<Rhs>,
DenseBase.h 273 Eigen::Transpose<Derived> transpose();
274 typedef const Transpose<const Derived> ConstTransposeReturnType;
275 ConstTransposeReturnType transpose() const;
  /external/ceres-solver/internal/ceres/
compressed_row_sparse_matrix.h 125 CompressedRowSparseMatrix* Transpose() const;
compressed_row_sparse_matrix_test.cc 275 TEST(CompressedRowSparseMatrix, Transpose) {
318 scoped_ptr<CompressedRowSparseMatrix> transpose(matrix.Transpose());
324 transpose->ToDenseMatrix(&dense_transpose);
325 EXPECT_NEAR((dense_matrix - dense_transpose.transpose()).norm(), 0.0, 1e-14);
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrix.h 36 // transpose the product such that the result is column major
277 Transpose = StorageOrder==RowMajor,
278 ActualRows = Transpose ? MaxCols : MaxRows,
279 ActualCols = Transpose ? MaxRows : MaxCols
281 typedef typename conditional<Transpose,_RhsScalar,_LhsScalar>::type LhsScalar;
282 typedef typename conditional<Transpose,_LhsScalar,_RhsScalar>::type RhsScalar;
319 Transpose = StorageOrder==RowMajor
321 typedef typename conditional<Transpose,_RhsScalar,_LhsScalar>::type LhsScalar;
322 typedef typename conditional<Transpose,_LhsScalar,_RhsScalar>::type RhsScalar;
333 this->m_mc = Transpose ? cols : rows
    [all...]
SelfadjointMatrixVector.h 265 // let's simply transpose the product
266 Transpose<Dest> destT(dest);
267 SelfadjointProductMatrix<Transpose<const Rhs>, int(RhsUpLo)==Upper ? Lower : Upper, false,
268 Transpose<const Lhs>, 0, true>(m_rhs.transpose(), m_lhs.transpose()).scaleAndAddTo(destT, alpha);
TriangularMatrixVector.h 120 res.coeffRef(i) += alpha * (cjLhs.row(i).segment(s,r).cwiseProduct(cjRhs.segment(s,r).transpose())).sum();
194 typedef TriangularProduct<(Mode & (UnitDiag|ZeroDiag)) | ((Mode & Lower) ? Upper : Lower),true,Transpose<const Rhs>,false,Transpose<const Lhs>,true> TriangularProductTranspose;
195 Transpose<Dest> dstT(dst);
197 TriangularProductTranspose(m_rhs.transpose(),m_lhs.transpose()), dstT, alpha);
  /external/eigen/Eigen/src/Cholesky/
LLT_MKL.h 88 Transpose<MatrixType> matt(mat); \
LLT.h 336 Transpose<MatrixType> matt(mat);
342 Transpose<MatrixType> matt(mat);
348 Transpose<MatrixType> matt(mat);
LDLT.h 395 Transpose<MatrixType> matt(mat);
402 Transpose<MatrixType> matt(mat);
514 dst = dec().transpositionsP().transpose() * dst;
565 res = transpositionsP().transpose() * res;
  /external/eigen/Eigen/src/Core/util/
BlasUtil.h 216 // pop/push transpose
218 struct blas_traits<Transpose<NestedXpr> >
223 typedef Transpose<NestedXpr> XprType;
224 typedef Transpose<const typename Base::_ExtractType> ExtractType; // const to get rid of a compile error; anyway blas traits are only used on the RHS
225 typedef Transpose<const typename Base::_ExtractType> _ExtractType;
  /external/chromium_org/ui/gfx/
transform.h 166 void Transpose();
  /external/eigen/test/eigen2/
eigen2_triangular.cpp 45 VERIFY(m2up.transpose().isLowerTriangular());
49 // VERIFY_IS_APPROX(m1up.transpose() * m2, m1.upper().transpose().lower() * m2);
60 m1.template part<Eigen::UpperTriangular>() = (m2.transpose() * m2).lazy();
61 m3 = m2.transpose() * m2;
62 VERIFY_IS_APPROX(m3.template part<Eigen::LowerTriangular>().transpose(), m1);
66 m1.template part<Eigen::LowerTriangular>() = (m2.transpose() * m2).lazy();
75 Transpose<MatrixType> trm4(m4);
79 VERIFY(m3.transpose().template marked<Eigen::UpperTriangular>()
80 .solveTriangular(m3.transpose()).cwise().abs().isIdentity(test_precision<RealScalar>()))
    [all...]

Completed in 281 milliseconds

1 2