Searched refs:conjugate (Results 1 - 25 of 51) sorted by relevance

123

/external/eigen/doc/snippets/
H A Dtut_arithmetic_transpose_conjugate.cpp7 cout << "Here is the conjugate of a\n" << a.conjugate() << endl;
/external/eigen/test/
H A Dproduct_extra.cpp51 VERIFY_IS_APPROX( m1.adjoint() * (s1*m2).conjugate(), (m1.adjoint()).eval() * ((s1*m2).conjugate()).eval());
54 // test all possible conjugate combinations for the four matrix-vector product cases:
56 VERIFY_IS_APPROX((-m1.conjugate() * s2) * (s1 * vc2),
57 (-m1.conjugate()*s2).eval() * (s1 * vc2).eval());
58 VERIFY_IS_APPROX((-m1 * s2) * (s1 * vc2.conjugate()),
59 (-m1*s2).eval() * (s1 * vc2.conjugate()).eval());
60 VERIFY_IS_APPROX((-m1.conjugate() * s2) * (s1 * vc2.conjugate()),
61 (-m1.conjugate()*s
[all...]
H A Dproduct_trmv.cpp44 VERIFY(((s1*m3).conjugate() * v1).isApprox((s1*m1).conjugate().template triangularView<Eigen::Lower>() * v1, largerEps));
46 VERIFY((m3.conjugate() * v1.conjugate()).isApprox(m1.conjugate().template triangularView<Eigen::Upper>() * v1.conjugate(), largerEps));
62 VERIFY((m3.adjoint() * (s1*v1.conjugate())).isApprox(m1.adjoint().template triangularView<Eigen::Upper>() * (s1*v1.conjugate()), largerEps));
H A Dproduct_trsolve.cpp46 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Lower>(), cmRhs);
50 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Upper>(), rmRhs);
53 VERIFY_TRSM(cmLhs.conjugate().template triangularView<UnitLower>(), cmRhs);
57 VERIFY_TRSM(rmLhs.conjugate().template triangularView<UnitUpper>(), rmRhs);
60 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<Lower>(), cmRhs);
63 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<Upper>(), rmRhs);
65 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<UnitLower>(), cmRhs);
69 VERIFY_TRSM_ONTHERIGHT(rmLhs.conjugate().template triangularView<UnitUpper>(), rmRhs);
H A Dproduct_trmm.cpp46 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<Mode>(), ge_right.adjoint() * triTr.conjugate());
53 VERIFY_IS_APPROX( (ge_xs_save + s1*triTr.conjugate() * (s2*ge_left.adjoint())).eval(), ge_xs.noalias() += (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.adjoint()) );
56 VERIFY_IS_APPROX( ge_sx_save - (ge_right.adjoint() * (-s1 * triTr).conjugate()).eval(), ge_sx.noalias() -= (ge_right.adjoint() * (-s1 * mat).adjoint().template triangularView<Mode>()).eval());
58 VERIFY_IS_APPROX( ge_xs = (s1*mat).adjoint().template triangularView<Mode>() * ge_left.adjoint(), numext::conj(s1) * triTr.conjugate() * ge_left.adjoint());
H A Dhouseholder.cpp87 HCoeffsVectorType hc = qr.hCoeffs().conjugate();
100 SquareMatrixType hseq_mat_conj = hseq.conjugate();
105 VERIFY_IS_APPROX(hseq_mat.conjugate(), hseq_mat_conj);
109 VERIFY_IS_APPROX(hseq_mat.conjugate() * m6, hseq_mat_conj * m6);
113 VERIFY_IS_APPROX(m6 * hseq_mat.conjugate(), m6 * hseq_mat_conj);
H A Dproduct_syrk.cpp94 VERIFY_IS_APPROX((m2.template selfadjointView<Lower>().rankUpdate(m1.col(c).conjugate(),s1)._expression()),
95 ((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Lower>().toDenseMatrix()));
98 VERIFY_IS_APPROX((m2.template selfadjointView<Upper>().rankUpdate(m1.col(c).conjugate(),s1)._expression()),
99 ((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Upper>().toDenseMatrix()));
H A Dproduct_symm.cpp66 VERIFY_IS_APPROX(rhs12 = (s1*m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate(),
67 rhs13 = (s1*m1.adjoint()) * (s2*rhs3).conjugate());
71 VERIFY_IS_APPROX(rhs12.noalias() += s1 * ((m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate()),
72 rhs13 += (s1*m1.adjoint()) * (s2*rhs3).conjugate());
H A Dsparse_solvers.cpp60 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));
H A Dadjoint.cpp83 // check basic compatibility of adjoint, transpose, conjugate
84 VERIFY_IS_APPROX(m1.transpose().conjugate().adjoint(), m1);
85 VERIFY_IS_APPROX(m1.adjoint().conjugate().transpose(), m1);
102 VERIFY_IS_APPROX(m1.conjugate()(r,c), numext::conj(m1(r,c)));
117 VERIFY_IS_APPROX(m3,m1.conjugate());
145 VERIFY_RAISES_ASSERT(a = a.conjugate().transpose());
H A Dtriangular.cpp63 VERIFY_IS_APPROX(m3.template triangularView<Lower>().conjugate().toDenseMatrix(),
64 m3.conjugate().template triangularView<Lower>().toDenseMatrix());
79 VERIFY(v2.isApprox(m3.conjugate() * (m1.conjugate().template triangularView<Lower>().solve(v2)), largerEps));
89 VERIFY(m2.isApprox(m3.conjugate() * (m1.conjugate().template triangularView<Lower>().solve(m2)), largerEps));
H A Dcholesky.cpp113 VERIFY_IS_APPROX(MatrixType(chollo.matrixL().transpose().conjugate()), MatrixType(chollo.matrixU()));
114 VERIFY_IS_APPROX(MatrixType(chollo.matrixU().transpose().conjugate()), MatrixType(chollo.matrixL()));
115 VERIFY_IS_APPROX(MatrixType(cholup.matrixL().transpose().conjugate()), MatrixType(cholup.matrixU()));
116 VERIFY_IS_APPROX(MatrixType(cholup.matrixU().transpose().conjugate()), MatrixType(cholup.matrixL()));
160 VERIFY_IS_APPROX(MatrixType(ldltlo.matrixL().transpose().conjugate()), MatrixType(ldltlo.matrixU()));
161 VERIFY_IS_APPROX(MatrixType(ldltlo.matrixU().transpose().conjugate()), MatrixType(ldltlo.matrixL()));
162 VERIFY_IS_APPROX(MatrixType(ldltup.matrixL().transpose().conjugate()), MatrixType(ldltup.matrixU()));
163 VERIFY_IS_APPROX(MatrixType(ldltup.matrixU().transpose().conjugate()), MatrixType(ldltup.matrixL()));
H A Dgeo_quaternion.cpp140 // inverse and conjugate
142 VERIFY_IS_APPROX(q1 * (q1.conjugate() * v1), v1);
214 VERIFY_IS_APPROX(mq1 * (mq1.conjugate() * v1), v1);
217 VERIFY_IS_APPROX(mcq1 * (mcq1.conjugate() * v1), v1);
220 VERIFY_IS_APPROX(mq3 * (mq3.conjugate() * v1), v1);
223 VERIFY_IS_APPROX(mcq3 * (mcq3.conjugate() * v1), v1);
/external/eigen/test/eigen2/
H A Deigen2_adjoint.cpp43 // check basic compatibility of adjoint, transpose, conjugate
44 VERIFY_IS_APPROX(m1.transpose().conjugate().adjoint(), m1);
45 VERIFY_IS_APPROX(m1.adjoint().conjugate().transpose(), m1);
69 VERIFY_IS_APPROX(m1.conjugate()(r,c), ei_conj(m1(r,c)));
H A Deigen2_sparse_product.cpp85 refLo = refUp.transpose().conjugate();
86 mLo = mUp.transpose().conjugate();
96 VERIFY_IS_APPROX(mS.transpose().conjugate(), mS);
/external/eigen/Eigen/src/Geometry/
H A DOrthoMethods.h111 res.row(0) = (_expression().row(1) * other.coeff(2) - _expression().row(2) * other.coeff(1)).conjugate();
112 res.row(1) = (_expression().row(2) * other.coeff(0) - _expression().row(0) * other.coeff(2)).conjugate();
113 res.row(2) = (_expression().row(0) * other.coeff(1) - _expression().row(1) * other.coeff(0)).conjugate();
118 res.col(0) = (_expression().col(1) * other.coeff(2) - _expression().col(2) * other.coeff(1)).conjugate();
119 res.col(1) = (_expression().col(2) * other.coeff(0) - _expression().col(0) * other.coeff(2)).conjugate();
120 res.col(2) = (_expression().col(0) * other.coeff(1) - _expression().col(1) * other.coeff(0)).conjugate();
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrix_MKL.h94 a_tmp = lhs.conjugate(); \
101 b_tmp = rhs.conjugate(); \
H A DTriangularSolverMatrix_MKL.h76 a_tmp = tri.conjugate(); \
131 a_tmp = tri.conjugate(); \
H A DSelfadjointMatrixMatrix_MKL.h133 a_tmp = lhs.conjugate(); \
144 b_tmp = rhs.conjugate(); \
258 a_tmp = rhs.conjugate(); \
269 b_tmp = lhs.conjugate(); \
H A DTriangularMatrixVector_MKL.h102 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \
133 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \
187 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \
218 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \
H A DSelfadjointMatrixVector_MKL.h97 x_tmp=map_x.conjugate(); \
/external/eigen/Eigen/src/Eigenvalues/
H A DHessenbergDecomposition.h235 return HouseholderSequenceType(m_matrix, m_hCoeffs.conjugate())
316 .applyHouseholderOnTheRight(matA.col(i).tail(remainingSize-1).conjugate(), numext::conj(h), &temp.coeffRef(0));
/external/eigen/Eigen/src/SVD/
H A DUpperBidiagonalization.h71 return HouseholderUSequenceType(m_householder, m_householder.diagonal().conjugate());
77 return HouseholderVSequenceType(m_householder.conjugate(), m_householder.const_derived().template diagonal<1>())
/external/eigen/Eigen/src/Eigen2Support/
H A DLeastSquares.h153 VectorType diff = (*(points[i]) - mean).conjugate();
/external/eigen/Eigen/src/Cholesky/
H A DLLT_MKL.h89 return llt_inplace<EIGTYPE, Lower>::rankUpdate(matt, vec.conjugate(), sigma); \

Completed in 3516 milliseconds

123