HomeSort by relevance Sort by last modified time
    Searched refs:matrixQ (Results 1 - 24 of 24) sorted by null

  /external/eigen/doc/snippets/
RealQZ_compute.cpp 9 cout << "Q:\n" << qz.matrixQ() << "\n" << "Z:\n" << qz.matrixZ() << "\n";
13 << "\n|A-QSZ|: " << (A-qz.matrixQ()*qz.matrixS()*qz.matrixZ()).norm()
14 << ", |B-QTZ|: " << (B-qz.matrixQ()*qz.matrixT()*qz.matrixZ()).norm()
15 << "\n|QQ* - I|: " << (qz.matrixQ()*qz.matrixQ().adjoint() - MatrixXf::Identity(4,4)).norm()
HessenbergDecomposition_matrixH.cpp 6 MatrixXf Q = hessOfA.matrixQ();
Tridiagonalization_Tridiagonalization_MatrixType.cpp 5 MatrixXd Q = triOfA.matrixQ();
  /external/eigen/test/
hessenberg.cpp 22 MatrixType Q = hess.matrixQ();
38 MatrixType cs1Q = cs1.matrixQ();
39 MatrixType cs2Q = cs2.matrixQ();
45 VERIFY_RAISES_ASSERT( hessUninitialized.matrixQ() );
real_qz.cpp 73 VERIFY_IS_APPROX(qz.matrixQ()*qz.matrixS()*qz.matrixZ(), A);
74 VERIFY_IS_APPROX(qz.matrixQ()*qz.matrixT()*qz.matrixZ(), B);
75 VERIFY_IS_APPROX(qz.matrixQ()*qz.matrixQ().adjoint(), MatrixType::Identity(dim,dim));
qr_fullpivoting.cpp 38 MatrixQType q = qr.matrixQ();
44 MatrixType c = qr.matrixQ() * r * qr.colsPermutation().inverse();
50 VERIFY_IS_APPROX(tmp.noalias() = qr.matrixQ() * r, (qr.matrixQ() * r).eval());
105 m3 = qr.matrixQ(); // get a unitary
119 VERIFY_RAISES_ASSERT(qr.matrixQ())
sparseqr.cpp 87 Q = solver.matrixQ();
95 dQ = solver.matrixQ();
eigensolver_selfadjoint.cpp 158 VERIFY_IS_APPROX(MatrixType(symmC.template selfadjointView<Lower>()), tridiag.matrixQ() * tridiag.matrixT().eval() * MatrixType(tridiag.matrixQ()).adjoint());
159 VERIFY_IS_APPROX(MatrixType(symmC.template selfadjointView<Lower>()), tridiag.matrixQ() * tridiag.matrixT() * tridiag.matrixQ().adjoint());
  /external/eigen/Eigen/src/Eigenvalues/
ComplexSchur.h 195 * \param[in] matrixQ orthogonal matrix Q that transform a matrix A to H : A = Q H Q^T
211 ComplexSchur& computeFromHessenberg(const HessMatrixType& matrixH, const OrthMatrixType& matrixQ, bool computeU=true);
341 ComplexSchur<MatrixType>& ComplexSchur<MatrixType>::computeFromHessenberg(const HessMatrixType& matrixH, const OrthMatrixType& matrixQ, bool computeU)
345 m_matU = matrixQ;
360 if(computeU) _this.m_matU = _this.m_hess.matrixQ();
377 MatrixType Q = _this.m_hess.matrixQ();
HessenbergDecomposition.h 49 * computed, you can use the matrixH() and matrixQ() functions to construct
84 /** \brief Return type of matrixQ() */
234 HouseholderSequenceType matrixQ() const
260 * \sa matrixQ(), packedMatrix()
RealSchur.h 174 * \param[in] matrixQ orthogonal matrix Q that transform a matrix A to H : A = Q H Q^T
190 RealSchur& computeFromHessenberg(const HessMatrixType& matrixH, const OrthMatrixType& matrixQ, bool computeU);
274 computeFromHessenberg(m_hess.matrixH(), m_hess.matrixQ(), computeU);
282 RealSchur<MatrixType>& RealSchur<MatrixType>::computeFromHessenberg(const HessMatrixType& matrixH, const OrthMatrixType& matrixQ, bool computeU)
288 m_matU = matrixQ;
SelfAdjointEigenSolver.h 382 * \param matrixQ pointer to the column-major matrix holding the eigenvectors, can be 0
393 static void tridiagonal_qr_step(RealScalar* diag, RealScalar* subdiag, Index start, Index end, Scalar* matrixQ, Index n);
808 static void tridiagonal_qr_step(RealScalar* diag, RealScalar* subdiag, Index start, Index end, Scalar* matrixQ, Index n)
    [all...]
Tridiagonalization.h 55 * matrixQ() and matrixT() functions to retrieve the matrices Q and T in the
98 /** \brief Return type of matrixQ() */
240 HouseholderSequenceType matrixQ() const
263 * matrixQ(), packedMatrix(), diagonal(), subDiagonal()
RealQZ.h 43 * matrixT(), matrixQ() and matrixZ() functions to retrieve the matrices
119 const MatrixType& matrixQ() const {
  /external/opencv/cv/src/
cvgeometry.cpp 355 cvRQDecomp3x3( const CvMat *matrixM, CvMat *matrixR, CvMat *matrixQ,
369 CV_ASSERT( CV_IS_MAT(matrixM) && CV_IS_MAT(matrixR) && CV_IS_MAT(matrixQ) &&
371 CV_ARE_SIZES_EQ(matrixM, matrixR) && CV_ARE_SIZES_EQ(matrixM, matrixQ));
513 cvConvert( &Q, matrixQ );
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 47 * Use matrixQ() to get an expression and matrixQ().transpose() to get the transpose.
157 y = matrixQ().transpose() * b;
189 SPQRMatrixQReturnType<SPQR> matrixQ() const
  /external/eigen/Eigen/src/SparseQR/
SparseQR.h 55 * Use matrixQ() to get an expression and matrixQ().transpose() to get the transpose.
160 * B2 = matrixQ() * B1;
166 * Q = SparseQR<SparseMatrix<double> >(A).matrixQ();
173 SparseQRMatrixQReturnType<SparseQR> matrixQ() const
201 y = this->matrixQ().transpose() * B;
731 dst = src.m_qr.matrixQ() * DstXprType::Identity(src.m_qr.rows(), src.m_qr.rows());
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
DGMRES.h 426 DenseMatrix matrixQ(it,it);
427 matrixQ.setIdentity();
428 schurofH.computeFromHessenberg(m_Hes.topLeftCorner(it,it), matrixQ, computeU);
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LMonestep.h 70 m_wa4 = qrfac.matrixQ().adjoint() * m_fvec;
  /external/eigen/Eigen/src/QR/
FullPivHouseholderQR.h 184 MatrixQReturnType matrixQ(void) const;
591 * \brief Expression type for return value of FullPivHouseholderQR::matrixQ()
657 inline typename FullPivHouseholderQR<MatrixType>::MatrixQReturnType FullPivHouseholderQR<MatrixType>::matrixQ() const
CompleteOrthogonalDecomposition.h 155 HouseholderSequenceType matrixQ(void) const { return m_cpqr.householderQ(); }
ColPivHouseholderQR.h 182 HouseholderSequenceType matrixQ() const
  /external/eigen/Eigen/src/SVD/
JacobiSVD.h 92 if(svd.m_computeFullU) m_qr.matrixQ().evalTo(svd.m_matrixU, m_workspace);
140 if(svd.m_computeFullV) m_qr.matrixQ().evalTo(svd.m_matrixV, m_workspace);
    [all...]
  /external/opencv/cv/include/
cv.h     [all...]

Completed in 1534 milliseconds