Searched refs:triangularView (Results 1 - 25 of 88) sorted by relevance

1234

/external/eigen/test/
H A Dtriangular.cpp1 // 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<Lowe
[all...]
H A Dproduct_trmv.cpp1 // 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<Eige
[all...]
H A Dproduct_syrk.cpp39 ((s1 * rhs2 * rhs2.adjoint()).eval().template triangularView<Lower>().toDenseMatrix()));
41 VERIFY_IS_APPROX(((m2.template triangularView<Lower>() += s1 * rhs2 * rhs22.adjoint()).nestedExpression()),
42 ((s1 * rhs2 * rhs22.adjoint()).eval().template triangularView<Lower>().toDenseMatrix()));
47 (s1 * rhs2 * rhs2.adjoint()).eval().template triangularView<Upper>().toDenseMatrix());
49 VERIFY_IS_APPROX((m2.template triangularView<Upper>() += s1 * rhs22 * rhs2.adjoint()).nestedExpression(),
50 (s1 * rhs22 * rhs2.adjoint()).eval().template triangularView<Upper>().toDenseMatrix());
55 (s1 * rhs1.adjoint() * rhs1).eval().template triangularView<Lower>().toDenseMatrix());
57 VERIFY_IS_APPROX((m2.template triangularView<Lower>() += s1 * rhs11.adjoint() * rhs1).nestedExpression(),
58 (s1 * rhs11.adjoint() * rhs1).eval().template triangularView<Lower>().toDenseMatrix());
63 (s1 * rhs1.adjoint() * rhs1).eval().template triangularView<Uppe
[all...]
H A Dproduct_trsolve.cpp46 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<UnitUppe
[all...]
H A Dsparse_solvers.cpp53 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<Uppe
[all...]
H A Dselfadjoint.cpp1 // This file is triangularView of Eigen, a lightweight C++ template library
30 VERIFY_IS_APPROX(MatrixType(m3.template triangularView<Upper>()), MatrixType(m1.template triangularView<Upper>()));
35 VERIFY_IS_APPROX(MatrixType(m3.template triangularView<Lower>()), MatrixType(m1.template triangularView<Lower>()));
H A Dproduct_trmm.cpp35 tri = mat.template triangularView<Mode>();
36 triTr = mat.transpose().template triangularView<Mode>();
40 VERIFY_IS_APPROX( ge_xs = mat.template triangularView<Mode>() * ge_right, tri * ge_right);
41 VERIFY_IS_APPROX( ge_sx = ge_left * mat.template triangularView<Mode>(), ge_left * tri);
43 VERIFY_IS_APPROX( ge_xs.noalias() = mat.template triangularView<Mode>() * ge_right, tri * ge_right);
44 VERIFY_IS_APPROX( ge_sx.noalias() = ge_left * mat.template triangularView<Mode>(), ge_left * tri);
46 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.transpose()), s1*triTr.conjugate() * (s2*ge_left.transpose()));
47 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.transpose() * mat.adjoint().template triangularView<Mode>(), ge_right.transpose() * triTr.conjugate());
49 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.adjoint()), s1*triTr.conjugate() * (s2*ge_left.adjoint()));
50 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.adjoint() * mat.adjoint().template triangularView<Mod
[all...]
H A Dproduct_selfadjoint.cpp41 m2 = m1.template triangularView<Lower>();
43 VERIFY_IS_APPROX(m2, (m1 + v1 * v2.adjoint()+ v2 * v1.adjoint()).template triangularView<Lower>().toDenseMatrix());
45 m2 = m1.template triangularView<Upper>();
47 VERIFY_IS_APPROX(m2, (m1 + (s3*(-v1)*(s2*v2).adjoint()+numext::conj(s3)*(s2*v2)*(-v1).adjoint())).template triangularView<Upper>().toDenseMatrix());
49 m2 = m1.template triangularView<Upper>();
51 VERIFY_IS_APPROX(m2, (m1 + s1*(-s2*r1.adjoint())*(r2.adjoint()*s3).adjoint() + numext::conj(s1)*(r2.adjoint()*s3) * (-s2*r1.adjoint()).adjoint()).template triangularView<Upper>().toDenseMatrix());
55 m2 = m1.template triangularView<Lower>();
59 VERIFY_IS_APPROX(m2, m3.template triangularView<Lower>().toDenseMatrix());
H A Dsparse_permutations.cpp32 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<Uppe
[all...]
H A Dproduct_symm.cpp36 m2 = m1.template triangularView<Lower>();
42 m2 = m1.template triangularView<Upper>(); rhs12.setRandom(); rhs13 = rhs12;
48 m2 = m1.template triangularView<Lower>();
52 m2 = m1.template triangularView<Upper>();
56 m2 = m1.template triangularView<Upper>();
61 m2 = m1.template triangularView<Lower>(); rhs12.setRandom(); rhs13 = rhs12;
65 m2 = m1.template triangularView<Upper>();
70 m2 = m1.template triangularView<Upper>(); rhs13 = rhs12;
74 m2 = m1.template triangularView<Lower>();
H A Dproduct_notemporary.cpp77 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);
81 VERIFY_EVALUATION_COUNT( m3.template triangularView<Upper>() = (m1 * m2.adjoint()), 0);
82 VERIFY_EVALUATION_COUNT( m3.template triangularView<Upper>() -= (m1 * m2.adjoint()), 0);
85 VERIFY_EVALUATION_COUNT( rm3.col(c0).noalias() = (s1 * m1.adjoint()).template triangularView<UnitUpper>() * (s2*m2.row(c0)).adjoint(), 1);
87 VERIFY_EVALUATION_COUNT( m1.template triangularView<Lower>().solveInPlace(m3), 0);
88 VERIFY_EVALUATION_COUNT( m1.adjoint().template triangularView<Lower>().solveInPlace(m3.transpose()), 0);
107 VERIFY_EVALUATION_COUNT( m3.noalias() = m1.block(r0,r0,r1,r1).template triangularView<UnitUpper>() * m2.block(r0,c0,r1,c1), 1);
H A Dnomalloc.cpp68 m2.col(0).noalias() = m1.template triangularView<Upper>() * m1.col(0);
69 m2.col(0).noalias() -= m1.adjoint().template triangularView<Upper>() * m1.col(0);
70 m2.col(0).noalias() -= m1.template triangularView<Upper>() * m1.row(0).adjoint();
71 m2.col(0).noalias() -= m1.adjoint().template triangularView<Upper>() * m1.row(0).adjoint();
73 m2.row(0).noalias() = m1.row(0) * m1.template triangularView<Upper>();
74 m2.row(0).noalias() -= m1.row(0) * m1.adjoint().template triangularView<Upper>();
75 m2.row(0).noalias() -= m1.col(0).adjoint() * m1.template triangularView<Upper>();
76 m2.row(0).noalias() -= m1.col(0).adjoint() * m1.adjoint().template triangularView<Upper>();
94 // m1 += m1.template triangularView<Upper>() * m2.col(;
96 // m1 += m1.template triangularView<Uppe
[all...]
H A Dbandmatrix.cpp1 // 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();
H A Dproduct_mmtr.cpp14 DEST.template triangularView<TRI>() OP; \
16 ref2.template triangularView<TRI>() = ref1; \
/external/eigen/doc/snippets/
H A DTutorial_solve_triangular_inplace.cpp5 A.triangularView<Upper>().solveInPlace(b);
H A DTutorial_solve_triangular.cpp7 Vector3f x = A.triangularView<Upper>().solve(b);
H A Dclass_FullPivLU.cpp10 l.block<5,3>(0,0).triangularView<StrictlyLower>() = lu.matrixLU();
13 Matrix5x3 u = lu.matrixLU().triangularView<Upper>();
/external/eigen/doc/examples/
H A DTemplateKeyword_flexible.cpp10 dst.template triangularView<Upper>() = src.template triangularView<Upper>();
H A DTemplateKeyword_simple.cpp8 dst.triangularView<Upper>() = src.triangularView<Upper>();
/external/eigen/lapack/
H A Dlu.cpp70 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);
H A Dcholesky.cpp62 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/
H A DTriangularSolver.h30 return m_matrix.template triangularView<Added>().solve(other.derived());
37 m_matrix.template triangularView<Added>().solveInPlace(other.derived());
/external/eigen/Eigen/src/Householder/
H A DBlockHouseholder.h38 triFactor.col(i).head(i) = triFactor.block(0,0,i,i).template triangularView<Upper>()
60 tmp = T.template triangularView<Upper>().adjoint() * tmp;
/external/eigen/blas/
H A Dlevel3_impl.h275 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();
348 if(beta==Scalar(0)) matrix(c, *n, *n, *ldc).triangularView<Upper>().setZero();
349 else matrix(c, *n, *n, *ldc).triangularView<Upper>() *= beta;
351 if(beta==Scalar(0)) matrix(c, *n, *n, *ldc).triangularView<Lower>().setZero();
352 else matrix(c, *n, *n, *ldc).triangularView<Lower>() *= beta;
360 matrix(c, *n, *n, *ldc).triangularView<Upper>() += alpha * matrix(a,*n,*k,*lda) * matrix(a,*n,*k,*lda).transpose();
362 matrix(c, *n, *n, *ldc).triangularView<Uppe
[all...]
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DIncompleteLU.h76 x = m_lu.template triangularView<UnitLower>().solve(b);
77 x = m_lu.template triangularView<Upper>().solve(x);

Completed in 234 milliseconds

1234