11#ifndef EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
12#define EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
27template<
typename MatrixType>
struct FullPivHouseholderQRMatrixQReturnType;
29template<
typename MatrixType>
61 :
public SolverBase<FullPivHouseholderQR<_MatrixType> >
76 typedef Matrix<StorageIndex, 1,
127 template<
typename InputType>
147 template<
typename InputType>
161 #ifdef EIGEN_PARSED_BY_DOXYGEN
177 template<
typename Rhs>
194 template<
typename InputType>
396 #ifndef EIGEN_PARSED_BY_DOXYGEN
397 template<
typename RhsType,
typename DstType>
400 template<
bool Conjugate,
typename RhsType,
typename DstType>
426template<
typename MatrixType>
430 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
431 eigen_assert(m_qr.rows() == m_qr.cols() &&
"You can't take the determinant of a non-square matrix!");
432 return abs(m_qr.diagonal().prod());
435template<
typename MatrixType>
438 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
439 eigen_assert(m_qr.rows() == m_qr.cols() &&
"You can't take the determinant of a non-square matrix!");
440 return m_qr.diagonal().cwiseAbs().array().log().sum();
449template<
typename MatrixType>
450template<
typename InputType>
458template<
typename MatrixType>
461 check_template_parameters();
464 Index rows = m_qr.rows();
465 Index cols = m_qr.cols();
469 m_hCoeffs.resize(
size);
475 m_rows_transpositions.resize(
size);
476 m_cols_transpositions.resize(
size);
477 Index number_of_transpositions = 0;
479 RealScalar biggest(0);
481 m_nonzero_pivots =
size;
482 m_maxpivot = RealScalar(0);
486 Index row_of_biggest_in_corner, col_of_biggest_in_corner;
488 typedef typename Scoring::result_type Score;
490 Score score = m_qr.bottomRightCorner(rows-k, cols-k)
491 .unaryExpr(Scoring())
492 .maxCoeff(&row_of_biggest_in_corner, &col_of_biggest_in_corner);
493 row_of_biggest_in_corner += k;
494 col_of_biggest_in_corner += k;
496 if(k==0) biggest = biggest_in_corner;
501 m_nonzero_pivots = k;
504 m_rows_transpositions.coeffRef(i) = internal::convert_index<StorageIndex>(i);
505 m_cols_transpositions.coeffRef(i) = internal::convert_index<StorageIndex>(i);
506 m_hCoeffs.coeffRef(i) =
Scalar(0);
511 m_rows_transpositions.coeffRef(k) = internal::convert_index<StorageIndex>(row_of_biggest_in_corner);
512 m_cols_transpositions.coeffRef(k) = internal::convert_index<StorageIndex>(col_of_biggest_in_corner);
513 if(k != row_of_biggest_in_corner) {
514 m_qr.row(k).tail(cols-k).swap(m_qr.row(row_of_biggest_in_corner).tail(cols-k));
515 ++number_of_transpositions;
517 if(k != col_of_biggest_in_corner) {
518 m_qr.col(k).swap(m_qr.col(col_of_biggest_in_corner));
519 ++number_of_transpositions;
523 m_qr.col(k).tail(rows-k).makeHouseholderInPlace(m_hCoeffs.coeffRef(k),
beta);
524 m_qr.coeffRef(k,k) =
beta;
529 m_qr.bottomRightCorner(rows-k, cols-k-1)
530 .applyHouseholderOnTheLeft(m_qr.col(k).tail(rows-k-1), m_hCoeffs.coeffRef(k), &m_temp.coeffRef(k+1));
533 m_cols_permutation.setIdentity(cols);
535 m_cols_permutation.applyTranspositionOnTheRight(k, m_cols_transpositions.coeff(k));
537 m_det_pq = (number_of_transpositions%2) ? -1 : 1;
538 m_isInitialized =
true;
541#ifndef EIGEN_PARSED_BY_DOXYGEN
542template<
typename _MatrixType>
543template<
typename RhsType,
typename DstType>
546 const Index l_rank = rank();
556 typename RhsType::PlainObject
c(rhs);
559 for (
Index k = 0; k < l_rank; ++k)
561 Index remainingSize = rows()-k;
562 c.row(k).swap(
c.row(m_rows_transpositions.coeff(k)));
563 c.bottomRightCorner(remainingSize, rhs.cols())
564 .applyHouseholderOnTheLeft(m_qr.col(k).tail(remainingSize-1),
565 m_hCoeffs.coeff(k), &temp.
coeffRef(0));
568 m_qr.topLeftCorner(l_rank, l_rank)
569 .template triangularView<Upper>()
570 .solveInPlace(
c.topRows(l_rank));
572 for(
Index i = 0; i < l_rank; ++i) dst.row(m_cols_permutation.indices().coeff(i)) =
c.row(i);
573 for(
Index i = l_rank; i < cols(); ++i) dst.row(m_cols_permutation.indices().coeff(i)).setZero();
576template<
typename _MatrixType>
577template<
bool Conjugate,
typename RhsType,
typename DstType>
580 const Index l_rank = rank();
588 typename RhsType::PlainObject
c(m_cols_permutation.transpose()*rhs);
590 m_qr.topLeftCorner(l_rank, l_rank)
591 .template triangularView<Upper>()
592 .transpose().template conjugateIf<Conjugate>()
593 .solveInPlace(
c.topRows(l_rank));
595 dst.topRows(l_rank) =
c.topRows(l_rank);
596 dst.bottomRows(rows()-l_rank).setZero();
602 Index remainingSize = rows()-k;
604 dst.bottomRightCorner(remainingSize, dst.cols())
605 .applyHouseholderOnTheLeft(m_qr.col(k).tail(remainingSize-1).template conjugateIf<!Conjugate>(),
606 m_hCoeffs.template conjugateIf<Conjugate>().coeff(k), &temp.
coeffRef(0));
608 dst.row(k).swap(dst.row(m_rows_transpositions.coeff(k)));
615template<
typename DstXprType,
typename MatrixType>
633 :
public ReturnByValue<FullPivHouseholderQRMatrixQReturnType<MatrixType> >
638 typedef Matrix<
typename MatrixType::Scalar, 1, MatrixType::RowsAtCompileTime,
RowMajor, 1,
646 m_rowsTranspositions(rowsTranspositions)
649 template <
typename ResultType>
652 const Index rows = m_qr.rows();
654 evalTo(
result, workspace);
657 template <
typename ResultType>
664 const Index rows = m_qr.rows();
665 const Index cols = m_qr.cols();
668 result.setIdentity(rows, rows);
671 result.block(k, k, rows-k, rows-k)
672 .applyHouseholderOnTheLeft(m_qr.col(k).tail(rows-k-1), conj(m_hCoeffs.coeff(k)), &workspace.
coeffRef(k));
673 result.row(k).swap(
result.row(m_rowsTranspositions.coeff(k)));
681 typename MatrixType::Nested
m_qr;
693template<
typename MatrixType>
696 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
704template<
typename Derived>
#define EIGEN_SIZE_MIN_PREFER_DYNAMIC(a, b)
Definition: Macros.h:1304
#define EIGEN_GENERIC_PUBLIC_INTERFACE(Derived)
Just a side note.
Definition: Macros.h:1274
#define eigen_assert(x)
Definition: Macros.h:1047
#define EIGEN_SIZE_MIN_PREFER_FIXED(a, b)
Definition: Macros.h:1312
#define EIGEN_STATIC_ASSERT_NON_INTEGER(TYPE)
Definition: StaticAssert.h:187
constexpr common_return_t< T1, T2 > beta(const T1 a, const T2 b) noexcept
Compile-time beta function.
Definition: beta.hpp:36
Householder rank-revealing QR decomposition of a matrix with full pivoting.
Definition: FullPivHouseholderQR.h:62
FullPivHouseholderQR & setThreshold(const RealScalar &threshold)
Allows to prescribe a threshold to be used by certain methods, such as rank(), who need to determine ...
Definition: FullPivHouseholderQR.h:344
MatrixType::RealScalar absDeterminant() const
Definition: FullPivHouseholderQR.h:427
const MatrixType & matrixQR() const
Definition: FullPivHouseholderQR.h:188
Index cols() const
Definition: FullPivHouseholderQR.h:319
PermutationType m_cols_permutation
Definition: FullPivHouseholderQR.h:417
FullPivHouseholderQR & setThreshold(Default_t)
Allows to come back to the default behavior, letting Eigen use its default formula for determining th...
Definition: FullPivHouseholderQR.h:359
PermutationMatrix< ColsAtCompileTime, MaxColsAtCompileTime > PermutationType
Definition: FullPivHouseholderQR.h:79
const PermutationType & colsPermutation() const
Definition: FullPivHouseholderQR.h:198
internal::plain_row_type< MatrixType >::type RowVectorType
Definition: FullPivHouseholderQR.h:80
Index rows() const
Definition: FullPivHouseholderQR.h:318
Index dimensionOfKernel() const
Definition: FullPivHouseholderQR.h:263
RealScalar m_maxpivot
Definition: FullPivHouseholderQR.h:420
HCoeffsType m_hCoeffs
Definition: FullPivHouseholderQR.h:414
SolverBase< FullPivHouseholderQR > Base
Definition: FullPivHouseholderQR.h:66
bool m_isInitialized
Definition: FullPivHouseholderQR.h:419
internal::plain_col_type< MatrixType >::type ColVectorType
Definition: FullPivHouseholderQR.h:81
RealScalar m_precision
Definition: FullPivHouseholderQR.h:422
IntDiagSizeVectorType m_rows_transpositions
Definition: FullPivHouseholderQR.h:415
const IntDiagSizeVectorType & rowsTranspositions() const
Definition: FullPivHouseholderQR.h:205
MatrixType m_qr
Definition: FullPivHouseholderQR.h:413
bool isInjective() const
Definition: FullPivHouseholderQR.h:276
Index m_det_pq
Definition: FullPivHouseholderQR.h:423
const HCoeffsType & hCoeffs() const
Definition: FullPivHouseholderQR.h:325
RealScalar maxPivot() const
Definition: FullPivHouseholderQR.h:394
Matrix< StorageIndex, 1, EIGEN_SIZE_MIN_PREFER_DYNAMIC(ColsAtCompileTime, RowsAtCompileTime), RowMajor, 1, EIGEN_SIZE_MIN_PREFER_FIXED(MaxColsAtCompileTime, MaxRowsAtCompileTime)> IntDiagSizeVectorType
Definition: FullPivHouseholderQR.h:78
bool m_usePrescribedThreshold
Definition: FullPivHouseholderQR.h:419
void computeInPlace()
Definition: FullPivHouseholderQR.h:459
@ MaxColsAtCompileTime
Definition: FullPivHouseholderQR.h:72
@ MaxRowsAtCompileTime
Definition: FullPivHouseholderQR.h:71
IntDiagSizeVectorType m_cols_transpositions
Definition: FullPivHouseholderQR.h:416
RealScalar m_prescribedThreshold
Definition: FullPivHouseholderQR.h:420
void _solve_impl(const RhsType &rhs, DstType &dst) const
Definition: FullPivHouseholderQR.h:544
bool isSurjective() const
Definition: FullPivHouseholderQR.h:289
static void check_template_parameters()
Definition: FullPivHouseholderQR.h:406
_MatrixType MatrixType
Definition: FullPivHouseholderQR.h:65
MatrixType::RealScalar logAbsDeterminant() const
Definition: FullPivHouseholderQR.h:436
FullPivHouseholderQR & compute(const EigenBase< InputType > &matrix)
FullPivHouseholderQR(Index rows, Index cols)
Default Constructor with memory preallocation.
Definition: FullPivHouseholderQR.h:105
RowVectorType m_temp
Definition: FullPivHouseholderQR.h:418
MatrixType::PlainObject PlainObject
Definition: FullPivHouseholderQR.h:82
FullPivHouseholderQR(EigenBase< InputType > &matrix)
Constructs a QR factorization from a given matrix.
Definition: FullPivHouseholderQR.h:148
internal::FullPivHouseholderQRMatrixQReturnType< MatrixType > MatrixQReturnType
Definition: FullPivHouseholderQR.h:74
internal::plain_diag_type< MatrixType >::type HCoeffsType
Definition: FullPivHouseholderQR.h:75
MatrixQReturnType matrixQ(void) const
Definition: FullPivHouseholderQR.h:694
Index m_nonzero_pivots
Definition: FullPivHouseholderQR.h:421
const Inverse< FullPivHouseholderQR > inverse() const
Definition: FullPivHouseholderQR.h:312
void _solve_impl_transposed(const RhsType &rhs, DstType &dst) const
Definition: FullPivHouseholderQR.h:578
Index rank() const
Definition: FullPivHouseholderQR.h:246
FullPivHouseholderQR()
Default Constructor.
Definition: FullPivHouseholderQR.h:89
bool isInvertible() const
Definition: FullPivHouseholderQR.h:301
FullPivHouseholderQR(const EigenBase< InputType > &matrix)
Constructs a QR factorization from a given matrix.
Definition: FullPivHouseholderQR.h:128
Index nonzeroPivots() const
Definition: FullPivHouseholderQR.h:385
RealScalar threshold() const
Returns the threshold that will be used by certain methods such as rank().
Definition: FullPivHouseholderQR.h:369
Expression of the inverse of another expression.
Definition: Inverse.h:44
EIGEN_DEVICE_FUNC const XprTypeNestedCleaned & nestedExpression() const
Definition: Inverse.h:60
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index cols() const EIGEN_NOEXCEPT
Definition: Inverse.h:58
EIGEN_DEVICE_FUNC EIGEN_CONSTEXPR Index rows() const EIGEN_NOEXCEPT
Definition: Inverse.h:57
Base class for all dense matrices, vectors, and expressions.
Definition: MatrixBase.h:50
The matrix class, also used for vectors and row-vectors.
Definition: Matrix.h:180
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE Scalar & coeffRef(Index rowId, Index colId)
This is an overloaded version of DenseCoeffsBase<Derived,WriteAccessors>::coeffRef(Index,...
Definition: PlainObjectBase.h:175
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE void resize(Index rows, Index cols)
Resizes *this to a rows x cols matrix.
Definition: PlainObjectBase.h:271
Definition: ReturnByValue.h:52
Pseudo expression representing a solving operation.
Definition: Solve.h:63
A base class for matrix decomposition and solvers.
Definition: SolverBase.h:69
internal::traits< FullPivHouseholderQR< _MatrixType > >::Scalar Scalar
Definition: SolverBase.h:73
const Solve< FullPivHouseholderQR< _MatrixType >, Rhs > solve(const MatrixBase< Rhs > &b) const
Definition: SolverBase.h:106
EIGEN_DEVICE_FUNC FullPivHouseholderQR< _MatrixType > & derived()
Definition: EigenBase.h:46
@ RowsAtCompileTime
Definition: SolverBase.h:80
@ ColsAtCompileTime
Definition: SolverBase.h:81
UnitType abs(const UnitType x) noexcept
Compute absolute value.
Definition: math.h:721
@ RowMajor
Storage order is row major (see TopicStorageOrders).
Definition: Constants.h:321
constexpr common_t< T1, T2 > min(const T1 x, const T2 y) noexcept
Compile-time pairwise minimum function.
Definition: min.hpp:35
EIGEN_DEVICE_FUNC bool isMuchSmallerThan(const Scalar &x, const OtherScalar &y, const typename NumTraits< Scalar >::Real &precision=NumTraits< Scalar >::dummy_precision())
Definition: MathFunctions.h:1940
EIGEN_CONSTEXPR Index size(const T &x)
Definition: Meta.h:479
Namespace containing all symbols from the Eigen library.
Definition: Core:141
EIGEN_DEFAULT_DENSE_INDEX_TYPE Index
The Index type as used for the API.
Definition: Meta.h:74
Default_t
Definition: Constants.h:362
result
Definition: format.h:2564
Definition: Eigen_Colamd.h:50
Definition: BFloat16.h:88
static constexpr const velocity::meters_per_second_t c(299792458.0)
Speed of light in vacuum.
Common base class for all classes T such that MatrixBase has an operator=(T) and a constructor Matrix...
Definition: EigenBase.h:30
Eigen::Index Index
The interface type of indices.
Definition: EigenBase.h:39
EIGEN_DEVICE_FUNC Derived & derived()
Definition: EigenBase.h:46
The type used to identify a matrix expression.
Definition: Constants.h:522
Holds information about the various numeric (i.e.
Definition: NumTraits.h:233
The type used to identify a general solver (factored) storage.
Definition: Constants.h:513
static void run(DstXprType &dst, const SrcXprType &src, const internal::assign_op< typename DstXprType::Scalar, typename QrType::Scalar > &)
Definition: FullPivHouseholderQR.h:620
Inverse< QrType > SrcXprType
Definition: FullPivHouseholderQR.h:619
FullPivHouseholderQR< MatrixType > QrType
Definition: FullPivHouseholderQR.h:618
Definition: AssignEvaluator.h:824
Definition: AssignEvaluator.h:814
Expression type for return value of FullPivHouseholderQR::matrixQ()
Definition: FullPivHouseholderQR.h:634
Matrix< typename MatrixType::Scalar, 1, MatrixType::RowsAtCompileTime, RowMajor, 1, MatrixType::MaxRowsAtCompileTime > WorkVectorType
Definition: FullPivHouseholderQR.h:639
FullPivHouseholderQR< MatrixType >::IntDiagSizeVectorType IntDiagSizeVectorType
Definition: FullPivHouseholderQR.h:636
Index rows() const
Definition: FullPivHouseholderQR.h:677
HCoeffsType::Nested m_hCoeffs
Definition: FullPivHouseholderQR.h:682
FullPivHouseholderQRMatrixQReturnType(const MatrixType &qr, const HCoeffsType &hCoeffs, const IntDiagSizeVectorType &rowsTranspositions)
Definition: FullPivHouseholderQR.h:641
MatrixType::Nested m_qr
Definition: FullPivHouseholderQR.h:681
void evalTo(ResultType &result) const
Definition: FullPivHouseholderQR.h:650
internal::plain_diag_type< MatrixType >::type HCoeffsType
Definition: FullPivHouseholderQR.h:637
Index cols() const
Definition: FullPivHouseholderQR.h:678
IntDiagSizeVectorType::Nested m_rowsTranspositions
Definition: FullPivHouseholderQR.h:683
void evalTo(ResultType &result, WorkVectorType &workspace) const
Definition: FullPivHouseholderQR.h:658
Definition: UnaryFunctors.h:72
Definition: AssignmentFunctors.h:21
Definition: UnaryFunctors.h:64
MatrixXpr XprKind
Definition: FullPivHouseholderQR.h:21
SolverStorage StorageKind
Definition: FullPivHouseholderQR.h:22
int StorageIndex
Definition: FullPivHouseholderQR.h:23
MatrixType::PlainObject ReturnType
Definition: FullPivHouseholderQR.h:32
Definition: ForwardDeclarations.h:17