11#ifndef EIGEN_TRIANGULARMATRIX_H
12#define EIGEN_TRIANGULARMATRIX_H
18template<
int S
ide,
typename TriangularType,
typename Rhs>
struct triangular_solve_retval;
83 template<
typename Other>
103 #ifndef EIGEN_PARSED_BY_DOXYGEN
105 inline const Derived&
derived()
const {
return *
static_cast<const Derived*
>(
this); }
107 inline Derived&
derived() {
return *
static_cast<Derived*
>(
this); }
110 template<
typename DenseDerived>
113 template<
typename DenseDerived>
132 const int mode = int(
Mode) & ~SelfAdjoint;
140 #ifdef EIGEN_INTERNAL_DEBUGGING
169template<
typename MatrixType,
unsigned int _Mode>
188 :
public TriangularViewImpl<_MatrixType, _Mode, typename internal::traits<_MatrixType>::StorageKind >
254 return ReturnType(
m_matrix.template conjugateIf<Cond>());
269 typename MatrixType::TransposeReturnType tmp(
m_matrix);
281 template<
typename Other>
289 template<
int S
ide,
typename Other>
293 {
return Base::template solve<Side>(other); }
359 using Base::evalToLazy;
379 template<
typename Other>
386 template<
typename Other>
406 {
return *
this = MatrixType::Constant(derived().rows(), derived().cols(),
value); }
420 Base::check_coordinates_internal(
row,
col);
421 return derived().nestedExpression().coeff(
row,
col);
431 Base::check_coordinates_internal(
row,
col);
432 return derived().nestedExpression().coeffRef(
row,
col);
436 template<
typename OtherDerived>
441 template<
typename OtherDerived>
445#ifndef EIGEN_PARSED_BY_DOXYGEN
448 {
return *
this = other.derived().nestedExpression(); }
450 template<
typename OtherDerived>
455 template<
typename OtherDerived>
462 template<
typename OtherDerived>
471 template<
typename OtherDerived>
friend
502 template<
int S
ide,
typename Other>
515 template<
int S
ide,
typename OtherDerived>
519 template<
typename OtherDerived>
522 {
return solveInPlace<OnTheLeft>(other); }
525 template<
typename OtherDerived>
527#ifdef EIGEN_PARSED_BY_DOXYGEN
538 template<
typename OtherDerived>
547 template<
typename RhsType,
typename DstType>
552 this->solveInPlace(dst);
555 template<
typename ProductType>
568#ifndef EIGEN_PARSED_BY_DOXYGEN
570template<
typename MatrixType,
unsigned int Mode>
571template<
typename OtherDerived>
580template<
typename MatrixType,
unsigned int Mode>
581template<
typename OtherDerived>
582EIGEN_DEVICE_FUNC void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(
const MatrixBase<OtherDerived>& other)
589template<
typename MatrixType,
unsigned int Mode>
590template<
typename OtherDerived>
592TriangularViewImpl<MatrixType, Mode, Dense>::operator=(
const TriangularBase<OtherDerived>& other)
599template<
typename MatrixType,
unsigned int Mode>
600template<
typename OtherDerived>
601EIGEN_DEVICE_FUNC void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(
const TriangularBase<OtherDerived>& other)
614template<
typename Derived>
615template<
typename DenseDerived>
618 evalToLazy(other.derived());
640template<
typename Derived>
641template<
unsigned int Mode>
650template<
typename Derived>
651template<
unsigned int Mode>
664template<
typename Derived>
668 for(
Index j = 0; j < cols(); ++j)
674 if(absValue > maxAbsOnUpperPart) maxAbsOnUpperPart = absValue;
677 RealScalar threshold = maxAbsOnUpperPart * prec;
678 for(
Index j = 0; j < cols(); ++j)
679 for(
Index i = j+1; i < rows(); ++i)
680 if(
numext::abs(coeff(i, j)) > threshold)
return false;
689template<
typename Derived>
693 for(
Index j = 0; j < cols(); ++j)
694 for(
Index i = j; i < rows(); ++i)
697 if(absValue > maxAbsOnLowerPart) maxAbsOnLowerPart = absValue;
699 RealScalar threshold = maxAbsOnLowerPart * prec;
700 for(
Index j = 1; j < cols(); ++j)
704 if(
numext::abs(coeff(i, j)) > threshold)
return false;
722template<
typename MatrixType,
unsigned int Mode>
729template<
typename MatrixType,
unsigned int Mode>
731 :
evaluator<typename internal::remove_all<MatrixType>::type>
753template<
int UpLo,
int Mode,
int SetOpposite,
typename DstEvaluatorTypeT,
typename SrcEvaluatorTypeT,
typename Functor,
int Version = Specialized>
772 :
Base(dst, src, func, dstExpr)
775#ifdef EIGEN_INTERNAL_DEBUGGING
800template<
int Mode,
bool SetOpposite,
typename DstXprType,
typename SrcXprType,
typename Functor>
807 SrcEvaluatorType srcEvaluator(src);
809 Index dstRows = src.rows();
810 Index dstCols = src.cols();
811 if((dst.rows()!=dstRows) || (dst.cols()!=dstCols))
812 dst.resize(dstRows, dstCols);
813 DstEvaluatorType dstEvaluator(dst);
816 DstEvaluatorType,SrcEvaluatorType,Functor> Kernel;
817 Kernel kernel(dstEvaluator, srcEvaluator, func, dst.const_cast_derived());
820 unroll = DstXprType::SizeAtCompileTime !=
Dynamic
821 && SrcEvaluatorType::CoeffReadCost <
HugeCost
822 && DstXprType::SizeAtCompileTime * (int(DstEvaluatorType::CoeffReadCost) + int(SrcEvaluatorType::CoeffReadCost)) / 2 <=
EIGEN_UNROLLING_LIMIT
828template<
int Mode,
bool SetOpposite,
typename DstXprType,
typename SrcXprType>
840template<
typename DstXprType,
typename SrcXprType,
typename Functor>
845 eigen_assert(
int(DstXprType::Mode) ==
int(SrcXprType::Mode));
847 call_triangular_assignment_loop<DstXprType::Mode, false>(dst, src, func);
851template<
typename DstXprType,
typename SrcXprType,
typename Functor>
856 call_triangular_assignment_loop<SrcXprType::Mode, (int(SrcXprType::Mode) & int(SelfAdjoint)) == 0>(dst, src, func);
860template<
typename DstXprType,
typename SrcXprType,
typename Functor>
865 call_triangular_assignment_loop<DstXprType::Mode, false>(dst, src, func);
870template<
typename Kernel,
unsigned int Mode,
int UnrollCount,
bool SetOpposite>
878 col = (UnrollCount-1) / DstXprType::RowsAtCompileTime,
879 row = (UnrollCount-1) % DstXprType::RowsAtCompileTime
885 static inline void run(Kernel &kernel)
890 kernel.assignDiagonalCoeff(
row);
892 kernel.assignCoeff(
row,
col);
894 kernel.assignOppositeCoeff(
row,
col);
899template<
typename Kernel,
unsigned int Mode,
bool SetOpposite>
903 static inline void run(Kernel &) {}
912template<
typename Kernel,
unsigned int Mode,
bool SetOpposite>
917 static inline void run(Kernel &kernel)
919 for(
Index j = 0; j < kernel.cols(); ++j)
923 if (((Mode&
Lower) && SetOpposite) || (Mode&
Upper))
926 if(Mode&
Upper) kernel.assignCoeff(i, j);
927 else kernel.assignOppositeCoeff(i, j);
933 kernel.assignDiagonalCoeff(i++);
935 if (((Mode&
Upper) && SetOpposite) || (Mode&
Lower))
937 for(; i < kernel.rows(); ++i)
938 if(Mode&
Lower) kernel.assignCoeff(i, j);
939 else kernel.assignOppositeCoeff(i, j);
949template<
typename Derived>
950template<
typename DenseDerived>
953 other.derived().
resize(this->rows(), this->cols());
960template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
968 if((dst.rows()!=dstRows) || (dst.cols()!=dstCols))
969 dst.resize(dstRows, dstCols);
971 dst._assignProduct(src, Scalar(1),
false);
976template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
982 dst._assignProduct(src, Scalar(1),
true);
987template<
typename DstXprType,
typename Lhs,
typename Rhs,
typename Scalar>
993 dst._assignProduct(src, Scalar(-1),
true);
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE ColXpr col(Index i)
This is the const version of col().
Definition: BlockMethods.h:1097
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE RowXpr row(Index i)
This is the const version of row(). */.
Definition: BlockMethods.h:1118
#define EIGEN_DEFAULT_COPY_CONSTRUCTOR(CLASS)
Definition: Macros.h:1231
#define EIGEN_DEPRECATED
Definition: Macros.h:1068
#define eigen_internal_assert(x)
Definition: Macros.h:1053
#define EIGEN_DEFAULT_EMPTY_CONSTRUCTOR_AND_DESTRUCTOR(Derived)
Definition: Macros.h:1257
#define EIGEN_NOEXCEPT
Definition: Macros.h:1428
#define EIGEN_CONSTEXPR
Definition: Macros.h:797
#define EIGEN_UNUSED_VARIABLE(var)
Definition: Macros.h:1086
#define EIGEN_DEVICE_FUNC
Definition: Macros.h:986
#define EIGEN_ONLY_USED_FOR_DEBUG(x)
Definition: Macros.h:1059
#define eigen_assert(x)
Definition: Macros.h:1047
#define EIGEN_INHERIT_ASSIGNMENT_OPERATORS(Derived)
Definition: Macros.h:1241
#define EIGEN_STRONG_INLINE
Definition: Macros.h:927
#define EIGEN_UNROLLING_LIMIT
Defines the maximal loop size to enable meta unrolling of loops.
Definition: Settings.h:24
#define EIGEN_STATIC_ASSERT_LVALUE(Derived)
Definition: StaticAssert.h:202
#define EIGEN_STATIC_ASSERT(CONDITION, MSG)
Definition: StaticAssert.h:127
constexpr common_return_t< T1, T2 > beta(const T1 a, const T2 b) noexcept
Compile-time beta function.
Definition: beta.hpp:36
Base class for all dense matrices, vectors, and arrays.
Definition: DenseBase.h:47
EIGEN_DEVICE_FUNC void resize(Index newSize)
Only plain matrices/arrays, not expressions, may be resized; therefore the only useful resize methods...
Definition: DenseBase.h:246
Base class for all dense matrices, vectors, and expressions.
Definition: MatrixBase.h:50
bool isLowerTriangular(const RealScalar &prec=NumTraits< Scalar >::dummy_precision()) const
Definition: TriangularMatrix.h:690
NumTraits< Scalar >::Real RealScalar
Definition: MatrixBase.h:58
EIGEN_DEVICE_FUNC TriangularViewReturnType< Mode >::Type triangularView()
bool isUpperTriangular(const RealScalar &prec=NumTraits< Scalar >::dummy_precision()) const
Definition: TriangularMatrix.h:665
Expression of the product of two arbitrary matrices or vectors.
Definition: Product.h:75
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE EIGEN_CONSTEXPR Index cols() const EIGEN_NOEXCEPT
Definition: Product.h:104
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE EIGEN_CONSTEXPR Index rows() const EIGEN_NOEXCEPT
Definition: Product.h:102
Expression of a selfadjoint matrix from a triangular part of a dense matrix.
Definition: SelfAdjointView.h:51
Pseudo expression representing a solving operation.
Definition: Solve.h:63
Base class for triangular part in a matrix.
Definition: TriangularMatrix.h:28
internal::traits< Derived >::StorageKind StorageKind
Definition: TriangularMatrix.h:49
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index rows() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:59
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index innerStride() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:65
EIGEN_DEVICE_FUNC Derived & derived()
Definition: TriangularMatrix.h:107
EIGEN_DEVICE_FUNC Scalar & coeffRef(Index row, Index col)
Definition: TriangularMatrix.h:79
Derived const & Nested
Definition: TriangularMatrix.h:53
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index outerStride() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:63
EIGEN_DEVICE_FUNC Scalar operator()(Index row, Index col) const
Definition: TriangularMatrix.h:91
internal::traits< Derived >::Scalar Scalar
Definition: TriangularMatrix.h:48
internal::traits< Derived >::FullMatrixType DenseMatrixType
Definition: TriangularMatrix.h:51
internal::traits< Derived >::StorageIndex StorageIndex
Definition: TriangularMatrix.h:50
EIGEN_DEVICE_FUNC void evalTo(MatrixBase< DenseDerived > &other) const
Assigns a triangular or selfadjoint matrix to a dense matrix.
Definition: TriangularMatrix.h:616
EIGEN_DEVICE_FUNC const Derived & derived() const
Definition: TriangularMatrix.h:105
EIGEN_DEVICE_FUNC DenseMatrixType toDenseMatrix() const
Definition: TriangularMatrix.h:118
EIGEN_DEVICE_FUNC void resize(Index rows, Index cols)
Definition: TriangularMatrix.h:69
@ RowsAtCompileTime
Definition: TriangularMatrix.h:33
@ SizeAtCompileTime
This is equal to the number of coefficients, i.e.
Definition: TriangularMatrix.h:38
@ MaxColsAtCompileTime
Definition: TriangularMatrix.h:36
@ MaxRowsAtCompileTime
Definition: TriangularMatrix.h:35
@ Mode
Definition: TriangularMatrix.h:32
@ MaxSizeAtCompileTime
Definition: TriangularMatrix.h:44
@ ColsAtCompileTime
Definition: TriangularMatrix.h:34
void check_coordinates_internal(Index, Index) const
Definition: TriangularMatrix.h:146
void check_coordinates(Index row, Index col) const
Definition: TriangularMatrix.h:127
DenseMatrixType DenseType
Definition: TriangularMatrix.h:52
EIGEN_DEVICE_FUNC void evalToLazy(MatrixBase< DenseDerived > &other) const
Assigns a triangular or selfadjoint matrix to a dense matrix.
Definition: TriangularMatrix.h:951
EIGEN_DEVICE_FUNC Scalar & operator()(Index row, Index col)
Definition: TriangularMatrix.h:97
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void copyCoeff(Index row, Index col, Other &other)
Definition: TriangularMatrix.h:85
EIGEN_DEVICE_FUNC Scalar coeff(Index row, Index col) const
Definition: TriangularMatrix.h:77
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index cols() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:61
EIGEN_DEVICE_FUNC TriangularBase()
Definition: TriangularMatrix.h:56
Expression of a triangular part in a matrix.
Definition: TriangularMatrix.h:189
TriangularView< typename internal::add_const< MatrixType >::type, _Mode > ConstTriangularView
Definition: TriangularMatrix.h:201
internal::traits< TriangularView >::MatrixTypeNestedNonRef MatrixTypeNestedNonRef
Definition: TriangularMatrix.h:198
EIGEN_DEVICE_FUNC const ConstTransposeReturnType transpose() const
Definition: TriangularMatrix.h:276
MatrixTypeNested m_matrix
Definition: TriangularMatrix.h:333
EIGEN_DEVICE_FUNC const NestedExpression & nestedExpression() const
Definition: TriangularMatrix.h:233
internal::traits< TriangularView >::StorageKind StorageKind
Definition: TriangularMatrix.h:205
TriangularView< const typename MatrixType::AdjointReturnType, TransposeMode > AdjointReturnType
Definition: TriangularMatrix.h:257
EIGEN_DEVICE_FUNC Scalar determinant() const
Definition: TriangularMatrix.h:321
EIGEN_DEVICE_FUNC TransposeReturnType transpose()
Definition: TriangularMatrix.h:266
EIGEN_DEVICE_FUNC const Solve< TriangularView, Other > solve(const MatrixBase< Other > &other) const
Definition: TriangularMatrix.h:284
TriangularView< const typename MatrixType::ConstTransposeReturnType, TransposeMode > ConstTransposeReturnType
Definition: TriangularMatrix.h:273
EIGEN_DEVICE_FUNC SelfAdjointView< MatrixTypeNestedNonRef, Mode > selfadjointView()
Definition: TriangularMatrix.h:303
EIGEN_DEVICE_FUNC const SelfAdjointView< MatrixTypeNestedNonRef, Mode > selfadjointView() const
This is the const version of selfadjointView()
Definition: TriangularMatrix.h:311
TriangularView< typename MatrixType::TransposeReturnType, TransposeMode > TransposeReturnType
Definition: TriangularMatrix.h:263
internal::traits< TriangularView >::MatrixTypeNestedCleaned NestedExpression
Definition: TriangularMatrix.h:206
TriangularView< const MatrixConjugateReturnType, Mode > ConjugateReturnType
Definition: TriangularMatrix.h:239
TriangularViewImpl< _MatrixType, _Mode, typename internal::traits< _MatrixType >::StorageKind > Base
Definition: TriangularMatrix.h:192
internal::traits< TriangularView >::MatrixTypeNested MatrixTypeNested
Definition: TriangularMatrix.h:197
EIGEN_DEVICE_FUNC NestedExpression & nestedExpression()
Definition: TriangularMatrix.h:237
EIGEN_DEVICE_FUNC const AdjointReturnType adjoint() const
Definition: TriangularMatrix.h:260
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index rows() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:226
EIGEN_DEVICE_FUNC internal::conditional< Cond, ConjugateReturnType, ConstTriangularView >::type conjugateIf() const
Definition: TriangularMatrix.h:251
internal::remove_all< typenameMatrixType::ConjugateReturnType >::type MatrixConjugateReturnType
Definition: TriangularMatrix.h:200
@ TransposeMode
Definition: TriangularMatrix.h:211
@ Flags
Definition: TriangularMatrix.h:210
@ Mode
Definition: TriangularMatrix.h:209
@ IsVectorAtCompileTime
Definition: TriangularMatrix.h:215
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index cols() const EIGEN_NOEXCEPT
Definition: TriangularMatrix.h:229
_MatrixType MatrixType
Definition: TriangularMatrix.h:194
EIGEN_DEVICE_FUNC TriangularView(MatrixType &matrix)
Definition: TriangularMatrix.h:219
EIGEN_DEVICE_FUNC const ConjugateReturnType conjugate() const
Definition: TriangularMatrix.h:242
internal::traits< TriangularView >::Scalar Scalar
Definition: TriangularMatrix.h:193
TriangularBase< TriangularViewType > Base
Definition: TriangularMatrix.h:351
EIGEN_DEVICE_FUNC TriangularViewType & setOnes()
Definition: TriangularMatrix.h:412
EIGEN_DEVICE_FUNC void swap(TriangularBase< OtherDerived > const &other)
Swaps the coefficients of the common triangular parts of two matrices.
Definition: TriangularMatrix.h:530
EIGEN_DEVICE_FUNC TriangularViewType & operator+=(const DenseBase< Other > &other)
Definition: TriangularMatrix.h:381
EIGEN_DEVICE_FUNC const Product< TriangularViewType, OtherDerived > operator*(const MatrixBase< OtherDerived > &rhs) const
Efficient triangular matrix times vector/matrix product.
Definition: TriangularMatrix.h:465
internal::traits< TriangularViewType >::Scalar Scalar
Definition: TriangularMatrix.h:352
EIGEN_DEPRECATED EIGEN_DEVICE_FUNC void swap(MatrixBase< OtherDerived > const &other)
Shortcut for.
Definition: TriangularMatrix.h:541
internal::traits< TriangularViewType >::StorageKind StorageKind
Definition: TriangularMatrix.h:362
EIGEN_DEVICE_FUNC Scalar & coeffRef(Index row, Index col)
Definition: TriangularMatrix.h:428
MatrixType::PlainObject DenseMatrixType
Definition: TriangularMatrix.h:355
friend EIGEN_DEVICE_FUNC const Product< OtherDerived, TriangularViewType > operator*(const MatrixBase< OtherDerived > &lhs, const TriangularViewImpl &rhs)
Efficient vector/matrix times triangular matrix product.
Definition: TriangularMatrix.h:474
EIGEN_DEPRECATED EIGEN_DEVICE_FUNC void lazyAssign(const MatrixBase< OtherDerived > &other)
EIGEN_DEVICE_FUNC TriangularViewType & operator/=(const typename internal::traits< MatrixType >::Scalar &other)
Definition: TriangularMatrix.h:398
const internal::triangular_solve_retval< Side, TriangularViewType, Other > solve(const MatrixBase< Other > &other) const
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE TriangularViewType & _assignProduct(const ProductType &prod, const Scalar &alpha, bool beta)
_MatrixType MatrixType
Definition: TriangularMatrix.h:354
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void _solve_impl(const RhsType &rhs, DstType &dst) const
Definition: TriangularMatrix.h:549
EIGEN_DEVICE_FUNC void solveInPlace(const MatrixBase< OtherDerived > &other) const
"in-place" version of TriangularView::solve() where the result is written in other
EIGEN_DEPRECATED EIGEN_DEVICE_FUNC void lazyAssign(const TriangularBase< OtherDerived > &other)
EIGEN_DEVICE_FUNC Scalar coeff(Index row, Index col) const
Definition: TriangularMatrix.h:418
EIGEN_DEVICE_FUNC TriangularViewType & operator=(const TriangularViewImpl &other)
Definition: TriangularMatrix.h:447
EIGEN_DEVICE_FUNC TriangularViewType & operator=(const MatrixBase< OtherDerived > &other)
Shortcut for.
EIGEN_DEVICE_FUNC TriangularViewType & operator*=(const typename internal::traits< MatrixType >::Scalar &other)
Definition: TriangularMatrix.h:395
TriangularView< _MatrixType, _Mode > TriangularViewType
Definition: TriangularMatrix.h:350
DenseMatrixType PlainObject
Definition: TriangularMatrix.h:356
EIGEN_DEVICE_FUNC TriangularViewType & setConstant(const Scalar &value)
Definition: TriangularMatrix.h:405
EIGEN_DEVICE_FUNC TriangularViewType & setZero()
Definition: TriangularMatrix.h:409
EIGEN_DEVICE_FUNC void fill(const Scalar &value)
Definition: TriangularMatrix.h:402
EIGEN_DEVICE_FUNC Index outerStride() const
Definition: TriangularMatrix.h:372
EIGEN_DEVICE_FUNC void solveInPlace(const MatrixBase< OtherDerived > &other) const
Definition: TriangularMatrix.h:521
EIGEN_DEVICE_FUNC TriangularViewType & operator=(const TriangularBase< OtherDerived > &other)
Assigns a triangular matrix to a triangular part of a dense matrix.
EIGEN_DEVICE_FUNC TriangularViewType & operator-=(const DenseBase< Other > &other)
Definition: TriangularMatrix.h:388
EIGEN_DEVICE_FUNC Index innerStride() const
Definition: TriangularMatrix.h:376
Definition: TriangularMatrix.h:185
Definition: AssignEvaluator.h:619
const SrcEvaluatorType & m_src
Definition: AssignEvaluator.h:717
DstEvaluatorTypeT DstEvaluatorType
Definition: AssignEvaluator.h:625
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void assignCoeff(Index row, Index col)
Assign src(row,col) to dst(row,col) through the assignment functor.
Definition: AssignEvaluator.h:652
SrcEvaluatorTypeT SrcEvaluatorType
Definition: AssignEvaluator.h:626
DstEvaluatorType & m_dst
Definition: AssignEvaluator.h:716
const Functor & m_functor
Definition: AssignEvaluator.h:718
SrcEvaluatorTypeT::XprType SrcXprType
Definition: AssignEvaluator.h:622
DstEvaluatorTypeT::XprType DstXprType
Definition: AssignEvaluator.h:621
DstEvaluatorType::Scalar Scalar
Definition: AssignEvaluator.h:627
Definition: TriangularMatrix.h:755
Base::SrcEvaluatorType SrcEvaluatorType
Definition: TriangularMatrix.h:766
Base::SrcXprType SrcXprType
Definition: TriangularMatrix.h:759
Base::DstEvaluatorType DstEvaluatorType
Definition: TriangularMatrix.h:765
EIGEN_DEVICE_FUNC void assignOppositeCoeff(Index row, Index col)
Definition: TriangularMatrix.h:792
EIGEN_DEVICE_FUNC void assignDiagonalCoeff(Index id)
Definition: TriangularMatrix.h:785
Base::AssignmentTraits AssignmentTraits
Definition: TriangularMatrix.h:768
EIGEN_DEVICE_FUNC triangular_dense_assignment_kernel(DstEvaluatorType &dst, const SrcEvaluatorType &src, const Functor &func, DstXprType &dstExpr)
Definition: TriangularMatrix.h:771
generic_dense_assignment_kernel< DstEvaluatorTypeT, SrcEvaluatorTypeT, Functor, Version > Base
Definition: TriangularMatrix.h:757
Base::DstXprType DstXprType
Definition: TriangularMatrix.h:758
Base::Scalar Scalar
Definition: TriangularMatrix.h:767
type
Definition: core.h:575
@ StrictlyLower
View matrix as a lower triangular matrix with zeros on the diagonal.
Definition: Constants.h:221
@ UnitDiag
Matrix has ones on the diagonal; to be used in combination with Lower or Upper.
Definition: Constants.h:213
@ StrictlyUpper
View matrix as an upper triangular matrix with zeros on the diagonal.
Definition: Constants.h:223
@ UnitLower
View matrix as a lower triangular matrix with ones on the diagonal.
Definition: Constants.h:217
@ ZeroDiag
Matrix has zeros on the diagonal; to be used in combination with Lower or Upper.
Definition: Constants.h:215
@ SelfAdjoint
Used in BandMatrix and SelfAdjointView to indicate that the matrix is self-adjoint.
Definition: Constants.h:225
@ UnitUpper
View matrix as an upper triangular matrix with ones on the diagonal.
Definition: Constants.h:219
@ Lower
View matrix as a lower triangular matrix.
Definition: Constants.h:209
@ Upper
View matrix as an upper triangular matrix.
Definition: Constants.h:211
const unsigned int PacketAccessBit
Short version: means the expression might be vectorized.
Definition: Constants.h:94
const unsigned int LinearAccessBit
Short version: means the expression can be seen as 1D vector.
Definition: Constants.h:130
const unsigned int DirectAccessBit
Means that the underlying array of coefficients can be directly accessed as a plain strided array.
Definition: Constants.h:155
const unsigned int LvalueBit
Means the expression has a coeffRef() method, i.e.
Definition: Constants.h:144
Type
Definition: Constants.h:471
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_assignment_no_alias(Dst &dst, const Src &src, const Func &func)
Definition: AssignEvaluator.h:873
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_assignment(Dst &dst, const Src &src)
Definition: AssignEvaluator.h:834
EIGEN_DEVICE_FUNC bool is_same_dense(const T1 &mat1, const T2 &mat2, typename enable_if< possibly_same_dense< T1, T2 >::value >::type *=0)
Definition: XprHelper.h:695
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void call_triangular_assignment_loop(DstXprType &dst, const SrcXprType &src, const Functor &func)
Definition: TriangularMatrix.h:802
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE T maxi(const T &x, const T &y)
Definition: MathFunctions.h:1091
EIGEN_STRONG_INLINE void swap(T &a, T &b)
Definition: Meta.h:766
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE T mini(const T &x, const T &y)
Definition: MathFunctions.h:1083
EIGEN_DEVICE_FUNC EIGEN_ALWAYS_INLINE internal::enable_if< NumTraits< T >::IsSigned||NumTraits< T >::IsComplex, typenameNumTraits< T >::Real >::type abs(const T &x)
Definition: MathFunctions.h:1509
Namespace containing all symbols from the Eigen library.
Definition: Core:141
@ DefaultProduct
Definition: Constants.h:500
const unsigned int HereditaryBits
Definition: Constants.h:195
const int HugeCost
This value means that the cost to evaluate an expression coefficient is either very expensive or cann...
Definition: Constants.h:44
EIGEN_DEFAULT_DENSE_INDEX_TYPE Index
The Index type as used for the API.
Definition: Meta.h:74
const int Dynamic
This value means that a positive quantity (e.g., a size) is not known at compile-time,...
Definition: Constants.h:22
Definition: Eigen_Colamd.h:50
The type used to identify a dense storage.
Definition: Constants.h:507
Definition: Constants.h:528
Common base class for all classes T such that MatrixBase has an operator=(T) and a constructor Matrix...
Definition: EigenBase.h:30
EIGEN_DEVICE_FUNC Derived & const_cast_derived() const
Definition: EigenBase.h:52
Eigen::Index Index
The interface type of indices.
Definition: EigenBase.h:39
Definition: Constants.h:533
static void run(DstXprType &dst, const SrcXprType &src, const internal::assign_op< Scalar, typename SrcXprType::Scalar > &)
Definition: TriangularMatrix.h:964
Product< Lhs, Rhs, DefaultProduct > SrcXprType
Definition: TriangularMatrix.h:963
static void run(DstXprType &dst, const SrcXprType &src, const internal::sub_assign_op< Scalar, typename SrcXprType::Scalar > &)
Definition: TriangularMatrix.h:991
Product< Lhs, Rhs, DefaultProduct > SrcXprType
Definition: TriangularMatrix.h:990
Product< Lhs, Rhs, DefaultProduct > SrcXprType
Definition: TriangularMatrix.h:979
static void run(DstXprType &dst, const SrcXprType &src, const internal::add_assign_op< Scalar, typename SrcXprType::Scalar > &)
Definition: TriangularMatrix.h:980
static EIGEN_DEVICE_FUNC void run(DstXprType &dst, const SrcXprType &src, const Functor &func)
Definition: TriangularMatrix.h:863
static EIGEN_DEVICE_FUNC void run(DstXprType &dst, const SrcXprType &src, const Functor &func)
Definition: TriangularMatrix.h:854
static EIGEN_DEVICE_FUNC void run(DstXprType &dst, const SrcXprType &src, const Functor &func)
Definition: TriangularMatrix.h:843
Definition: AssignEvaluator.h:824
Triangular2Dense Kind
Definition: TriangularMatrix.h:836
Dense2Triangular Kind
Definition: TriangularMatrix.h:837
Triangular2Triangular Kind
Definition: TriangularMatrix.h:835
Definition: AssignEvaluator.h:817
Definition: TriangularMatrix.h:742
Definition: Constants.h:542
Definition: TriangularMatrix.h:741
Definition: TriangularMatrix.h:740
Definition: AssignmentFunctors.h:46
Definition: AssignmentFunctors.h:21
Definition: AssignEvaluator.h:29
glue_shapes< typenameevaluator_traits< MatrixType >::Shape, TriangularShape >::type Shape
Definition: TriangularMatrix.h:726
storage_kind_to_evaluator_kind< typenameMatrixType::StorageKind >::Kind Kind
Definition: TriangularMatrix.h:725
Definition: CoreEvaluators.h:80
Definition: CoreEvaluators.h:91
Definition: XprHelper.h:685
Definition: XprHelper.h:660
Definition: XprHelper.h:417
T type
Definition: Meta.h:126
T type
Definition: Meta.h:114
Definition: XprHelper.h:282
Definition: AssignmentFunctors.h:67
Definition: AssignmentFunctors.h:142
ref_selector< MatrixType >::non_const_type MatrixTypeNested
Definition: TriangularMatrix.h:172
remove_all< MatrixTypeNested >::type MatrixTypeNestedCleaned
Definition: TriangularMatrix.h:174
MatrixType ExpressionType
Definition: TriangularMatrix.h:176
remove_reference< MatrixTypeNested >::type MatrixTypeNestedNonRef
Definition: TriangularMatrix.h:173
MatrixType::PlainObject FullMatrixType
Definition: TriangularMatrix.h:175
Definition: ForwardDeclarations.h:17
static EIGEN_DEVICE_FUNC void run(Kernel &)
Definition: TriangularMatrix.h:903
static EIGEN_DEVICE_FUNC void run(Kernel &kernel)
Definition: TriangularMatrix.h:917
Kernel::Scalar Scalar
Definition: TriangularMatrix.h:915
Definition: TriangularMatrix.h:872
Kernel::Scalar Scalar
Definition: TriangularMatrix.h:882
DstEvaluatorType::XprType DstXprType
Definition: TriangularMatrix.h:875
Kernel::DstEvaluatorType DstEvaluatorType
Definition: TriangularMatrix.h:874
static EIGEN_DEVICE_FUNC void run(Kernel &kernel)
Definition: TriangularMatrix.h:885
@ row
Definition: TriangularMatrix.h:879
@ col
Definition: TriangularMatrix.h:878
Definition: SolveTriangular.h:208
evaluator< typename internal::remove_all< MatrixType >::type > Base
Definition: TriangularMatrix.h:734
TriangularView< MatrixType, Mode > XprType
Definition: TriangularMatrix.h:733
EIGEN_DEVICE_FUNC unary_evaluator(const XprType &xpr)
Definition: TriangularMatrix.h:736
Definition: CoreEvaluators.h:65