HomeSort by relevance Sort by last modified time
    Searched refs:Upper (Results 101 - 125 of 198) sorted by null

1 2 3 45 6 7 8

  /external/eigen/Eigen/src/SVD/
JacobiSVD.h 91 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.cols(),matrix.cols()).template triangularView<Upper>();
139 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.rows(),matrix.rows()).template triangularView<Upper>().adjoint();
175 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.cols(),matrix.cols()).template triangularView<Upper>();
232 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.rows(),matrix.rows()).template triangularView<Upper>().adjoint();
274 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.cols(),matrix.cols()).template triangularView<Upper>();
328 svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.rows(),matrix.rows()).template triangularView<Upper>().adjoint();
    [all...]
  /external/llvm/lib/Analysis/
DependenceAnalysis.cpp     [all...]
InstructionSimplify.cpp     [all...]
  /external/llvm/lib/Target/SystemZ/
SystemZISelDAGToDAG.cpp 116 // narrower (in which case the upper bits are don't care), or wider (in which
    [all...]
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrixTriangular.h 51 ColMajor, UpLo==Lower?Upper:Lower>
116 if (UpLo==Upper)
160 if(UpLo==Upper)
TriangularMatrixMatrix_BLAS.h 90 LowUp = IsLower ? Lower : Upper, \
201 LowUp = IsLower ? Lower : Upper, \
SelfadjointMatrixMatrix.h 479 LhsIsUpper = (LhsMode&(Upper|Lower))==Upper,
481 RhsIsUpper = (RhsMode&(Upper|Lower))==Upper,
SelfadjointProduct.h 43 selfadjoint_rank1_update<Scalar,Index,ColMajor,UpLo==Lower?Upper:Lower,ConjRhs,ConjLhs>::run(size,mat,stride,vecY,vecX,alpha);
TriangularMatrixMatrix.h 67 (Mode&(UnitDiag|ZeroDiag)) | ((Mode&Upper) ? Lower : Upper),
170 // 3 - the dense panel below (lower case) or above (upper case) the diagonal block => GEPP
212 // the part below (lower case) or above (upper case) the diagonal => GEPP
TriangularSolverMatrix.h 29 (Mode&UnitDiag) | ((Mode&Upper) ? Lower : Upper),
  /external/eigen/Eigen/src/SparseCore/
SparseMatrixBase.h 324 SparseSymmetricPermutationProduct<Derived,Upper|Lower> twistedBy(const PermutationMatrix<Dynamic,Dynamic,StorageIndex>& perm) const
326 return SparseSymmetricPermutationProduct<Derived,Upper|Lower>(derived(), perm);
  /external/eigen/test/
eigensolver_selfadjoint.cpp 153 // FIXME check that upper and lower part are 0:
154 //VERIFY(T.topRightCorner(rows-2, cols-2).template triangularView<Upper>().isZero());
220 m2 = m1.triangularView<Upper>();
222 SelfAdjointEigenSolver<Matrix3d> eig2(m2.selfadjointView<Upper>());
product_trmm.cpp 98 CALL_ALL_ORDERS(EIGEN_CAT(1,NB),SCALAR,Upper) \
qr.cpp 29 MatrixType r = qrOfA.matrixQR().template triangularView<Upper>();
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixLogarithm.h 217 .template triangularView<Upper>().solve(TminusI);
252 T = sqrtT.template triangularView<Upper>();
273 * \param[in] A argument of matrix logarithm, should be upper triangular and atomic
  /external/swiftshader/third_party/LLVM/lib/VMCore/
Instructions.cpp     [all...]
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
GMRES.h 157 // insert coefficients into upper matrix triangle
165 // solve upper triangular system
167 H.topLeftCorner(k, k).template triangularView <Upper>().solveInPlace(y);
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LMonestep.h 116 m_wa3 = m_rfactor.template triangularView<Upper>() * (m_permutation.inverse() *m_wa1);
  /external/llvm/lib/IR/
Instructions.cpp     [all...]
  /external/eigen/Eigen/src/Cholesky/
LDLT.h 32 * \tparam _UpLo the triangular part that will be used for the decompositon: Lower (default) or Upper.
140 /** \returns a view of the upper triangular matrix U */
274 * The strict upper part is used during the decomposition, the strict lower
451 template<> struct ldlt_inplace<Upper>
476 template<typename MatrixType> struct LDLT_Traits<MatrixType,Upper>
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
HybridNonLinearSolver.h 260 wa3 = R.template triangularView<Upper>()*wa1 + qtf;
503 wa3 = R.template triangularView<Upper>()*wa1 + qtf;
LevenbergMarquardt.h 299 wa3 = fjac.template triangularView<Upper>() * (qrfac.colsPermutation().inverse() *wa1);
549 wa3 = fjac.topLeftCorner(n,n).template triangularView<Upper>() * (permutation.inverse() * wa1);
  /external/eigen/Eigen/src/QR/
CompleteOrthogonalDecomposition.h 40 * \b Q and \b Z are unitary matrices and \b T an upper triangular matrix of
174 * Only the upper triangular part should be referenced. To get it, use
175 * \code matrixT().template triangularView<Upper>() \endcode
178 * matrixR().topLeftCorner(rank(), rank()).template triangularView<Upper>()
427 // where R11 is r-by-r (r = rank) upper triangular, R12 is
430 // Householder transformations from the right to the upper trapezoidal
432 // [R11 R12] = [T11 0] * Z, where T11 is r-by-r upper triangular and
512 .template triangularView<Upper>()
HouseholderQR.h 31 * by using Householder transformations. Here, \b Q a unitary matrix and \b R an upper triangular matrix.
364 .template triangularView<Upper>()
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 163 y.topRows(rk) = this->matrixR().topLeftCorner(rk, rk).template triangularView<Upper>().solve(y2.topRows(rk));

Completed in 221 milliseconds

1 2 3 45 6 7 8