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

1 2 3 4

  /external/tensorflow/tensorflow/core/kernels/
transpose_functor_cpu.cc 34 template <typename T, bool conjugate>
52 if (conjugate) {
60 (conjugate ? 1 : 0) + ndims * (Eigen::TensorOpCost::DivCost<int64>() +
70 template <typename T, bool conjugate>
71 struct Transpose<CPUDevice, T, conjugate> {
76 internal::TransposeUsingEigen<CPUDevice, T, 2>(d, in, perm, conjugate,
80 internal::TransposeUsingEigen<CPUDevice, T, 3>(d, in, perm, conjugate,
84 internal::TransposeUsingEigen<CPUDevice, T, 4>(d, in, perm, conjugate,
88 internal::TransposeUsingEigen<CPUDevice, T, 5>(d, in, perm, conjugate,
92 internal::TransposeUsingEigen<CPUDevice, T, 6>(d, in, perm, conjugate,
    [all...]
transpose_functor_gpu.cu.cc 34 template <typename T, bool conjugate>
48 if (conjugate) {
56 template <typename T, bool conjugate>
84 TransposeKernel<T, conjugate>, cfg.block_count, cfg.thread_per_block, 0,
95 template <typename T, bool conjugate = false>
116 conjugate>()(
124 conjugate>()(
129 conjugate>()(
144 template <bool conjugate>
145 struct TransposeUsingTile<complex64, conjugate> {
    [all...]
transpose_functor.h 38 // Conjugate and transpose tensor 'in' into tensor 'out' according to dimension
61 template <typename Device, typename T, bool conjugate = false>
148 const gtl::ArraySlice<int32> perm, bool conjugate,
158 if (conjugate) {
159 y.device(d) = x.conjugate().shuffle(p);
167 const gtl::ArraySlice<int32> perm, bool conjugate,
203 if (conjugate) {
207 "Conjugate transpose of complex64 not supported for GCC on "
210 Transpose<Device, complex64, /*conjugate=*/true>::run(d, in, perm, out);
218 if (conjugate) {
    [all...]
conv_2d_gpu.h 41 template <typename T, bool conjugate>
44 if (conjugate) {
53 template <bool conjugate>
54 struct maybe_conj<float2, conjugate> {
56 if (conjugate) {
67 template <bool conjugate>
68 struct maybe_conj<double2, conjugate> {
70 if (conjugate) {
182 template <typename T, int sp0, int sp1, int sp2, bool conjugate = false>
205 maybe_conj<T, conjugate>::run(ldg(input + input_index))
    [all...]
  /external/eigen/doc/snippets/
tut_arithmetic_transpose_conjugate.cpp 7 cout << "Here is the conjugate of a\n" << a.conjugate() << endl;
  /external/python/cpython3/Lib/test/
test_abstract_numbers.py 15 self.assertEqual(7, int(7).conjugate())
16 self.assertEqual(-7, int(-7).conjugate())
26 self.assertEqual(7.3, float(7.3).conjugate())
27 self.assertEqual(-7.3, float(-7.3).conjugate())
  /device/linaro/bootloader/edk2/AppPkg/Applications/Python/Python-2.7.2/Lib/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/python/cpython2/Lib/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/test/
product_symm.cpp 48 VERIFY_IS_APPROX(rhs12 = (s1*m2).conjugate().template selfadjointView<Lower>() * (s2*rhs1),
49 rhs13 = (s1*m1).conjugate() * (s2*rhs1));
51 VERIFY_IS_APPROX(rhs12 = (s1*m2).template selfadjointView<Lower>().conjugate() * (s2*rhs1),
52 rhs13 = (s1*m1).conjugate() * (s2*rhs1));
84 VERIFY_IS_APPROX(rhs12 = (s1*m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate(),
85 rhs13 = (s1*m1.adjoint()) * (s2*rhs3).conjugate());
89 VERIFY_IS_APPROX(rhs12.noalias() += s1 * ((m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate()),
90 rhs13 += (s1*m1.adjoint()) * (s2*rhs3).conjugate());
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 54 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.transpose()), s1*triTr.conjugate() * (s2*ge_left.transpose()));
55 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.transpose() * mat.adjoint().template triangularView<Mode>(), ge_right.transpose() * triTr.conjugate());
57 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.adjoint()), s1*triTr.conjugate() * (s2*ge_left.adjoint()));
58 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.adjoint() * mat.adjoint().template triangularView<Mode>(), ge_right.adjoint() * triTr.conjugate());
61 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()) );
64 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());
66 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_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...]
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));
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 123 VERIFY_IS_APPROX(MatrixType(chollo.matrixL().transpose().conjugate()), MatrixType(chollo.matrixU()));
124 VERIFY_IS_APPROX(MatrixType(chollo.matrixU().transpose().conjugate()), MatrixType(chollo.matrixL()));
125 VERIFY_IS_APPROX(MatrixType(cholup.matrixL().transpose().conjugate()), MatrixType(cholup.matrixU()));
126 VERIFY_IS_APPROX(MatrixType(cholup.matrixU().transpose().conjugate()), MatrixType(cholup.matrixL()));
189 VERIFY_IS_APPROX(MatrixType(ldltlo.matrixL().transpose().conjugate()), MatrixType(ldltlo.matrixU()));
190 VERIFY_IS_APPROX(MatrixType(ldltlo.matrixU().transpose().conjugate()), MatrixType(ldltlo.matrixL()));
191 VERIFY_IS_APPROX(MatrixType(ldltup.matrixL().transpose().conjugate()), MatrixType(ldltup.matrixU()));
192 VERIFY_IS_APPROX(MatrixType(ldltup.matrixU().transpose().conjugate()), MatrixType(ldltup.matrixL()));
  /external/eigen/Eigen/src/plugins/
CommonCwiseUnaryOps.h 15 /** \internal the return type of conjugate() */
67 /// \returns an expression of the complex conjugate of \c *this.
69 EIGEN_DOC_UNARY_ADDONS(conjugate,complex conjugate)
74 conjugate() const function
  /external/eigen/unsupported/test/
cxx11_tensor_of_complex.cpp 60 Tensor<std::complex<float>, 1> conj1 = data1.conjugate();
61 Tensor<std::complex<double>, 1> conj2 = data2.conjugate();
62 Tensor<int, 1> conj3 = data3.conjugate();
  /external/eigen/Eigen/src/Geometry/
OrthoMethods.h 123 res.row(0) = (mat.row(1) * vec.coeff(2) - mat.row(2) * vec.coeff(1)).conjugate();
124 res.row(1) = (mat.row(2) * vec.coeff(0) - mat.row(0) * vec.coeff(2)).conjugate();
125 res.row(2) = (mat.row(0) * vec.coeff(1) - mat.row(1) * vec.coeff(0)).conjugate();
130 res.col(0) = (mat.col(1) * vec.coeff(2) - mat.col(2) * vec.coeff(1)).conjugate();
131 res.col(1) = (mat.col(2) * vec.coeff(0) - mat.col(0) * vec.coeff(2)).conjugate();
132 res.col(2) = (mat.col(0) * vec.coeff(1) - mat.col(1) * vec.coeff(0)).conjugate();
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrix_BLAS.h 91 a_tmp = lhs.conjugate(); \
98 b_tmp = rhs.conjugate(); \
TriangularSolverMatrix_BLAS.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 \
64 transa = (TriStorageOrder==RowMajor) ? ((Conjugate) ? 'C' : 'T') : 'N'; \
74 a_tmp = tri.conjugate(); \
95 template <typename Index, int Mode, bool Conjugate, int TriStorageOrder> \
96 struct triangular_solve_matrix<EIGTYPE,Index,OnTheRight,Mode,Conjugate,TriStorageOrder,ColMajor> \
102 conjA = ((TriStorageOrder==ColMajor) && Conjugate) ? 1 : 0 \
117 transa = (TriStorageOrder==RowMajor) ? ((Conjugate) ? 'C' : 'T') : 'N'; \
127 a_tmp = tri.conjugate(); \
    [all...]
  /external/tensorflow/tensorflow/compiler/xla/client/lib/
math.h 100 // Applies a complex conjugation operation if 'a' is complex and 'conjugate'
102 xla::XlaOp MaybeConjugate(xla::XlaOp x, bool conjugate);
  /external/eigen/Eigen/src/Eigenvalues/
HessenbergDecomposition.h 237 return HouseholderSequenceType(m_matrix, m_hCoeffs.conjugate())
318 .applyHouseholderOnTheRight(matA.col(i).tail(remainingSize-1).conjugate(), numext::conj(h), &temp.coeffRef(0));

Completed in 1237 milliseconds

1 2 3 4