/external/eigen/test/ |
triangular.cpp | 1 // This file is triangularView of Eigen, a lightweight C++ template library 33 MatrixType m1up = m1.template triangularView<Upper>(); 34 MatrixType m2up = m2.template triangularView<Upper>(); 48 r1.template triangularView<Upper>() += m1; 54 m1.template triangularView<Upper>() = m2.transpose() + m2; 56 VERIFY_IS_APPROX(m3.template triangularView<Lower>().transpose().toDenseMatrix(), m1); 60 m1.template triangularView<Lower>() = m2.transpose() + m2; 61 VERIFY_IS_APPROX(m3.template triangularView<Lower>().toDenseMatrix(), m1); 63 VERIFY_IS_APPROX(m3.template triangularView<Lower>().conjugate().toDenseMatrix(), 64 m3.conjugate().template triangularView<Lower>().toDenseMatrix()) [all...] |
product_trmv.cpp | 1 // This file is triangularView of Eigen, a lightweight C++ template library 33 m3 = m1.template triangularView<Eigen::Lower>(); 34 VERIFY((m3 * v1).isApprox(m1.template triangularView<Eigen::Lower>() * v1, largerEps)); 35 m3 = m1.template triangularView<Eigen::Upper>(); 36 VERIFY((m3 * v1).isApprox(m1.template triangularView<Eigen::Upper>() * v1, largerEps)); 37 m3 = m1.template triangularView<Eigen::UnitLower>(); 38 VERIFY((m3 * v1).isApprox(m1.template triangularView<Eigen::UnitLower>() * v1, largerEps)); 39 m3 = m1.template triangularView<Eigen::UnitUpper>(); 40 VERIFY((m3 * v1).isApprox(m1.template triangularView<Eigen::UnitUpper>() * v1, largerEps)); 43 m3 = m1.template triangularView<Eigen::Lower>() [all...] |
product_trsolve.cpp | 46 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Lower>(), cmRhs); 47 VERIFY_TRSM(cmLhs.adjoint() .template triangularView<Lower>(), cmRhs); 48 VERIFY_TRSM(cmLhs .template triangularView<Upper>(), cmRhs); 49 VERIFY_TRSM(cmLhs .template triangularView<Lower>(), rmRhs); 50 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Upper>(), rmRhs); 51 VERIFY_TRSM(cmLhs.adjoint() .template triangularView<Upper>(), rmRhs); 53 VERIFY_TRSM(cmLhs.conjugate().template triangularView<UnitLower>(), cmRhs); 54 VERIFY_TRSM(cmLhs .template triangularView<UnitUpper>(), rmRhs); 56 VERIFY_TRSM(rmLhs .template triangularView<Lower>(), cmRhs); 57 VERIFY_TRSM(rmLhs.conjugate().template triangularView<UnitUpper>(), rmRhs) [all...] |
sparse_solvers.cpp | 53 VERIFY_IS_APPROX(refMat2.template triangularView<Lower>().solve(vec2), 54 m2.template triangularView<Lower>().solve(vec3)); 58 VERIFY_IS_APPROX(refMat2.template triangularView<Upper>().solve(vec2), 59 m2.template triangularView<Upper>().solve(vec3)); 60 VERIFY_IS_APPROX(refMat2.conjugate().template triangularView<Upper>().solve(vec2), 61 m2.conjugate().template triangularView<Upper>().solve(vec3)); 66 VERIFY_IS_APPROX(refMat2.conjugate().template triangularView<Upper>().solve(vec2), 67 mm2.conjugate().template triangularView<Upper>().solve(vec3)); 72 VERIFY_IS_APPROX(refMat2.transpose().template triangularView<Upper>().solve(vec2), 73 m2.transpose().template triangularView<Upper>().solve(vec3)) [all...] |
selfadjoint.cpp | 1 // This file is triangularView of Eigen, a lightweight C++ template library 31 VERIFY_IS_APPROX(MatrixType(m3.template triangularView<Upper>()), MatrixType(m1.template triangularView<Upper>())); 36 VERIFY_IS_APPROX(MatrixType(m3.template triangularView<Lower>()), MatrixType(m1.template triangularView<Lower>()));
|
product_trmm.cpp | 37 tri = mat.template triangularView<Mode>(); 38 triTr = mat.transpose().template triangularView<Mode>(); 42 VERIFY_IS_APPROX( ge_xs = mat.template triangularView<Mode>() * ge_right, tri * ge_right); 43 VERIFY_IS_APPROX( ge_sx = ge_left * mat.template triangularView<Mode>(), ge_left * tri); 45 VERIFY_IS_APPROX( ge_xs.noalias() = mat.template triangularView<Mode>() * ge_right, tri * ge_right); 46 VERIFY_IS_APPROX( ge_sx.noalias() = ge_left * mat.template triangularView<Mode>(), ge_left * tri); 48 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.transpose()), s1*triTr.conjugate() * (s2*ge_left.transpose())); 49 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.transpose() * mat.adjoint().template triangularView<Mode>(), ge_right.transpose() * triTr.conjugate()); 51 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.adjoint()), s1*triTr.conjugate() * (s2*ge_left.adjoint())); 52 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.adjoint() * mat.adjoint().template triangularView<Mode>(), ge_right.adjoint() * triTr.conjugate()) [all...] |
product_selfadjoint.cpp | 42 m2 = m1.template triangularView<Lower>(); 44 VERIFY_IS_APPROX(m2, (m1 + v1 * v2.adjoint()+ v2 * v1.adjoint()).template triangularView<Lower>().toDenseMatrix()); 46 m2 = m1.template triangularView<Upper>(); 48 VERIFY_IS_APPROX(m2, (m1 + (s3*(-v1)*(s2*v2).adjoint()+internal::conj(s3)*(s2*v2)*(-v1).adjoint())).template triangularView<Upper>().toDenseMatrix()); 50 m2 = m1.template triangularView<Upper>(); 52 VERIFY_IS_APPROX(m2, (m1 + s1*(-s2*r1.adjoint())*(r2.adjoint()*s3).adjoint() + internal::conj(s1)*(r2.adjoint()*s3) * (-s2*r1.adjoint()).adjoint()).template triangularView<Upper>().toDenseMatrix()); 56 m2 = m1.template triangularView<Lower>(); 60 VERIFY_IS_APPROX(m2, m3.template triangularView<Lower>().toDenseMatrix());
|
sparse_permutations.cpp | 32 up = mat.template triangularView<Upper>(); 33 lo = mat.template triangularView<Lower>(); 39 VERIFY_IS_APPROX(up, DenseMatrix(mat_d.template triangularView<Upper>())); 40 VERIFY_IS_APPROX(lo, DenseMatrix(mat_d.template triangularView<Lower>())); 104 res_d = up_sym_d.template triangularView<Upper>(); 108 res_d = up_sym_d.template triangularView<Lower>(); 112 res_d = lo_sym_d.template triangularView<Upper>(); 116 res_d = lo_sym_d.template triangularView<Lower>(); 122 res_d = ((p * up_sym_d) * p.inverse()).eval().template triangularView<Upper>(); 126 res_d = ((p * lo_sym_d) * p.inverse()).eval().template triangularView<Upper>() [all...] |
product_syrk.cpp | 37 ((s1 * rhs2 * rhs2.adjoint()).eval().template triangularView<Lower>().toDenseMatrix())); 41 (s1 * rhs2 * rhs2.adjoint()).eval().template triangularView<Upper>().toDenseMatrix()); 45 (s1 * rhs1.adjoint() * rhs1).eval().template triangularView<Lower>().toDenseMatrix()); 49 (s1 * rhs1.adjoint() * rhs1).eval().template triangularView<Upper>().toDenseMatrix()); 53 (s1 * rhs3.adjoint() * rhs3).eval().template triangularView<Lower>().toDenseMatrix()); 57 (s1 * rhs3.adjoint() * rhs3).eval().template triangularView<Upper>().toDenseMatrix()); 61 ((s1 * m1.col(c) * m1.col(c).adjoint()).eval().template triangularView<Lower>().toDenseMatrix())); 65 ((s1 * m1.col(c) * m1.col(c).adjoint()).eval().template triangularView<Upper>().toDenseMatrix())); 69 ((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Lower>().toDenseMatrix())); 73 ((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Upper>().toDenseMatrix())) [all...] |
product_symm.cpp | 38 m2 = m1.template triangularView<Lower>(); 44 m2 = m1.template triangularView<Upper>(); rhs12.setRandom(); rhs13 = rhs12; 50 m2 = m1.template triangularView<Lower>(); 54 m2 = m1.template triangularView<Upper>(); 58 m2 = m1.template triangularView<Upper>(); 63 m2 = m1.template triangularView<Lower>(); rhs12.setRandom(); rhs13 = rhs12; 67 m2 = m1.template triangularView<Upper>(); 72 m2 = m1.template triangularView<Upper>(); rhs13 = rhs12; 76 m2 = m1.template triangularView<Lower>();
|
nomalloc.cpp | 63 m2.col(0).noalias() = m1.template triangularView<Upper>() * m1.col(0); 64 m2.col(0).noalias() -= m1.adjoint().template triangularView<Upper>() * m1.col(0); 65 m2.col(0).noalias() -= m1.template triangularView<Upper>() * m1.row(0).adjoint(); 66 m2.col(0).noalias() -= m1.adjoint().template triangularView<Upper>() * m1.row(0).adjoint(); 68 m2.row(0).noalias() = m1.row(0) * m1.template triangularView<Upper>(); 69 m2.row(0).noalias() -= m1.row(0) * m1.adjoint().template triangularView<Upper>(); 70 m2.row(0).noalias() -= m1.col(0).adjoint() * m1.template triangularView<Upper>(); 71 m2.row(0).noalias() -= m1.col(0).adjoint() * m1.adjoint().template triangularView<Upper>(); 89 // m1 += m1.template triangularView<Upper>() * m2.col(; 91 // m1 += m1.template triangularView<Upper>() * m2 [all...] |
product_notemporary.cpp | 77 VERIFY_EVALUATION_COUNT( m3.noalias() -= (s1 * m1).template triangularView<Lower>() * m2, 0); 78 VERIFY_EVALUATION_COUNT( rm3.noalias() = (s1 * m1.adjoint()).template triangularView<Upper>() * (m2+m2), 1); 79 VERIFY_EVALUATION_COUNT( rm3.noalias() = (s1 * m1.adjoint()).template triangularView<UnitUpper>() * m2.adjoint(), 0); 82 VERIFY_EVALUATION_COUNT( rm3.col(c0).noalias() = (s1 * m1.adjoint()).template triangularView<UnitUpper>() * (s2*m2.row(c0)).adjoint(), 1); 84 VERIFY_EVALUATION_COUNT( m1.template triangularView<Lower>().solveInPlace(m3), 0); 85 VERIFY_EVALUATION_COUNT( m1.adjoint().template triangularView<Lower>().solveInPlace(m3.transpose()), 0); 104 VERIFY_EVALUATION_COUNT( m3.noalias() = m1.block(r0,r0,r1,r1).template triangularView<UnitUpper>() * m2.block(r0,c0,r1,c1), 1);
|
bandmatrix.cpp | 1 // This file is triangularView of Eigen, a lightweight C++ template library 53 dm1.block(0,supers+1,cols-supers-1-a,cols-supers-1-a).template triangularView<Upper>().setZero(); 54 dm1.block(subs+1,0,rows-subs-1-b,rows-subs-1-b).template triangularView<Lower>().setZero();
|
cholesky.cpp | 35 MatrixType symmLo = symm.template triangularView<Lower>(); 36 MatrixType symmUp = symm.template triangularView<Upper>(); 86 SquareMatrixType symmUp = symm.template triangularView<Upper>(); 87 SquareMatrixType symmLo = symm.template triangularView<Lower>(); 128 SquareMatrixType symmUp = symm.template triangularView<Upper>(); 129 SquareMatrixType symmLo = symm.template triangularView<Lower>(); 219 RealMatrixType symmLo = symm.template triangularView<Lower>(); 238 RealMatrixType symmLo = symm.template triangularView<Lower>();
|
/external/eigen/doc/snippets/ |
Tutorial_solve_triangular_inplace.cpp | 5 A.triangularView<Upper>().solveInPlace(b);
|
Tutorial_solve_triangular.cpp | 7 Vector3f x = A.triangularView<Upper>().solve(b);
|
class_FullPivLU.cpp | 10 l.block<5,3>(0,0).triangularView<StrictlyLower>() = lu.matrixLU(); 13 Matrix5x3 u = lu.matrixLU().triangularView<Upper>();
|
/external/eigen/doc/examples/ |
TemplateKeyword_flexible.cpp | 10 dst.template triangularView<Upper>() = src.template triangularView<Upper>();
|
TemplateKeyword_simple.cpp | 8 dst.triangularView<Upper>() = src.triangularView<Upper>();
|
/external/eigen/lapack/ |
lu.cpp | 70 lu.triangularView<UnitLower>().solveInPlace(B); 71 lu.triangularView<Upper>().solveInPlace(B); 75 lu.triangularView<Upper>().transpose().solveInPlace(B); 76 lu.triangularView<UnitLower>().transpose().solveInPlace(B); 81 lu.triangularView<Upper>().adjoint().solveInPlace(B); 82 lu.triangularView<UnitLower>().adjoint().solveInPlace(B);
|
cholesky.cpp | 62 A.triangularView<Upper>().adjoint().solveInPlace(B); 63 A.triangularView<Upper>().solveInPlace(B); 67 A.triangularView<Lower>().solveInPlace(B); 68 A.triangularView<Lower>().adjoint().solveInPlace(B);
|
/external/eigen/Eigen/src/Eigen2Support/ |
TriangularSolver.h | 30 return m_matrix.template triangularView<Added>().solve(other.derived()); 37 m_matrix.template triangularView<Added>().solveInPlace(other.derived());
|
QR.h | 46 const TriangularView<MatrixRBlockType, UpperTriangular> 50 return MatrixRBlockType(this->matrixQR(), 0, 0, cols, cols).template triangularView<UpperTriangular>();
|
/external/eigen/Eigen/src/Householder/ |
BlockHouseholder.h | 38 triFactor.col(i).head(i) = triFactor.block(0,0,i,i).template triangularView<Upper>() 54 const TriangularView<const VectorsType, UnitLower>& V(vectors); 60 tmp = T.template triangularView<Upper>().adjoint() * tmp;
|
/external/eigen/blas/ |
level3_impl.h | 275 matA.triangularView<Upper>() = matrix(a,size,size,*lda); 276 matA.triangularView<Lower>() = matrix(a,size,size,*lda).transpose(); 280 matA.triangularView<Lower>() = matrix(a,size,size,*lda); 281 matA.triangularView<Upper>() = matrix(a,size,size,*lda).transpose(); 346 if(beta==Scalar(0)) matrix(c, *n, *n, *ldc).triangularView<Upper>().setZero(); 347 else matrix(c, *n, *n, *ldc).triangularView<Upper>() *= beta; 349 if(beta==Scalar(0)) matrix(c, *n, *n, *ldc).triangularView<Lower>().setZero(); 350 else matrix(c, *n, *n, *ldc).triangularView<Lower>() *= beta; 358 matrix(c, *n, *n, *ldc).triangularView<Upper>() += alpha * matrix(a,*n,*k,*lda) * matrix(a,*n,*k,*lda).transpose(); 360 matrix(c, *n, *n, *ldc).triangularView<Upper>() += alpha * matrix(a,*k,*n,*lda).transpose() * matrix(a,*k,*n,*lda) [all...] |