Go to the documentation of this file.
11 #ifndef EIGEN_TRIANGULARMATRIX_H
12 #define EIGEN_TRIANGULARMATRIX_H
18 template<
int S
ide,
typename TriangularType,
typename Rhs>
struct triangular_solve_retval;
82 template<
typename Other>
102 #ifndef EIGEN_PARSED_BY_DOXYGEN
104 inline const Derived&
derived()
const {
return *
static_cast<const Derived*
>(
this); }
106 inline Derived&
derived() {
return *
static_cast<Derived*
>(
this); }
107 #endif // not EIGEN_PARSED_BY_DOXYGEN
109 template<
typename DenseDerived>
112 template<
typename DenseDerived>
139 #ifdef EIGEN_INTERNAL_DEBUGGING
168 template<
typename MatrixType,
unsigned int _Mode>
187 :
public TriangularViewImpl<_MatrixType, _Mode, typename internal::traits<_MatrixType>::StorageKind >
220 using Base::operator=;
222 {
return Base::operator=(other); }
257 typename MatrixType::TransposeReturnType tmp(
m_matrix);
269 template<
typename Other>
277 template<
int S
ide,
typename Other>
281 {
return Base::template solve<Side>(other); }
347 using Base::evalToLazy;
367 template<
typename Other>
374 template<
typename Other>
394 {
return *
this = MatrixType::Constant(derived().rows(), derived().cols(), value); }
408 Base::check_coordinates_internal(
row,
col);
409 return derived().nestedExpression().coeff(
row,
col);
419 Base::check_coordinates_internal(
row,
col);
420 return derived().nestedExpression().coeffRef(
row,
col);
424 template<
typename OtherDerived>
429 template<
typename OtherDerived>
433 #ifndef EIGEN_PARSED_BY_DOXYGEN
436 {
return *
this = other.derived().nestedExpression(); }
439 template<
typename OtherDerived>
444 template<
typename OtherDerived>
450 template<
typename OtherDerived>
459 template<
typename OtherDerived>
friend
490 template<
int S
ide,
typename Other>
504 template<
int S
ide,
typename OtherDerived>
508 template<
typename OtherDerived>
511 {
return solveInPlace<OnTheLeft>(other); }
514 template<
typename OtherDerived>
516 #ifdef EIGEN_PARSED_BY_DOXYGEN
528 template<
typename OtherDerived>
536 template<
typename RhsType,
typename DstType>
541 this->solveInPlace(dst);
544 template<
typename ProductType>
553 #ifndef EIGEN_PARSED_BY_DOXYGEN
555 template<
typename MatrixType,
unsigned int Mode>
556 template<
typename OtherDerived>
557 inline TriangularView<MatrixType, Mode>&
558 TriangularViewImpl<MatrixType, Mode, Dense>::operator=(
const MatrixBase<OtherDerived>& other)
565 template<
typename MatrixType,
unsigned int Mode>
566 template<
typename OtherDerived>
567 void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(
const MatrixBase<OtherDerived>& other)
574 template<
typename MatrixType,
unsigned int Mode>
575 template<
typename OtherDerived>
576 inline TriangularView<MatrixType, Mode>&
577 TriangularViewImpl<MatrixType, Mode, Dense>::operator=(
const TriangularBase<OtherDerived>& other)
584 template<
typename MatrixType,
unsigned int Mode>
585 template<
typename OtherDerived>
586 void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(
const TriangularBase<OtherDerived>& other)
599 template<
typename Derived>
600 template<
typename DenseDerived>
603 evalToLazy(other.derived());
625 template<
typename Derived>
626 template<
unsigned int Mode>
634 template<
typename Derived>
635 template<
unsigned int Mode>
647 template<
typename Derived>
651 for(
Index j = 0; j < cols(); ++j)
657 if(absValue > maxAbsOnUpperPart) maxAbsOnUpperPart = absValue;
660 RealScalar threshold = maxAbsOnUpperPart * prec;
661 for(
Index j = 0; j < cols(); ++j)
662 for(
Index i = j+1; i < rows(); ++i)
663 if(
numext::abs(coeff(i, j)) > threshold)
return false;
672 template<
typename Derived>
676 for(
Index j = 0; j < cols(); ++j)
677 for(
Index i = j; i < rows(); ++i)
680 if(absValue > maxAbsOnLowerPart) maxAbsOnLowerPart = absValue;
682 RealScalar threshold = maxAbsOnLowerPart * prec;
683 for(
Index j = 1; j < cols(); ++j)
687 if(
numext::abs(coeff(i, j)) > threshold)
return false;
705 template<
typename MatrixType,
unsigned int Mode>
709 typedef typename glue_shapes<typename evaluator_traits<MatrixType>::Shape,
TriangularShape>::type
Shape;
712 template<
typename MatrixType,
unsigned int Mode>
714 :
evaluator<typename internal::remove_all<MatrixType>::type>
724 struct Dense2Triangular {};
735 template<
int UpLo,
int Mode,
int SetOpposite,
typename DstEvaluatorTypeT,
typename SrcEvaluatorTypeT,
typename Functor,
int Version = Specialized>
754 :
Base(dst, src, func, dstExpr)
757 #ifdef EIGEN_INTERNAL_DEBUGGING
782 template<
int Mode,
bool SetOpposite,
typename DstXprType,
typename SrcXprType,
typename Functor>
786 typedef evaluator<DstXprType> DstEvaluatorType;
787 typedef evaluator<SrcXprType> SrcEvaluatorType;
789 SrcEvaluatorType srcEvaluator(src);
791 Index dstRows = src.rows();
792 Index dstCols = src.cols();
793 if((dst.rows()!=dstRows) || (dst.cols()!=dstCols))
794 dst.resize(dstRows, dstCols);
795 DstEvaluatorType dstEvaluator(dst);
798 DstEvaluatorType,SrcEvaluatorType,Functor> Kernel;
799 Kernel kernel(dstEvaluator, srcEvaluator, func, dst.const_cast_derived());
802 unroll = DstXprType::SizeAtCompileTime !=
Dynamic
803 && SrcEvaluatorType::CoeffReadCost <
HugeCost
804 && DstXprType::SizeAtCompileTime * (DstEvaluatorType::CoeffReadCost+SrcEvaluatorType::CoeffReadCost) / 2 <=
EIGEN_UNROLLING_LIMIT
807 triangular_assignment_loop<Kernel, Mode, unroll ?
int(DstXprType::SizeAtCompileTime) :
Dynamic, SetOpposite>::
run(kernel);
810 template<
int Mode,
bool SetOpposite,
typename DstXprType,
typename SrcXprType>
814 call_triangular_assignment_loop<Mode,SetOpposite>(dst, src, internal::assign_op<typename DstXprType::Scalar,typename SrcXprType::Scalar>());
819 template<>
struct AssignmentKind<TriangularShape,DenseShape> {
typedef Dense2Triangular
Kind; };
822 template<
typename DstXprType,
typename SrcXprType,
typename Functor>
825 EIGEN_DEVICE_FUNC
static void run(DstXprType &dst,
const SrcXprType &src,
const Functor &func)
829 call_triangular_assignment_loop<DstXprType::Mode, false>(dst, src, func);
833 template<
typename DstXprType,
typename SrcXprType,
typename Functor>
834 struct Assignment<DstXprType, SrcXprType, Functor, Triangular2Dense>
836 EIGEN_DEVICE_FUNC
static void run(DstXprType &dst,
const SrcXprType &src,
const Functor &func)
838 call_triangular_assignment_loop<SrcXprType::Mode, (SrcXprType::Mode&SelfAdjoint)==0>(dst, src, func);
842 template<
typename DstXprType,
typename SrcXprType,
typename Functor>
845 EIGEN_DEVICE_FUNC
static void run(DstXprType &dst,
const SrcXprType &src,
const Functor &func)
847 call_triangular_assignment_loop<DstXprType::Mode, false>(dst, src, func);
852 template<
typename Kernel,
unsigned int Mode,
int UnrollCount,
bool SetOpposite>
857 typedef typename DstEvaluatorType::XprType
DstXprType;
860 col = (UnrollCount-1) / DstXprType::RowsAtCompileTime,
861 row = (UnrollCount-1) % DstXprType::RowsAtCompileTime
867 static inline void run(Kernel &kernel)
872 kernel.assignDiagonalCoeff(
row);
874 kernel.assignCoeff(
row,
col);
876 kernel.assignOppositeCoeff(
row,
col);
881 template<
typename Kernel,
unsigned int Mode,
bool SetOpposite>
882 struct triangular_assignment_loop<Kernel, Mode, 0, SetOpposite>
885 static inline void run(Kernel &) {}
894 template<
typename Kernel,
unsigned int Mode,
bool SetOpposite>
899 static inline void run(Kernel &kernel)
901 for(
Index j = 0; j < kernel.cols(); ++j)
905 if (((Mode&
Lower) && SetOpposite) || (Mode&
Upper))
908 if(Mode&
Upper) kernel.assignCoeff(i, j);
909 else kernel.assignOppositeCoeff(i, j);
915 kernel.assignDiagonalCoeff(i++);
917 if (((Mode&
Upper) && SetOpposite) || (Mode&
Lower))
919 for(; i < kernel.rows(); ++i)
920 if(Mode&
Lower) kernel.assignCoeff(i, j);
921 else kernel.assignOppositeCoeff(i, j);
931 template<
typename Derived>
932 template<
typename DenseDerived>
935 other.derived().
resize(this->rows(), this->cols());
942 template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
950 if((dst.rows()!=dstRows) || (dst.cols()!=dstCols))
951 dst.resize(dstRows, dstCols);
953 dst._assignProduct(src, 1, 0);
958 template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
964 dst._assignProduct(src, 1, 1);
969 template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
975 dst._assignProduct(src, -1, 1);
983 #endif // EIGEN_TRIANGULARMATRIX_H
EIGEN_DEVICE_FUNC void swap(TriangularBase< OtherDerived > const &other)
EIGEN_DEVICE_FUNC void solveInPlace(const MatrixBase< OtherDerived > &other) const
const Functor & m_functor
EIGEN_DEVICE_FUNC Scalar & coeffRef(Index row, Index col)
EIGEN_DEVICE_FUNC Index innerStride() const
static void run(DstXprType &dst, const SrcXprType &src, const internal::assign_op< Scalar, typename SrcXprType::Scalar > &)
internal::traits< TriangularView >::MatrixTypeNestedNonRef MatrixTypeNestedNonRef
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Index rows() const
TriangularBase< TriangularViewType > Base
remove_all< MatrixTypeNested >::type MatrixTypeNestedCleaned
Kernel::DstEvaluatorType DstEvaluatorType
#define EIGEN_UNROLLING_LIMIT
EIGEN_DEVICE_FUNC TriangularView(MatrixType &matrix)
Map< Matrix< Scalar, Dynamic, Dynamic, ColMajor >, 0, OuterStride<> > MatrixType
bool is_same_dense(const T1 &mat1, const T2 &mat2, typename enable_if< has_direct_access< T1 >::ret &&has_direct_access< T2 >::ret, T1 >::type *=0)
Eigen::Index Index
The interface type of indices.
remove_reference< MatrixTypeNested >::type MatrixTypeNestedNonRef
EIGEN_DEVICE_FUNC TriangularViewType & operator=(const TriangularViewImpl &other)
EIGEN_DEVICE_FUNC void assignOppositeCoeff(Index row, Index col)
EIGEN_DEVICE_FUNC Index rows() const
const EIGEN_DEVICE_FUNC SelfAdjointView< MatrixTypeNestedNonRef, Mode > selfadjointView() const
EIGEN_DEVICE_FUNC ColXpr col(Index i)
This is the const version of col().
TriangularView< typename MatrixType::TransposeReturnType, TransposeMode > TransposeReturnType
TriangularView< const typename MatrixType::AdjointReturnType, TransposeMode > AdjointReturnType
EIGEN_DEVICE_FUNC void evalToLazy(MatrixBase< DenseDerived > &other) const
static EIGEN_DEVICE_FUNC void run(Kernel &kernel)
friend const EIGEN_DEVICE_FUNC Product< OtherDerived, TriangularViewType > operator*(const MatrixBase< OtherDerived > &lhs, const TriangularViewImpl &rhs)
internal::remove_all< typename MatrixType::ConjugateReturnType >::type MatrixConjugateReturnType
MatrixTypeNested m_matrix
Base::DstXprType DstXprType
EIGEN_DEVICE_FUNC TransposeReturnType transpose()
Expression of a selfadjoint matrix from a triangular part of a dense matrix.
MatrixType::PlainObject FullMatrixType
TriangularView< const typename MatrixType::ConstTransposeReturnType, TransposeMode > ConstTransposeReturnType
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_assignment_no_alias(Dst &dst, const Src &src, const Func &func)
EIGEN_DEVICE_FUNC Index rows() const
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void copyCoeff(Index row, Index col, Other &other)
Map< Matrix< T, Dynamic, Dynamic, ColMajor >, 0, OuterStride<> > matrix(T *data, int rows, int cols, int stride)
EIGEN_DEVICE_FUNC TriangularBase()
EIGEN_DEVICE_FUNC Scalar coeff(Index row, Index col) const
EIGEN_DEVICE_FUNC Scalar & coeffRef(Index row, Index col)
SrcEvaluatorTypeT SrcEvaluatorType
#define eigen_internal_assert(x)
const unsigned int DirectAccessBit
DstEvaluatorTypeT DstEvaluatorType
void resize(Index rows, Index cols)
#define EIGEN_ONLY_USED_FOR_DEBUG(x)
const unsigned int PacketAccessBit
const EIGEN_DEVICE_FUNC ConjugateReturnType conjugate() const
DstEvaluatorType::Scalar Scalar
Base::AssignmentTraits AssignmentTraits
Base::SrcEvaluatorType SrcEvaluatorType
internal::traits< Derived >::FullMatrixType DenseMatrixType
DenseMatrixType DenseType
NumTraits< Scalar >::Real RealScalar
internal::traits< TriangularView >::MatrixTypeNested MatrixTypeNested
DenseMatrixType PlainObject
generic_dense_assignment_kernel< DstEvaluatorTypeT, SrcEvaluatorTypeT, Functor, Version > Base
EIGEN_DEVICE_FUNC Index outerStride() const
EIGEN_DEVICE_FUNC Index outerStride() const
TriangularView< _MatrixType, _Mode > TriangularViewType
#define EIGEN_UNUSED_VARIABLE(var)
internal::traits< TriangularView >::Scalar Scalar
const unsigned int LvalueBit
EIGEN_DEVICE_FUNC TriangularViewType & setZero()
EIGEN_DEVICE_FUNC Scalar operator()(Index row, Index col) const
DstEvaluatorType::XprType DstXprType
EIGEN_DEVICE_FUNC void fill(const Scalar &value)
Base class for triangular part in a matrix.
const EIGEN_DEVICE_FUNC Product< TriangularViewType, OtherDerived > operator*(const MatrixBase< OtherDerived > &rhs) const
EIGEN_DEVICE_FUNC void evalTo(MatrixBase< DenseDerived > &other) const
ref_selector< MatrixType >::non_const_type MatrixTypeNested
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void _solve_impl(const RhsType &rhs, DstType &dst) const
SrcEvaluatorTypeT::XprType SrcXprType
const EIGEN_DEVICE_FUNC ConstTransposeReturnType transpose() const
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE T mini(const T &x, const T &y)
EIGEN_DEVICE_FUNC NestedExpression & nestedExpression()
EIGEN_DEVICE_FUNC RowXpr row(Index i)
This is the const version of row(). */.
const SrcEvaluatorType & m_src
EIGEN_DEVICE_FUNC TriangularViewType & operator-=(const DenseBase< Other > &other)
#define EIGEN_STRONG_INLINE
static void run(DstXprType &dst, const SrcXprType &src, const internal::sub_assign_op< Scalar, typename SrcXprType::Scalar > &)
TriangularView< const MatrixConjugateReturnType, Mode > ConjugateReturnType
storage_kind_to_shape< typename traits< T >::StorageKind >::Shape Shape
MatrixType::PlainObject DenseMatrixType
Expression of the product of two arbitrary matrices or vectors.
EIGEN_DEVICE_FUNC TriangularViewReturnType< Mode >::Type triangularView()
EIGEN_DEVICE_FUNC TriangularViewType & operator*=(const typename internal::traits< MatrixType >::Scalar &other)
TriangularViewImpl< _MatrixType, _Mode, typename internal::traits< _MatrixType >::StorageKind > Base
EIGEN_DEVICE_FUNC Index cols() const
EIGEN_DEVICE_FUNC Derived & derived()
EIGEN_DEVICE_FUNC Scalar determinant() const
bool isLowerTriangular(const RealScalar &prec=NumTraits< Scalar >::dummy_precision()) const
const unsigned int LinearAccessBit
EIGEN_DEVICE_FUNC TriangularViewType & setConstant(const Scalar &value)
internal::traits< TriangularView >::MatrixTypeNestedCleaned NestedExpression
Pseudo expression representing a solving operation.
const EIGEN_DEVICE_FUNC AdjointReturnType adjoint() const
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Index cols() const
EIGEN_DEVICE_FUNC Scalar coeff(Index row, Index col) const
Base class for all dense matrices, vectors, and arrays.
Base::DstEvaluatorType DstEvaluatorType
#define EIGEN_STATIC_ASSERT(CONDITION, MSG)
EIGEN_DEVICE_FUNC Scalar & operator()(Index row, Index col)
EIGEN_DEVICE_FUNC TriangularViewType & setOnes()
EIGEN_DEVICE_FUNC Index cols() const
void run(Expr &expr, Dev &dev)
const EIGEN_DEVICE_FUNC NestedExpression & nestedExpression() const
Product< Lhs, Rhs, DefaultProduct > SrcXprType
const EIGEN_DEVICE_FUNC Solve< TriangularView, Other > solve(const MatrixBase< Other > &other) const
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_triangular_assignment_loop(DstXprType &dst, const SrcXprType &src, const Functor &func)
internal::traits< TriangularViewType >::Scalar Scalar
storage_kind_to_evaluator_kind< typename traits< T >::StorageKind >::Kind Kind
DstEvaluatorTypeT::XprType DstXprType
MatrixType ExpressionType
void check_coordinates(Index row, Index col) const
EIGEN_DEVICE_FUNC TriangularViewType & operator+=(const DenseBase< Other > &other)
Product< Lhs, Rhs, DefaultProduct > SrcXprType
EIGEN_DEVICE_FUNC triangular_dense_assignment_kernel(DstEvaluatorType &dst, const SrcEvaluatorType &src, const Functor &func, DstXprType &dstExpr)
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE internal::enable_if< NumTraits< T >::IsSigned||NumTraits< T >::IsComplex, typename NumTraits< T >::Real >::type abs(const T &x)
EIGEN_DEVICE_FUNC TriangularViewType & operator/=(const typename internal::traits< MatrixType >::Scalar &other)
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void assignCoeff(Index row, Index col)
Assign src(row,col) to dst(row,col) through the assignment functor.
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE T maxi(const T &x, const T &y)
EIGEN_DEVICE_FUNC void resize(Index newSize)
internal::traits< Derived >::StorageKind StorageKind
Base class for all dense matrices, vectors, and expressions.
TriangularView & operator=(const TriangularView &other)
EIGEN_DEVICE_FUNC Index innerStride() const
Base::SrcXprType SrcXprType
#define EIGEN_STATIC_ASSERT_LVALUE(Derived)
EIGEN_DEVICE_FUNC void assignDiagonalCoeff(Index id)
internal::traits< TriangularView >::StorageKind StorageKind
const unsigned int HereditaryBits
Expression of a triangular part in a matrix.
int EIGEN_BLAS_FUNC() swap(int *n, RealScalar *px, int *incx, RealScalar *py, int *incy)
static void run(DstXprType &dst, const SrcXprType &src, const internal::add_assign_op< Scalar, typename SrcXprType::Scalar > &)
EIGEN_DEVICE_FUNC Derived & const_cast_derived() const
internal::traits< Derived >::Scalar Scalar
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_assignment(Dst &dst, const Src &src)
internal::traits< Derived >::StorageIndex StorageIndex
const EIGEN_DEVICE_FUNC Derived & derived() const
void check_coordinates_internal(Index, Index) const
internal::traits< TriangularViewType >::StorageKind StorageKind
EIGEN_DEVICE_FUNC DenseMatrixType toDenseMatrix() const
bool isUpperTriangular(const RealScalar &prec=NumTraits< Scalar >::dummy_precision()) const
Product< Lhs, Rhs, DefaultProduct > SrcXprType
EIGEN_DEVICE_FUNC SelfAdjointView< MatrixTypeNestedNonRef, Mode > selfadjointView()
EIGEN_DEFAULT_DENSE_INDEX_TYPE Index
The Index type as used for the API.
EIGEN_DEVICE_FUNC void swap(MatrixBase< OtherDerived > const &other)
control_box_rst
Author(s): Christoph Rösmann
autogenerated on Wed Mar 2 2022 00:07:10