11#ifndef EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
12#define EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
23 typedef int StorageIndex;
29template<
typename MatrixType>
32 typedef typename MatrixType::PlainObject ReturnType;
61 :
public SolverBase<FullPivHouseholderQR<_MatrixType> >
65 typedef _MatrixType MatrixType;
71 MaxRowsAtCompileTime = MatrixType::MaxRowsAtCompileTime,
72 MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
76 typedef Matrix<StorageIndex, 1,
77 EIGEN_SIZE_MIN_PREFER_DYNAMIC(ColsAtCompileTime,RowsAtCompileTime),
RowMajor, 1,
82 typedef typename MatrixType::PlainObject PlainObject;
92 m_rows_transpositions(),
93 m_cols_transpositions(),
96 m_isInitialized(
false),
97 m_usePrescribedThreshold(
false) {}
107 m_hCoeffs((
std::min)(rows,cols)),
108 m_rows_transpositions((
std::min)(rows,cols)),
109 m_cols_transpositions((
std::min)(rows,cols)),
110 m_cols_permutation(cols),
112 m_isInitialized(
false),
113 m_usePrescribedThreshold(
false) {}
127 template<
typename InputType>
129 : m_qr(matrix.rows(), matrix.cols()),
130 m_hCoeffs((
std::min)(matrix.rows(), matrix.cols())),
131 m_rows_transpositions((
std::min)(matrix.rows(), matrix.cols())),
132 m_cols_transpositions((
std::min)(matrix.rows(), matrix.cols())),
133 m_cols_permutation(matrix.cols()),
134 m_temp(matrix.cols()),
135 m_isInitialized(
false),
136 m_usePrescribedThreshold(
false)
138 compute(matrix.derived());
147 template<
typename InputType>
150 m_hCoeffs((
std::min)(matrix.rows(), matrix.cols())),
151 m_rows_transpositions((
std::min)(matrix.rows(), matrix.cols())),
152 m_cols_transpositions((
std::min)(matrix.rows(), matrix.cols())),
153 m_cols_permutation(matrix.cols()),
154 m_temp(matrix.cols()),
155 m_isInitialized(
false),
156 m_usePrescribedThreshold(
false)
161 #ifdef EIGEN_PARSED_BY_DOXYGEN
177 template<
typename Rhs>
190 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
194 template<
typename InputType>
200 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
201 return m_cols_permutation;
207 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
208 return m_rows_transpositions;
249 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
252 for(
Index i = 0; i < m_nonzero_pivots; ++i)
265 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
266 return cols() -
rank();
278 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
279 return rank() == cols();
291 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
292 return rank() == rows();
303 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
314 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
318 inline Index rows()
const {
return m_qr.rows(); }
319 inline Index cols()
const {
return m_qr.cols(); }
346 m_usePrescribedThreshold =
true;
361 m_usePrescribedThreshold =
false;
371 eigen_assert(m_isInitialized || m_usePrescribedThreshold);
372 return m_usePrescribedThreshold ? m_prescribedThreshold
387 eigen_assert(m_isInitialized &&
"LU is not initialized.");
388 return m_nonzero_pivots;
396 #ifndef EIGEN_PARSED_BY_DOXYGEN
397 template<
typename RhsType,
typename DstType>
400 template<
bool Conjugate,
typename RhsType,
typename DstType>
406 static void check_template_parameters()
408 EIGEN_STATIC_ASSERT_NON_INTEGER(Scalar);
411 void computeInPlace();
414 HCoeffsType m_hCoeffs;
415 IntDiagSizeVectorType m_rows_transpositions;
416 IntDiagSizeVectorType m_cols_transpositions;
417 PermutationType m_cols_permutation;
418 RowVectorType m_temp;
419 bool m_isInitialized, m_usePrescribedThreshold;
420 RealScalar m_prescribedThreshold, m_maxpivot;
421 Index m_nonzero_pivots;
422 RealScalar m_precision;
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>
453 m_qr = matrix.derived();
458template<
typename MatrixType>
461 check_template_parameters();
464 Index rows = m_qr.rows();
465 Index cols = m_qr.cols();
466 Index size = (std::min)(rows,cols);
469 m_hCoeffs.resize(size);
475 m_rows_transpositions.resize(size);
476 m_cols_transpositions.resize(size);
481 m_nonzero_pivots = size;
482 m_maxpivot = RealScalar(0);
484 for (
Index k = 0; k < size; ++k)
488 typedef typename Scoring::result_type Score;
490 Score score = m_qr.bottomRightCorner(rows-k, cols-k)
501 m_nonzero_pivots = k;
502 for(
Index i = k; i < size; i++)
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;
527 if(abs(beta) > m_maxpivot) m_maxpivot = abs(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);
534 for(
Index k = 0; k < size; ++k)
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>
544void FullPivHouseholderQR<_MatrixType>::_solve_impl(
const RhsType &rhs, DstType &dst)
const
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>
578void FullPivHouseholderQR<_MatrixType>::_solve_impl_transposed(
const RhsType &rhs, DstType &dst)
const
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();
599 const Index size = (std::min)(rows(), cols());
600 for (
Index k = size-1; k >= 0; --k)
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>
622 dst =
src.nestedExpression().solve(MatrixType::Identity(
src.rows(),
src.cols()));
633 :
public ReturnByValue<FullPivHouseholderQRMatrixQReturnType<MatrixType> >
638 typedef Matrix<
typename MatrixType::Scalar, 1, MatrixType::RowsAtCompileTime,
RowMajor, 1,
646 m_rowsTranspositions(rowsTranspositions)
649 template <
typename ResultType>
650 void evalTo(ResultType& result)
const
652 const Index rows = m_qr.rows();
657 template <
typename ResultType>
664 const Index rows = m_qr.rows();
665 const Index cols = m_qr.cols();
666 const Index size = (std::min)(rows, cols);
669 for (
Index k = size-1; k >= 0; k--)
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)));
677 Index rows()
const {
return m_qr.rows(); }
678 Index cols()
const {
return m_qr.rows(); }
681 typename MatrixType::Nested m_qr;
682 typename HCoeffsType::Nested m_hCoeffs;
683 typename IntDiagSizeVectorType::Nested m_rowsTranspositions;
693template<
typename MatrixType>
696 eigen_assert(m_isInitialized &&
"FullPivHouseholderQR is not initialized.");
704template<
typename Derived>
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
EIGEN_DEVICE_FUNC Derived & setZero()
Sets all coefficients in this expression to zero.
Definition CwiseNullaryOp.h:546
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
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
const PermutationType & colsPermutation() const
Definition FullPivHouseholderQR.h:198
Index dimensionOfKernel() const
Definition FullPivHouseholderQR.h:263
const IntDiagSizeVectorType & rowsTranspositions() const
Definition FullPivHouseholderQR.h:205
bool isInjective() const
Definition FullPivHouseholderQR.h:276
const HCoeffsType & hCoeffs() const
Definition FullPivHouseholderQR.h:325
RealScalar maxPivot() const
Definition FullPivHouseholderQR.h:394
bool isSurjective() const
Definition FullPivHouseholderQR.h:289
MatrixType::RealScalar logAbsDeterminant() const
Definition FullPivHouseholderQR.h:436
FullPivHouseholderQR(Index rows, Index cols)
Default Constructor with memory preallocation.
Definition FullPivHouseholderQR.h:105
FullPivHouseholderQR(EigenBase< InputType > &matrix)
Constructs a QR factorization from a given matrix.
Definition FullPivHouseholderQR.h:148
MatrixQReturnType matrixQ(void) const
Definition FullPivHouseholderQR.h:694
const Inverse< FullPivHouseholderQR > inverse() const
Definition FullPivHouseholderQR.h:312
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
Base class for all dense matrices, vectors, and expressions.
Definition MatrixBase.h:50
EIGEN_DEVICE_FUNC EIGEN_STRONG_INLINE EvalReturnType eval() const
Definition DenseBase.h:407
EIGEN_DEVICE_FUNC Derived & setIdentity()
Writes the identity expression (not necessarily square) into *this.
Definition CwiseNullaryOp.h:873
The matrix class, also used for vectors and row-vectors.
Definition Matrix.h:180
Definition ReturnByValue.h:52
A base class for matrix decomposition and solvers.
Definition SolverBase.h:69
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
@ RowMajor
Storage order is row major (see TopicStorageOrders).
Definition Constants.h:321
Namespace containing all symbols from the Eigen library.
Definition LDLT.h:16
EIGEN_DEFAULT_DENSE_INDEX_TYPE Index
The Index type as used for the API.
Definition Meta.h:74
Eigen::Index Index
The interface type of indices.
Definition EigenBase.h:39
The type used to identify a matrix expression.
Definition Constants.h:522
Holds information about the various numeric (i.e.
Definition NumTraits.h:236
The type used to identify a general solver (factored) storage.
Definition Constants.h:513
Definition AssignEvaluator.h:824
Definition AssignEvaluator.h:814
Expression type for return value of FullPivHouseholderQR::matrixQ()
Definition FullPivHouseholderQR.h:634
Definition UnaryFunctors.h:72
Definition AssignmentFunctors.h:21
Definition UnaryFunctors.h:64
Definition ForwardDeclarations.h:17
Definition inference.c:32