TR-mbed 1.0
Loading...
Searching...
No Matches
TriangularMatrix.h
Go to the documentation of this file.
1// This file is part of Eigen, a lightweight C++ template library
2// for linear algebra.
3//
4// Copyright (C) 2008 Benoit Jacob <jacob.benoit.1@gmail.com>
5// Copyright (C) 2008-2009 Gael Guennebaud <gael.guennebaud@inria.fr>
6//
7// This Source Code Form is subject to the terms of the Mozilla
8// Public License v. 2.0. If a copy of the MPL was not distributed
9// with this file, You can obtain one at http://mozilla.org/MPL/2.0/.
10
11#ifndef EIGEN_TRIANGULARMATRIX_H
12#define EIGEN_TRIANGULARMATRIX_H
13
14namespace Eigen {
15
16namespace internal {
17
18template<int Side, typename TriangularType, typename Rhs> struct triangular_solve_retval;
19
20}
21
27template<typename Derived> class TriangularBase : public EigenBase<Derived>
28{
29 public:
30
31 enum {
37
46
47 };
53 typedef Derived const& Nested;
54
56 inline TriangularBase() { eigen_assert(!((int(Mode) & int(UnitDiag)) && (int(Mode) & int(ZeroDiag)))); }
57
59 inline Index rows() const EIGEN_NOEXCEPT { return derived().rows(); }
61 inline Index cols() const EIGEN_NOEXCEPT { return derived().cols(); }
63 inline Index outerStride() const EIGEN_NOEXCEPT { return derived().outerStride(); }
65 inline Index innerStride() const EIGEN_NOEXCEPT { return derived().innerStride(); }
66
67 // dummy resize function
70 {
73 eigen_assert(rows==this->rows() && cols==this->cols());
74 }
75
77 inline Scalar coeff(Index row, Index col) const { return derived().coeff(row,col); }
79 inline Scalar& coeffRef(Index row, Index col) { return derived().coeffRef(row,col); }
80
83 template<typename Other>
86 {
87 derived().coeffRef(row, col) = other.coeff(row, col);
88 }
89
92 {
94 return coeff(row,col);
95 }
98 {
100 return coeffRef(row,col);
101 }
102
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); }
108 #endif // not EIGEN_PARSED_BY_DOXYGEN
109
110 template<typename DenseDerived>
113 template<typename DenseDerived>
116
119 {
122 return res;
123 }
124
125 protected:
126
128 {
131 eigen_assert(col>=0 && col<cols() && row>=0 && row<rows());
132 const int mode = int(Mode) & ~SelfAdjoint;
134 eigen_assert((mode==Upper && col>=row)
135 || (mode==Lower && col<=row)
136 || ((mode==StrictlyUpper || mode==UnitUpper) && col>row)
137 || ((mode==StrictlyLower || mode==UnitLower) && col<row));
138 }
139
140 #ifdef EIGEN_INTERNAL_DEBUGGING
142 {
144 }
145 #else
147 #endif
148
149};
150
168namespace internal {
169template<typename MatrixType, unsigned int _Mode>
171{
175 typedef typename MatrixType::PlainObject FullMatrixType;
177 enum {
178 Mode = _Mode,
180 Flags = (MatrixTypeNestedCleaned::Flags & (HereditaryBits | FlagsLvalueBit) & (~(PacketAccessBit | DirectAccessBit | LinearAccessBit)))
181 };
182};
183}
184
185template<typename _MatrixType, unsigned int _Mode, typename StorageKind> class TriangularViewImpl;
186
187template<typename _MatrixType, unsigned int _Mode> class TriangularView
188 : public TriangularViewImpl<_MatrixType, _Mode, typename internal::traits<_MatrixType>::StorageKind >
189{
190 public:
191
194 typedef _MatrixType MatrixType;
195
196 protected:
199
202
203 public:
204
207
208 enum {
209 Mode = _Mode,
211 TransposeMode = (Mode & Upper ? Lower : 0)
212 | (Mode & Lower ? Upper : 0)
213 | (Mode & (UnitDiag))
214 | (Mode & (ZeroDiag)),
216 };
217
220 {}
221
223
224
226 inline Index rows() const EIGEN_NOEXCEPT { return m_matrix.rows(); }
229 inline Index cols() const EIGEN_NOEXCEPT { return m_matrix.cols(); }
230
233 const NestedExpression& nestedExpression() const { return m_matrix; }
234
238
242 inline const ConjugateReturnType conjugate() const
243 { return ConjugateReturnType(m_matrix.conjugate()); }
244
248 template<bool Cond>
252 {
254 return ReturnType(m_matrix.template conjugateIf<Cond>());
255 }
256
260 inline const AdjointReturnType adjoint() const
261 { return AdjointReturnType(m_matrix.adjoint()); }
262
267 {
269 typename MatrixType::TransposeReturnType tmp(m_matrix);
270 return TransposeReturnType(tmp);
271 }
272
279 }
280
281 template<typename Other>
284 solve(const MatrixBase<Other>& other) const
285 { return Solve<TriangularView, Other>(*this, other.derived()); }
286
287 // workaround MSVC ICE
288 #if EIGEN_COMP_MSVC
289 template<int Side, typename Other>
292 solve(const MatrixBase<Other>& other) const
293 { return Base::template solve<Side>(other); }
294 #else
295 using Base::solve;
296 #endif
297
308
316
317
322 {
323 if (Mode & UnitDiag)
324 return 1;
325 else if (Mode & ZeroDiag)
326 return 0;
327 else
328 return m_matrix.diagonal().prod();
329 }
330
331 protected:
332
334};
335
345template<typename _MatrixType, unsigned int _Mode> class TriangularViewImpl<_MatrixType,_Mode,Dense>
346 : public TriangularBase<TriangularView<_MatrixType, _Mode> >
347{
348 public:
349
353
354 typedef _MatrixType MatrixType;
355 typedef typename MatrixType::PlainObject DenseMatrixType;
357
358 public:
359 using Base::evalToLazy;
360 using Base::derived;
361
363
364 enum {
365 Mode = _Mode,
367 };
368
372 inline Index outerStride() const { return derived().nestedExpression().outerStride(); }
376 inline Index innerStride() const { return derived().nestedExpression().innerStride(); }
377
379 template<typename Other>
382 internal::call_assignment_no_alias(derived(), other.derived(), internal::add_assign_op<Scalar,typename Other::Scalar>());
383 return derived();
384 }
386 template<typename Other>
389 internal::call_assignment_no_alias(derived(), other.derived(), internal::sub_assign_op<Scalar,typename Other::Scalar>());
390 return derived();
391 }
392
395 TriangularViewType& operator*=(const typename internal::traits<MatrixType>::Scalar& other) { return *this = derived().nestedExpression() * other; }
398 TriangularViewType& operator/=(const typename internal::traits<MatrixType>::Scalar& other) { return *this = derived().nestedExpression() / other; }
399
402 void fill(const Scalar& value) { setConstant(value); }
406 { return *this = MatrixType::Constant(derived().rows(), derived().cols(), value); }
413
418 inline Scalar coeff(Index row, Index col) const
419 {
420 Base::check_coordinates_internal(row, col);
421 return derived().nestedExpression().coeff(row, col);
422 }
423
429 {
431 Base::check_coordinates_internal(row, col);
432 return derived().nestedExpression().coeffRef(row, col);
433 }
434
436 template<typename OtherDerived>
439
441 template<typename OtherDerived>
444
445#ifndef EIGEN_PARSED_BY_DOXYGEN
448 { return *this = other.derived().nestedExpression(); }
449
450 template<typename OtherDerived>
454
455 template<typename OtherDerived>
459#endif
460
462 template<typename OtherDerived>
466 {
467 return Product<TriangularViewType,OtherDerived>(derived(), rhs.derived());
468 }
469
471 template<typename OtherDerived> friend
475 {
476 return Product<OtherDerived,TriangularViewType>(lhs.derived(),rhs.derived());
477 }
478
502 template<int Side, typename Other>
504 solve(const MatrixBase<Other>& other) const;
505
515 template<int Side, typename OtherDerived>
517 void solveInPlace(const MatrixBase<OtherDerived>& other) const;
518
519 template<typename OtherDerived>
521 void solveInPlace(const MatrixBase<OtherDerived>& other) const
522 { return solveInPlace<OnTheLeft>(other); }
523
525 template<typename OtherDerived>
527#ifdef EIGEN_PARSED_BY_DOXYGEN
529#else
531#endif
532 {
533 EIGEN_STATIC_ASSERT_LVALUE(OtherDerived);
534 call_assignment(derived(), other.const_cast_derived(), internal::swap_assign_op<Scalar>());
535 }
536
538 template<typename OtherDerived>
541 void swap(MatrixBase<OtherDerived> const & other)
542 {
543 EIGEN_STATIC_ASSERT_LVALUE(OtherDerived);
544 call_assignment(derived(), other.const_cast_derived(), internal::swap_assign_op<Scalar>());
545 }
546
547 template<typename RhsType, typename DstType>
549 EIGEN_STRONG_INLINE void _solve_impl(const RhsType &rhs, DstType &dst) const {
550 if(!internal::is_same_dense(dst,rhs))
551 dst = rhs;
552 this->solveInPlace(dst);
553 }
554
555 template<typename ProductType>
557 EIGEN_STRONG_INLINE TriangularViewType& _assignProduct(const ProductType& prod, const Scalar& alpha, bool beta);
558 protected:
561
562};
563
564/***************************************************************************
565* Implementation of triangular evaluation/assignment
566***************************************************************************/
567
568#ifndef EIGEN_PARSED_BY_DOXYGEN
569// FIXME should we keep that possibility
570template<typename MatrixType, unsigned int Mode>
571template<typename OtherDerived>
574{
576 return derived();
577}
578
579// FIXME should we keep that possibility
580template<typename MatrixType, unsigned int Mode>
581template<typename OtherDerived>
582EIGEN_DEVICE_FUNC void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(const MatrixBase<OtherDerived>& other)
583{
584 internal::call_assignment_no_alias(derived(), other.template triangularView<Mode>());
585}
586
587
588
589template<typename MatrixType, unsigned int Mode>
590template<typename OtherDerived>
591EIGEN_DEVICE_FUNC inline TriangularView<MatrixType, Mode>&
592TriangularViewImpl<MatrixType, Mode, Dense>::operator=(const TriangularBase<OtherDerived>& other)
593{
594 eigen_assert(Mode == int(OtherDerived::Mode));
595 internal::call_assignment(derived(), other.derived());
596 return derived();
597}
598
599template<typename MatrixType, unsigned int Mode>
600template<typename OtherDerived>
601EIGEN_DEVICE_FUNC void TriangularViewImpl<MatrixType, Mode, Dense>::lazyAssign(const TriangularBase<OtherDerived>& other)
602{
603 eigen_assert(Mode == int(OtherDerived::Mode));
604 internal::call_assignment_no_alias(derived(), other.derived());
605}
606#endif
607
608/***************************************************************************
609* Implementation of TriangularBase methods
610***************************************************************************/
611
614template<typename Derived>
615template<typename DenseDerived>
617{
618 evalToLazy(other.derived());
619}
620
621/***************************************************************************
622* Implementation of TriangularView methods
623***************************************************************************/
624
625/***************************************************************************
626* Implementation of MatrixBase methods
627***************************************************************************/
628
640template<typename Derived>
641template<unsigned int Mode>
643typename MatrixBase<Derived>::template TriangularViewReturnType<Mode>::Type
648
650template<typename Derived>
651template<unsigned int Mode>
653typename MatrixBase<Derived>::template ConstTriangularViewReturnType<Mode>::Type
658
664template<typename Derived>
666{
667 RealScalar maxAbsOnUpperPart = static_cast<RealScalar>(-1);
668 for(Index j = 0; j < cols(); ++j)
669 {
670 Index maxi = numext::mini(j, rows()-1);
671 for(Index i = 0; i <= maxi; ++i)
672 {
673 RealScalar absValue = numext::abs(coeff(i,j));
674 if(absValue > maxAbsOnUpperPart) maxAbsOnUpperPart = absValue;
675 }
676 }
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;
681 return true;
682}
683
689template<typename Derived>
691{
692 RealScalar maxAbsOnLowerPart = static_cast<RealScalar>(-1);
693 for(Index j = 0; j < cols(); ++j)
694 for(Index i = j; i < rows(); ++i)
695 {
696 RealScalar absValue = numext::abs(coeff(i,j));
697 if(absValue > maxAbsOnLowerPart) maxAbsOnLowerPart = absValue;
698 }
699 RealScalar threshold = maxAbsOnLowerPart * prec;
700 for(Index j = 1; j < cols(); ++j)
701 {
702 Index maxi = numext::mini(j, rows()-1);
703 for(Index i = 0; i < maxi; ++i)
704 if(numext::abs(coeff(i, j)) > threshold) return false;
705 }
706 return true;
707}
708
709
710/***************************************************************************
711****************************************************************************
712* Evaluators and Assignment of triangular expressions
713***************************************************************************
714***************************************************************************/
715
716namespace internal {
717
718
719// TODO currently a triangular expression has the form TriangularView<.,.>
720// in the future triangular-ness should be defined by the expression traits
721// such that Transpose<TriangularView<.,.> > is valid. (currently TriangularBase::transpose() is overloaded to make it work)
722template<typename MatrixType, unsigned int Mode>
728
729template<typename MatrixType, unsigned int Mode>
731 : evaluator<typename internal::remove_all<MatrixType>::type>
732{
736 unary_evaluator(const XprType &xpr) : Base(xpr.nestedExpression()) {}
737};
738
739// Additional assignment kinds:
743
744
745template<typename Kernel, unsigned int Mode, int UnrollCount, bool ClearOpposite> struct triangular_assignment_loop;
746
747
753template<int UpLo, int Mode, int SetOpposite, typename DstEvaluatorTypeT, typename SrcEvaluatorTypeT, typename Functor, int Version = Specialized>
754class triangular_dense_assignment_kernel : public generic_dense_assignment_kernel<DstEvaluatorTypeT, SrcEvaluatorTypeT, Functor, Version>
755{
756protected:
758 typedef typename Base::DstXprType DstXprType;
759 typedef typename Base::SrcXprType SrcXprType;
760 using Base::m_dst;
761 using Base::m_src;
762 using Base::m_functor;
763public:
764
767 typedef typename Base::Scalar Scalar;
769
770
774
775#ifdef EIGEN_INTERNAL_DEBUGGING
776 EIGEN_DEVICE_FUNC void assignCoeff(Index row, Index col)
777 {
779 Base::assignCoeff(row,col);
780 }
781#else
782 using Base::assignCoeff;
783#endif
784
786 {
787 if(Mode==UnitDiag && SetOpposite) m_functor.assignCoeff(m_dst.coeffRef(id,id), Scalar(1));
788 else if(Mode==ZeroDiag && SetOpposite) m_functor.assignCoeff(m_dst.coeffRef(id,id), Scalar(0));
789 else if(Mode==0) Base::assignCoeff(id,id);
790 }
791
793 {
795 if(SetOpposite)
796 m_functor.assignCoeff(m_dst.coeffRef(row,col), Scalar(0));
797 }
798};
799
800template<int Mode, bool SetOpposite, typename DstXprType, typename SrcXprType, typename Functor>
802void call_triangular_assignment_loop(DstXprType& dst, const SrcXprType& src, const Functor &func)
803{
804 typedef evaluator<DstXprType> DstEvaluatorType;
805 typedef evaluator<SrcXprType> SrcEvaluatorType;
806
807 SrcEvaluatorType srcEvaluator(src);
808
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);
814
816 DstEvaluatorType,SrcEvaluatorType,Functor> Kernel;
817 Kernel kernel(dstEvaluator, srcEvaluator, func, dst.const_cast_derived());
818
819 enum {
820 unroll = DstXprType::SizeAtCompileTime != Dynamic
821 && SrcEvaluatorType::CoeffReadCost < HugeCost
822 && DstXprType::SizeAtCompileTime * (int(DstEvaluatorType::CoeffReadCost) + int(SrcEvaluatorType::CoeffReadCost)) / 2 <= EIGEN_UNROLLING_LIMIT
823 };
824
825 triangular_assignment_loop<Kernel, Mode, unroll ? int(DstXprType::SizeAtCompileTime) : Dynamic, SetOpposite>::run(kernel);
826}
827
828template<int Mode, bool SetOpposite, typename DstXprType, typename SrcXprType>
834
838
839
840template< typename DstXprType, typename SrcXprType, typename Functor>
841struct Assignment<DstXprType, SrcXprType, Functor, Triangular2Triangular>
842{
843 EIGEN_DEVICE_FUNC static void run(DstXprType &dst, const SrcXprType &src, const Functor &func)
844 {
845 eigen_assert(int(DstXprType::Mode) == int(SrcXprType::Mode));
846
848 }
849};
850
851template< typename DstXprType, typename SrcXprType, typename Functor>
852struct Assignment<DstXprType, SrcXprType, Functor, Triangular2Dense>
853{
858};
859
860template< typename DstXprType, typename SrcXprType, typename Functor>
861struct Assignment<DstXprType, SrcXprType, Functor, Dense2Triangular>
862{
863 EIGEN_DEVICE_FUNC static void run(DstXprType &dst, const SrcXprType &src, const Functor &func)
864 {
866 }
867};
868
869
870template<typename Kernel, unsigned int Mode, int UnrollCount, bool SetOpposite>
872{
873 // FIXME: this is not very clean, perhaps this information should be provided by the kernel?
874 typedef typename Kernel::DstEvaluatorType DstEvaluatorType;
875 typedef typename DstEvaluatorType::XprType DstXprType;
876
877 enum {
878 col = (UnrollCount-1) / DstXprType::RowsAtCompileTime,
879 row = (UnrollCount-1) % DstXprType::RowsAtCompileTime
880 };
881
882 typedef typename Kernel::Scalar Scalar;
883
885 static inline void run(Kernel &kernel)
886 {
888
889 if(row==col)
890 kernel.assignDiagonalCoeff(row);
891 else if( ((Mode&Lower) && row>col) || ((Mode&Upper) && row<col) )
892 kernel.assignCoeff(row,col);
893 else if(SetOpposite)
894 kernel.assignOppositeCoeff(row,col);
895 }
896};
897
898// prevent buggy user code from causing an infinite recursion
899template<typename Kernel, unsigned int Mode, bool SetOpposite>
901{
903 static inline void run(Kernel &) {}
904};
905
906
907
908// TODO: experiment with a recursive assignment procedure splitting the current
909// triangular part into one rectangular and two triangular parts.
910
911
912template<typename Kernel, unsigned int Mode, bool SetOpposite>
914{
915 typedef typename Kernel::Scalar Scalar;
917 static inline void run(Kernel &kernel)
918 {
919 for(Index j = 0; j < kernel.cols(); ++j)
920 {
921 Index maxi = numext::mini(j, kernel.rows());
922 Index i = 0;
923 if (((Mode&Lower) && SetOpposite) || (Mode&Upper))
924 {
925 for(; i < maxi; ++i)
926 if(Mode&Upper) kernel.assignCoeff(i, j);
927 else kernel.assignOppositeCoeff(i, j);
928 }
929 else
930 i = maxi;
931
932 if(i<kernel.rows()) // then i==j
933 kernel.assignDiagonalCoeff(i++);
934
935 if (((Mode&Upper) && SetOpposite) || (Mode&Lower))
936 {
937 for(; i < kernel.rows(); ++i)
938 if(Mode&Lower) kernel.assignCoeff(i, j);
939 else kernel.assignOppositeCoeff(i, j);
940 }
941 }
942 }
943};
944
945} // end namespace internal
946
949template<typename Derived>
950template<typename DenseDerived>
952{
953 other.derived().resize(this->rows(), this->cols());
954 internal::call_triangular_assignment_loop<Derived::Mode, (int(Derived::Mode) & int(SelfAdjoint)) == 0 /* SetOpposite */>(other.derived(), derived().nestedExpression());
955}
956
957namespace internal {
958
959// Triangular = Product
960template< typename DstXprType, typename Lhs, typename Rhs, typename Scalar>
961struct Assignment<DstXprType, Product<Lhs,Rhs,DefaultProduct>, internal::assign_op<Scalar,typename Product<Lhs,Rhs,DefaultProduct>::Scalar>, Dense2Triangular>
962{
965 {
966 Index dstRows = src.rows();
967 Index dstCols = src.cols();
968 if((dst.rows()!=dstRows) || (dst.cols()!=dstCols))
969 dst.resize(dstRows, dstCols);
970
971 dst._assignProduct(src, Scalar(1), false);
972 }
973};
974
975// Triangular += Product
976template< typename DstXprType, typename Lhs, typename Rhs, typename Scalar>
977struct Assignment<DstXprType, Product<Lhs,Rhs,DefaultProduct>, internal::add_assign_op<Scalar,typename Product<Lhs,Rhs,DefaultProduct>::Scalar>, Dense2Triangular>
978{
981 {
982 dst._assignProduct(src, Scalar(1), true);
983 }
984};
985
986// Triangular -= Product
987template< typename DstXprType, typename Lhs, typename Rhs, typename Scalar>
988struct Assignment<DstXprType, Product<Lhs,Rhs,DefaultProduct>, internal::sub_assign_op<Scalar,typename Product<Lhs,Rhs,DefaultProduct>::Scalar>, Dense2Triangular>
989{
992 {
993 dst._assignProduct(src, Scalar(-1), true);
994 }
995};
996
997} // end namespace internal
998
999} // end namespace Eigen
1000
1001#endif // EIGEN_TRIANGULARMATRIX_H
int i
Definition BiCGSTAB_step_by_step.cpp:9
#define EIGEN_DEFAULT_COPY_CONSTRUCTOR(CLASS)
Definition Macros.h:1221
#define EIGEN_DEPRECATED
Definition Macros.h:1058
#define eigen_internal_assert(x)
Definition Macros.h:1043
#define EIGEN_DEFAULT_EMPTY_CONSTRUCTOR_AND_DESTRUCTOR(Derived)
Definition Macros.h:1247
#define EIGEN_NOEXCEPT
Definition Macros.h:1418
#define EIGEN_CONSTEXPR
Definition Macros.h:787
#define EIGEN_UNUSED_VARIABLE(var)
Definition Macros.h:1076
#define EIGEN_DEVICE_FUNC
Definition Macros.h:976
#define EIGEN_ONLY_USED_FOR_DEBUG(x)
Definition Macros.h:1049
#define eigen_assert(x)
Definition Macros.h:1037
#define EIGEN_INHERIT_ASSIGNMENT_OPERATORS(Derived)
Definition Macros.h:1231
#define EIGEN_STRONG_INLINE
Definition Macros.h:917
m col(1)
m row(1)
v setConstant(3, 5)
cout<< "Here is the matrix m:"<< endl<< m<< endl;Matrix< ptrdiff_t, 3, 1 > res
Definition PartialRedux_count.cpp:3
#define EIGEN_UNROLLING_LIMIT
Definition Settings.h:24
#define EIGEN_STATIC_ASSERT_LVALUE(Derived)
Definition StaticAssert.h:202
#define EIGEN_STATIC_ASSERT(CONDITION, MSG)
Definition StaticAssert.h:127
int rows
Definition Tutorial_commainit_02.cpp:1
int cols
Definition Tutorial_commainit_02.cpp:1
SCALAR Scalar
Definition bench_gemm.cpp:46
MatrixXf MatrixType
Definition benchmark-blocking-sizes.cpp:52
Base class for all dense matrices, vectors, and arrays.
Definition DenseBase.h:47
EIGEN_DEVICE_FUNC void resize(Index newSize)
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
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
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
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
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
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)
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
Definition TriangularMatrix.h:465
internal::traits< TriangularViewType >::Scalar Scalar
Definition TriangularMatrix.h:352
EIGEN_DEPRECATED EIGEN_DEVICE_FUNC void swap(MatrixBase< OtherDerived > const &other)
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)
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
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)
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)
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
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
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
@ TransposeMode
Definition TriangularMatrix.h:211
@ Flags
Definition TriangularMatrix.h:210
@ Mode
Definition TriangularMatrix.h:209
@ IsVectorAtCompileTime
Definition TriangularMatrix.h:215
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
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
Definition AssignEvaluator.h:619
DstEvaluatorTypeT DstEvaluatorType
Definition AssignEvaluator.h:625
SrcEvaluatorTypeT SrcEvaluatorType
Definition AssignEvaluator.h:626
DstEvaluatorTypeT::XprType DstXprType
Definition AssignEvaluator.h:621
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
Map< Matrix< T, Dynamic, Dynamic, ColMajor >, 0, OuterStride<> > matrix(T *data, int rows, int cols, int stride)
Definition common.h:110
@ StrictlyLower
Definition Constants.h:221
@ UnitDiag
Definition Constants.h:213
@ StrictlyUpper
Definition Constants.h:223
@ UnitLower
Definition Constants.h:217
@ ZeroDiag
Definition Constants.h:215
@ SelfAdjoint
Definition Constants.h:225
@ UnitUpper
Definition Constants.h:219
@ Lower
Definition Constants.h:209
@ Upper
Definition Constants.h:211
const unsigned int PacketAccessBit
Definition Constants.h:94
const unsigned int LinearAccessBit
Definition Constants.h:130
const unsigned int DirectAccessBit
Definition Constants.h:155
const unsigned int LvalueBit
Definition Constants.h:144
return int(ret)+1
RealScalar alpha
Definition level1_cplx_impl.h:147
DenseIndex ret
Definition level1_cplx_impl.h:44
int EIGEN_BLAS_FUNC() swap(int *n, RealScalar *px, int *incx, RealScalar *py, int *incy)
Definition level1_impl.h:130
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 EIGEN_STRONG_INLINE void call_triangular_assignment_loop(DstXprType &dst, const SrcXprType &src, const Functor &func)
Definition TriangularMatrix.h:802
@ Lhs
Definition TensorContractionMapper.h:19
@ Rhs
Definition TensorContractionMapper.h:18
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 bench_norm.cpp:85
@ DefaultProduct
Definition Constants.h:500
const unsigned int HereditaryBits
Definition Constants.h:195
const int HugeCost
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
Definition Constants.h:22
Definition BandTriangularSolver.h:13
EIGEN_DONT_INLINE void prod(const Lhs &a, const Rhs &b, Res &c)
Definition product_threshold.cpp:39
Definition Constants.h:528
Definition Constants.h:507
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
Triangular2Dense Kind
Definition TriangularMatrix.h:836
Dense2Triangular Kind
Definition TriangularMatrix.h:837
Triangular2Triangular Kind
Definition TriangularMatrix.h:835
Definition AssignEvaluator.h:817
static void run(DstXprType &dst, const SrcXprType &src, const internal::assign_op< Scalar, typename SrcXprType::Scalar > &)
Definition TriangularMatrix.h:964
static void run(DstXprType &dst, const SrcXprType &src, const internal::sub_assign_op< Scalar, typename SrcXprType::Scalar > &)
Definition TriangularMatrix.h:991
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
Definition TriangularMatrix.h:742
Definition Constants.h:542
Definition TriangularMatrix.h:741
Definition TriangularMatrix.h:740
Definition AssignmentFunctors.h:46
Definition AssignmentFunctors.h:21
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:660
Definition XprHelper.h:282
Definition AssignmentFunctors.h:67
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
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
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
Definition NonLinearOptimization.cpp:118
Definition benchGeometry.cpp:23
std::ptrdiff_t j
Definition tut_arithmetic_redux_minmax.cpp:2