HomeSort by relevance Sort by last modified time
    Searched refs:conjugate (Results 1 - 25 of 61) sorted by null

1 2 3

  /external/eigen/doc/snippets/
tut_arithmetic_transpose_conjugate.cpp 7 cout << "Here is the conjugate of a\n" << a.conjugate() << endl;
  /external/eigen/test/
product_extra.cpp 51 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()*s2).eval() * (s1 * vc2.conjugate()).eval())
    [all...]
product_trmv.cpp 44 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));
product_trsolve.cpp 46 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);
product_trmm.cpp 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<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());
householder.cpp 87 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);
product_syrk.cpp 94 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()));
product_symm.cpp 66 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());
sparse_solvers.cpp 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));
adjoint.cpp 59 Transpose.h Conjugate.h Dot.h
83 // 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());
triangular.cpp 63 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));
cholesky.cpp 113 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()));
  /prebuilts/python/darwin-x86/2.7.5/lib/python2.7/test/
test_abstract_numbers.py 15 self.assertEqual(7, int(7).conjugate())
25 self.assertEqual(7, long(7).conjugate())
35 self.assertEqual(7.3, float(7.3).conjugate())
  /prebuilts/python/linux-x86/2.7.5/lib/python2.7/test/
test_abstract_numbers.py 15 self.assertEqual(7, int(7).conjugate())
25 self.assertEqual(7, long(7).conjugate())
35 self.assertEqual(7.3, float(7.3).conjugate())
  /external/eigen/Eigen/src/Geometry/
OrthoMethods.h 111 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/test/eigen2/
eigen2_adjoint.cpp 15 Transpose.h Conjugate.h Dot.h
43 // 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)));
eigen2_sparse_product.cpp 85 refLo = refUp.transpose().conjugate();
86 mLo = mUp.transpose().conjugate();
96 VERIFY_IS_APPROX(mS.transpose().conjugate(), mS);
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrix_MKL.h 94 a_tmp = lhs.conjugate(); \
101 b_tmp = rhs.conjugate(); \
TriangularSolverMatrix_MKL.h 42 template <typename Index, int Mode, bool Conjugate, int TriStorageOrder> \
43 struct triangular_solve_matrix<EIGTYPE,Index,OnTheLeft,Mode,Conjugate,TriStorageOrder,ColMajor> \
49 conjA = ((TriStorageOrder==ColMajor) && Conjugate) ? 1 : 0 \
66 transa = (TriStorageOrder==RowMajor) ? ((Conjugate) ? 'C' : 'T') : 'N'; \
76 a_tmp = tri.conjugate(); \
97 template <typename Index, int Mode, bool Conjugate, int TriStorageOrder> \
98 struct triangular_solve_matrix<EIGTYPE,Index,OnTheRight,Mode,Conjugate,TriStorageOrder,ColMajor> \
104 conjA = ((TriStorageOrder==ColMajor) && Conjugate) ? 1 : 0 \
121 transa = (TriStorageOrder==RowMajor) ? ((Conjugate) ? 'C' : 'T') : 'N'; \
131 a_tmp = tri.conjugate(); \
    [all...]
SelfadjointMatrixMatrix_MKL.h 133 a_tmp = lhs.conjugate(); \
144 b_tmp = rhs.conjugate(); \
258 a_tmp = rhs.conjugate(); \
269 b_tmp = lhs.conjugate(); \
TriangularMatrixVector_MKL.h 102 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; \
  /external/eigen/Eigen/src/Eigenvalues/
HessenbergDecomposition.h 235 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/
UpperBidiagonalization.h 71 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/Cholesky/
LLT_MKL.h 89 return llt_inplace<EIGTYPE, Lower>::rankUpdate(matt, vec.conjugate(), sigma); \
  /external/eigen/Eigen/src/Eigen2Support/
LeastSquares.h 153 VectorType diff = (*(points[i]) - mean).conjugate();

Completed in 1112 milliseconds

1 2 3