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

  /external/eigen/Eigen/src/QR/
HouseholderQR_LAPACKE.h 44 template<typename MatrixQR, typename HCoeffs> \
45 struct householder_qr_inplace_blocked<MatrixQR, HCoeffs, EIGTYPE, true> \
47 static void run(MatrixQR& mat, HCoeffs& hCoeffs, Index = 32, \
54 LAPACKE_##LAPACKE_PREFIX##geqrf( matrix_order, m, n, (LAPACKE_TYPE*)mat.data(), lda, (LAPACKE_TYPE*)hCoeffs.data()); \
55 hCoeffs.adjointInPlace(); \
HouseholderQR.h 212 const HCoeffsType& hCoeffs() const { return m_hCoeffs; }
255 template<typename MatrixQR, typename HCoeffs>
256 void householder_qr_inplace_unblocked(MatrixQR& mat, HCoeffs& hCoeffs, typename MatrixQR::Scalar* tempData = 0)
264 eigen_assert(hCoeffs.size() == size);
280 mat.col(k).tail(remainingRows).makeHouseholderInPlace(hCoeffs.coeffRef(k), beta);
285 .applyHouseholderOnTheLeft(mat.col(k).tail(remainingRows-1), hCoeffs.coeffRef(k), tempData+k+1);
290 template<typename MatrixQR, typename HCoeffs,
292 bool InnerStrideIsOne = (MatrixQR::InnerStrideAtCompileTime == 1 && HCoeffs::InnerStrideAtCompileTime == 1)>
296 static void run(MatrixQR& mat, HCoeffs& hCoeffs, Index maxBlockSize=32
    [all...]
CompleteOrthogonalDecomposition.h 289 inline const HCoeffsType& hCoeffs() const { return m_cpqr.hCoeffs(); }
507 householderSequence(matrixQTZ(), hCoeffs()).setLength(rank).transpose());
FullPivHouseholderQR.h 325 const HCoeffsType& hCoeffs() const { return m_hCoeffs; }
605 const HCoeffsType& hCoeffs,
608 m_hCoeffs(hCoeffs),
ColPivHouseholderQR.h 334 const HCoeffsType& hCoeffs() const { return m_hCoeffs; }
  /external/eigen/Eigen/src/Householder/
BlockHouseholder.h 22 // void make_block_householder_triangular_factor(TriangularFactorType& triFactor, const VectorsType& vectors, const CoeffsType& hCoeffs)
31 // // Warning, note that hCoeffs may alias with vectors.
33 // typename CoeffsType::Scalar h = hCoeffs(i);
44 // triFactor(i,i) = hCoeffs(i);
51 void make_block_householder_triangular_factor(TriangularFactorType& triFactor, const VectorsType& vectors, const CoeffsType& hCoeffs)
63 triFactor.row(i).tail(rt).noalias() = -hCoeffs(i) * vectors.col(i).tail(rs).adjoint()
70 triFactor(i,i) = hCoeffs(i);
79 void apply_block_householder_on_the_left(MatrixType& mat, const VectorsType& vectors, const CoeffsType& hCoeffs, bool forward)
85 if(forward) make_block_householder_triangular_factor(T, vectors, hCoeffs);
86 else make_block_householder_triangular_factor(T, vectors, hCoeffs.conjugate());
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
Tridiagonalization.h 28 void tridiagonalization_inplace(MatrixType& matA, CoeffVectorType& hCoeffs);
329 * \param[out] hCoeffs returned Householder coefficients (see below)
338 * where \f$ h_i = hCoeffs[i]\f$ is the \f$ i \f$th Householder coefficient and
347 void tridiagonalization_inplace(MatrixType& matA, CoeffVectorType& hCoeffs)
354 eigen_assert(n==hCoeffs.size()+1 || n==1);
367 hCoeffs.tail(n-i-1).noalias() = (matA.bottomRightCorner(remainingSize,remainingSize).template selfadjointView<Lower>()
370 hCoeffs.tail(n-i-1) += (conj(h)*RealScalar(-0.5)*(hCoeffs.tail(remainingSize).dot(matA.col(i).tail(remainingSize)))) * matA.col(i).tail(n-i-1);
373 .rankUpdate(matA.col(i).tail(remainingSize), hCoeffs.tail(remainingSize), Scalar(-1));
376 hCoeffs.coeffRef(i) = h
    [all...]
HessenbergDecomposition.h 272 static void _compute(MatrixType& matA, CoeffVectorType& hCoeffs, VectorType& temp);
285 * \param hCoeffs returned Householder coefficients
294 void HessenbergDecomposition<MatrixType>::_compute(MatrixType& matA, CoeffVectorType& hCoeffs, VectorType& temp)
307 hCoeffs.coeffRef(i) = h;
  /external/eigen/test/
householder.cpp 87 HCoeffsVectorType hc = qr.hCoeffs().conjugate();
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
LevenbergMarquardt.h 474 fjac.diagonal() = qrfac.hCoeffs();

Completed in 742 milliseconds