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

1 2 3 45 6

  /external/eigen/Eigen/src/Core/products/
TriangularSolverMatrix.h 29 (Mode&UnitDiag) | ((Mode&Upper) ? Lower : Upper),
TriangularMatrixVector.h 204 typedef TriangularProduct<(Mode & (UnitDiag|ZeroDiag)) | ((Mode & Lower) ? Upper : Lower),true,Transpose<const Rhs>,false,Transpose<const Lhs>,true> TriangularProductTranspose;
  /external/eigen/test/
sparse_product.cpp 205 VERIFY_IS_APPROX(x=mUp.template selfadjointView<Upper>()*b, refX=refS*b);
207 VERIFY_IS_APPROX(x=mS.template selfadjointView<Upper|Lower>()*b, refX=refS*b);
sparse_basic.cpp 402 refMat3 = refMat2.template triangularView<Upper>();
403 m3 = m2.template triangularView<Upper>();
jacobisvd.cpp 137 Matrix<Scalar,Dynamic,1> tmp = qr.matrixQR().topLeftCorner(rank,rank).template triangularView<Upper>().adjoint().solve(rhs2);
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
HybridNonLinearSolver.h 260 wa3 = R.template triangularView<Upper>()*wa1 + qtf;
503 wa3 = R.template triangularView<Upper>()*wa1 + qtf;
lmpar.h 91 /* calculate an upper bound, paru, for the zero of the function. */
202 qr.matrixQR().topLeftCorner(rank, rank).template triangularView<Upper>().solveInPlace(wa1.head(rank));
229 /* calculate an upper bound, paru, for the zero of the function. */
LevenbergMarquardt.h 292 wa3 = fjac.template triangularView<Upper>() * (qrfac.colsPermutation().inverse() *wa1);
542 wa3 = fjac.topLeftCorner(n,n).template triangularView<Upper>() * (permutation.inverse() * wa1);
  /external/eigen/Eigen/src/QR/
HouseholderQR.h 31 * by using Householder transformations. Here, \b Q a unitary matrix and \b R an upper triangular matrix.
327 .template triangularView<Upper>()
ColPivHouseholderQR.h 30 * upper triangular matrix.
164 * Only the upper triangular part should be referenced. To get it, use
165 * \code matrixR().template triangularView<Upper>() \endcode
168 * matrixR().topLeftCorner(rank(), rank()).template triangularView<Upper>()
548 .template triangularView<Upper>()
FullPivHouseholderQR.h 42 * upper triangular matrix.
523 .template triangularView<Upper>()
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 154 y.topRows(rk) = this->matrixR().topLeftCorner(rk, rk).template triangularView<Upper>().solve(y.topRows(rk));
  /external/eigen/bench/btl/libs/eigen3/
eigen3_interface.hh 198 X = L.template triangularView<Upper>().solve(B);
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
GMRES.h 147 // insert coefficients into upper matrix triangle
154 // solve upper triangular system
156 H.topLeftCorner(k, k).template triangularView < Eigen::Upper > ().solveInPlace(y);
IncompleteCholesky.h 101 x = m_L.adjoint().template triangularView<Upper>().solve(x);
  /external/eigen/Eigen/src/SuperLUSupport/
SuperLUSupport.h 194 if (MatrixType::Flags & Upper)
253 if (MatrixType::Flags & Upper)
491 typedef TriangularView<LUMatrixType, Upper> UMatrixType;
695 int upper; local
725 upper = 1;
740 for (int i = 0; i < upper; ++i)
742 /* upper triangle in the supernode */
752 Lrow[lastl++] = L_SUB(istart + upper - 1);
753 for (int i = upper; i < nsupr; ++i)
762 ++upper;
    [all...]
  /external/eigen/Eigen/src/CholmodSupport/
CholmodSupport.h 112 if(UpLo==Upper) res.stype = 1;
377 * or Upper. Default is Lower.
379 * This class supports all kind of SparseMatrix<>: row or column major; upper, lower, or both; compressed or non compressed.
424 * or Upper. Default is Lower.
426 * This class supports all kind of SparseMatrix<>: row or column major; upper, lower, or both; compressed or non compressed.
469 * or Upper. Default is Lower.
471 * This class supports all kind of SparseMatrix<>: row or column major; upper, lower, or both; compressed or non compressed.
516 * or Upper. Default is Lower.
518 * This class supports all kind of SparseMatrix<>: row or column major; upper, lower, or both; compressed or non compressed.
  /external/eigen/Eigen/src/IterativeLinearSolvers/
IncompleteLUT.h 165 x = m_lu.template triangularView<Upper>().solve(x);
278 // 1 - copy the lower and the upper part of the row i of mat in the working vector u
280 Index sizeu = 1; // number of nonzero elements in the upper part of the current row
305 // copy the upper part
368 if (j >= ii) // dealing with the upper part
395 // reset the upper part of the pointer jr to zero
  /external/llvm/include/llvm/Analysis/
DependenceAnalysis.h 360 const SCEV *Upper[8];
565 /// If no upper bound is available, return NULL.
    [all...]
  /external/eigen/lapack/
clarft.f 40 *> If DIRECT = 'F', H = H(1) H(2) . . . H(k) and T is upper triangular;
115 *> If DIRECT = 'F', T is upper triangular; if DIRECT = 'B', T is
253 CALL CTRMV( 'Upper', 'No transpose', 'Non-unit', I-1, T,
dlarft.f 40 *> If DIRECT = 'F', H = H(1) H(2) . . . H(k) and T is upper triangular;
115 *> If DIRECT = 'F', T is upper triangular; if DIRECT = 'B', T is
251 CALL DTRMV( 'Upper', 'No transpose', 'Non-unit', I-1, T,
slarft.f 40 *> If DIRECT = 'F', H = H(1) H(2) . . . H(k) and T is upper triangular;
115 *> If DIRECT = 'F', T is upper triangular; if DIRECT = 'B', T is
251 CALL STRMV( 'Upper', 'No transpose', 'Non-unit', I-1, T,
zlarft.f 40 *> If DIRECT = 'F', H = H(1) H(2) . . . H(k) and T is upper triangular;
115 *> If DIRECT = 'F', T is upper triangular; if DIRECT = 'B', T is
252 CALL ZTRMV( 'Upper', 'No transpose', 'Non-unit', I-1, T,
  /external/eigen/Eigen/src/SparseLU/
SparseLU.h 336 MappedSparseMatrix<Scalar,ColMajor,Index> m_Ustore; // The upper triangular matrix
554 Index panel_size = m_perfv.panel_size; // upper bound on panel width
647 // Create the column major upper sparse matrix U;
705 U = A.template triangularView<Upper>().solve(U);
  /external/eigen/Eigen/src/SparseQR/
SparseQR.h 45 * given by A*P = Q*R where R is upper triangular or trapezoidal.
114 /** \returns a const reference to the \b sparse upper triangular matrix R of the QR factorization.
179 y.topRows(rank) = this->matrixR().topLeftCorner(rank, rank).template triangularView<Upper>().solve(b.topRows(rank));

Completed in 744 milliseconds

1 2 3 45 6