/external/icu4c/data/brkitr/ |
sent.txt | 23 $Upper = [\p{Sentence_Break = Upper}]; 38 $UpperEx = $Upper ($Extend | $Format)*; 70 $NotLettersEx = [^$OLetter $Upper $Lower $Sep $CR $LF $ATerm $STerm] ($Extend | $Format)*;
|
sent_el.txt | 23 $Upper = [\p{Sentence_Break = Upper}]; 38 $UpperEx = $Upper ($Extend | $Format)*; 70 $NotLettersEx = [^$OLetter $Upper $Lower $Sep $CR $LF $ATerm $STerm] ($Extend | $Format)*;
|
/external/eigen/Eigen/src/Core/util/ |
Constants.h | 163 /** View matrix as an upper triangular matrix. */ 164 Upper=0x2, 165 /** %Matrix has ones on the diagonal; to be used in combination with #Lower or #Upper. */ 167 /** %Matrix has zeros on the diagonal; to be used in combination with #Lower or #Upper. */ 171 /** View matrix as an upper triangular matrix with ones on the diagonal. */ 172 UnitUpper=UnitDiag|Upper, 175 /** View matrix as an upper triangular matrix with zeros on the diagonal. */ 176 StrictlyUpper=ZeroDiag|Upper,
|
/external/eigen/lapack/ |
lu.cpp | 71 lu.triangularView<Upper>().solveInPlace(B); 75 lu.triangularView<Upper>().transpose().solveInPlace(B); 81 lu.triangularView<Upper>().adjoint().solveInPlace(B);
|
/external/eigen/doc/snippets/ |
class_FullPivLU.cpp | 13 Matrix5x3 u = lu.matrixLU().triangularView<Upper>();
|
/external/eigen/blas/ |
level3_impl.h | 78 func[NOTR | (LEFT << 2) | (UP << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|0, false,ColMajor,ColMajor>::run); 82 func[NOTR | (RIGHT << 2) | (UP << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Upper|0, false,ColMajor,ColMajor>::run); 87 func[TR | (LEFT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|0, false,RowMajor,ColMajor>::run); 88 func[ADJ | (LEFT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|0, Conj, RowMajor,ColMajor>::run); 91 func[TR | (RIGHT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Upper|0, false,RowMajor,ColMajor>::run); 92 func[ADJ | (RIGHT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Upper|0, Conj, RowMajor,ColMajor>::run); 95 func[NOTR | (LEFT << 2) | (UP << 3) | (UNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|UnitDiag,false,ColMajor,ColMajor>::run); 99 func[NOTR | (RIGHT << 2) | (UP << 3) | (UNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Upper|UnitDiag,false,ColMajor,ColMajor>::run); 104 func[TR | (LEFT << 2) | (LO << 3) | (UNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|UnitDiag,false,RowMajor,ColMajor>::run); 105 func[ADJ | (LEFT << 2) | (LO << 3) | (UNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|UnitDiag,Conj, RowMajor,ColMajor>::run) [all...] |
level2_impl.h | 84 func[NOTR | (UP << 2) | (NUNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|0, false,ColMajor>::run); 89 func[TR | (LO << 2) | (NUNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|0, false,RowMajor>::run); 90 func[ADJ | (LO << 2) | (NUNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|0, Conj, RowMajor>::run); 92 func[NOTR | (UP << 2) | (UNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|UnitDiag,false,ColMajor>::run); 97 func[TR | (LO << 2) | (UNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|UnitDiag,false,RowMajor>::run); 98 func[ADJ | (LO << 2) | (UNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|UnitDiag,Conj, RowMajor>::run); 139 func[NOTR | (UP << 2) | (NUNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|0, Scalar,false,Scalar,false,ColMajor>::run); 144 func[TR | (LO << 2) | (NUNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|0, Scalar,false,Scalar,false,RowMajor>::run); 145 func[ADJ | (LO << 2) | (NUNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|0, Scalar,Conj, Scalar,false,RowMajor>::run); 147 func[NOTR | (UP << 2) | (UNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|UnitDiag,Scalar,false,Scalar,false,ColMajor>::run) [all...] |
/external/eigen/Eigen/src/SparseCore/ |
SparseSelfAdjointView.h | 21 * \param UpLo can be either \c #Lower or \c #Upper 220 ((UpLo&(Upper|Lower))==(Upper|Lower)) 221 || ( (UpLo&Upper) && !LhsIsRowMajor) 316 if(UpLo==(Upper|Lower)) 320 else if(( UpLo==Lower && r>c) || ( UpLo==Upper && r<c)) 349 if(UpLo==(Upper|Lower)) 361 else if(( (UpLo&Lower)==Lower && r>c) || ( (UpLo&Upper)==Upper && r<c)) 386 DstUpLo = DstOrder==RowMajor ? (_DstUpLo==Upper ? Lower : Upper) : _DstUpLo [all...] |
TriangularSolver.h | 20 : (Mode & Upper) 21 ? Upper 62 struct sparse_solve_triangular_selector<Lhs,Rhs,Mode,Upper,RowMajor> 132 struct sparse_solve_triangular_selector<Lhs,Rhs,Mode,Upper,ColMajor> 169 eigen_assert((!(Mode & ZeroDiag)) && bool(Mode & (Upper|Lower))); 200 : (Mode & Upper) 201 ? Upper 294 eigen_assert( (!(Mode & ZeroDiag)) && bool(Mode & (Upper|Lower))); 317 this->template triangular<Flags&(Upper|Lower)>().solveInPlace(other);
|
/external/eigen/test/ |
product_trsolve.cpp | 48 VERIFY_TRSM(cmLhs .template triangularView<Upper>(), cmRhs); 50 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Upper>(), rmRhs); 51 VERIFY_TRSM(cmLhs.adjoint() .template triangularView<Upper>(), rmRhs); 61 VERIFY_TRSM_ONTHERIGHT(cmLhs .template triangularView<Upper>(), cmRhs); 63 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<Upper>(), rmRhs);
|
product_notemporary.cpp | 78 VERIFY_EVALUATION_COUNT( rm3.noalias() = (s1 * m1.adjoint()).template triangularView<Upper>() * (m2+m2), 1); 88 VERIFY_EVALUATION_COUNT( m3.noalias() = s2 * m2.adjoint() * (s1 * m1.adjoint()).template selfadjointView<Upper>(), 0); 93 VERIFY_EVALUATION_COUNT( m3.col(c0).noalias() -= (s1 * m1).adjoint().template selfadjointView<Upper>() * (-m2.row(c0)*s3).adjoint(), 1); 95 VERIFY_EVALUATION_COUNT( m3.block(r0,c0,r1,c1).noalias() += m1.block(r0,r0,r1,r1).template selfadjointView<Upper>() * (s1*m2.block(r0,c0,r1,c1)), 0); 96 VERIFY_EVALUATION_COUNT( m3.block(r0,c0,r1,c1).noalias() = m1.block(r0,r0,r1,r1).template selfadjointView<Upper>() * m2.block(r0,c0,r1,c1), 0);
|
cholesky.cpp | 36 MatrixType symmUp = symm.template triangularView<Upper>(); 40 CholType<MatrixType,Upper> cholup(symmUp); 86 SquareMatrixType symmUp = symm.template triangularView<Upper>(); 89 // to test if really Cholesky only uses the upper triangular part, uncomment the following 101 // test the upper mode 102 LLT<SquareMatrixType,Upper> cholup(symmUp); 128 SquareMatrixType symmUp = symm.template triangularView<Upper>(); 138 LDLT<SquareMatrixType,Upper> ldltup(symmUp);
|
/external/eigen/Eigen/src/Core/products/ |
SelfadjointRank2Update.h | 40 struct selfadjoint_rank2_update_selector<Scalar,Index,UType,VType,Upper> 73 // If MatrixType is row major, then we use the routine for lower triangular in the upper triangular case and 85 (IsRowMajor ? int(UpLo==Upper ? Lower : Upper) : UpLo)>
|
GeneralMatrixMatrixTriangular_MKL.h | 79 LowUp = IsLower ? Lower : Upper, \ 104 LowUp = IsLower ? Lower : Upper, \
|
TriangularSolverVector.h | 23 ((Mode&Upper)==Upper ? Lower : Upper) | (Mode&UnitDiag),
|
/external/eigen/Eigen/src/Core/ |
SelfAdjointView.h | 22 * \param TriangularPart can be either \c #Lower or \c #Upper 170 OtherPart = UpLo == Upper ? StrictlyLower : StrictlyUpper 180 OtherPart = UpLo == Upper ? StrictlyLower : StrictlyUpper 205 struct triangular_assignment_selector<Derived1, Derived2, (SelfAdjoint|Upper), UnrollCount, ClearOpposite> 214 triangular_assignment_selector<Derived1, Derived2, (SelfAdjoint|Upper), UnrollCount-1, ClearOpposite>::run(dst, src); 224 struct triangular_assignment_selector<Derived1, Derived2, SelfAdjoint|Upper, 0, ClearOpposite> 255 struct triangular_assignment_selector<Derived1, Derived2, SelfAdjoint|Upper, Dynamic, ClearOpposite>
|
SolveTriangular.h | 43 int Mode, // can be Upper/Lower | UnitDiag 154 ((Mode&Upper)==Upper ? Lower : Upper) | (Mode&UnitDiag), 178 eigen_assert((!(Mode & ZeroDiag)) && bool(Mode & (Upper|Lower))); 200 * is an upper (resp. lower) triangular matrix.
|
/external/ceres-solver/internal/ceres/ |
dense_normal_cholesky_solver.cc | 85 lhs.selfadjointView<Eigen::Upper>().rankUpdate(Aref.transpose()); 100 lhs.selfadjointView<Eigen::Upper>().llt().solve(rhs);
|
implicit_schur_complement_test.cc | 101 // lhs_ref is an upper triangular matrix. Construct a full version 112 schur_solution = lhs->selfadjointView<Eigen::Upper>().llt().solve(*rhs); 159 lhs.selfadjointView<Eigen::Upper>().llt().solve(rhs);
|
schur_eliminator_test.cc | 121 .triangularView<Eigen::Upper>() = R - Q.transpose() * P * Q; 162 .selfadjointView<Eigen::Upper>() 176 Matrix delta = (lhs_ref - lhs_expected).selfadjointView<Eigen::Upper>();
|
block_jacobi_preconditioner.cc | 97 // col_block_size).selfadjointView<Eigen::Upper>().rankUpdate(m); 113 block = block.selfadjointView<Eigen::Upper>()
|
/external/eigen/Eigen/src/Householder/ |
BlockHouseholder.h | 38 triFactor.col(i).head(i) = triFactor.block(0,0,i,i).template triangularView<Upper>() 60 tmp = T.template triangularView<Upper>().adjoint() * tmp;
|
/external/eigen/unsupported/Eigen/src/MatrixFunctions/ |
MatrixLogarithm.h | 45 * \param[in] A argument of matrix logarithm, should be upper triangular and atomic 254 .template triangularView<Upper>().solve(TminusI); 270 .template triangularView<Upper>().solve(TminusI); 288 .template triangularView<Upper>().solve(TminusI); 306 .template triangularView<Upper>().solve(TminusI); 326 .template triangularView<Upper>().solve(TminusI); 346 .template triangularView<Upper>().solve(TminusI); 368 .template triangularView<Upper>().solve(TminusI); 390 .template triangularView<Upper>().solve(TminusI); 414 .template triangularView<Upper>().solve(TminusI) [all...] |
/external/eigen/Eigen/src/Cholesky/ |
LLT_MKL.h | 78 template<> struct llt_inplace<EIGTYPE, Upper> \
|
LLT.h | 26 * \param UpLo the triangular part that will be used for the decompositon: Lower (default) or Upper. 47 * Note that during the decomposition, only the upper triangular part of A is considered. Therefore, 96 /** \returns a view of the upper triangular matrix U */ 179 * The strict upper part is not used and even not initialized. 316 if(rs>0) A11.adjoint().template triangularView<Upper>().template solveInPlace<OnTheRight>(A21); 329 template<typename Scalar> struct llt_inplace<Scalar, Upper> 356 typedef const TriangularView<const typename MatrixType::AdjointReturnType, Upper> MatrixU; 363 template<typename MatrixType> struct LLT_Traits<MatrixType,Upper> 366 typedef const TriangularView<const MatrixType, Upper> MatrixU; 370 { return llt_inplace<typename MatrixType::Scalar, Upper>::blocked(m)==-1; [all...] |