/external/tensorflow/tensorflow/core/kernels/ |
D | transpose_functor_cpu.cc | 34 template <typename T, bool conjugate> 52 if (conjugate) { in TransposeSimple() 60 (conjugate ? 1 : 0) + ndims * (Eigen::TensorOpCost::DivCost<int64>() + in TransposeSimple() 70 template <typename T, bool conjugate> 71 struct Transpose<CPUDevice, T, conjugate> { 76 internal::TransposeUsingEigen<CPUDevice, T, 2>(d, in, perm, conjugate, in run() 80 internal::TransposeUsingEigen<CPUDevice, T, 3>(d, in, perm, conjugate, in run() 84 internal::TransposeUsingEigen<CPUDevice, T, 4>(d, in, perm, conjugate, in run() 88 internal::TransposeUsingEigen<CPUDevice, T, 5>(d, in, perm, conjugate, in run() 92 internal::TransposeUsingEigen<CPUDevice, T, 6>(d, in, perm, conjugate, in run() [all …]
|
D | transpose_functor_gpu.cu.cc | 34 template <typename T, bool conjugate> 48 if (conjugate) { in TransposeKernel() 56 template <typename T, bool conjugate> 84 TransposeKernel<T, conjugate>, cfg.block_count, cfg.thread_per_block, 0, in TransposeSimple() 95 template <typename T, bool conjugate = false> 116 conjugate>()( in run() 124 conjugate>()( in run() 129 conjugate>()( in run() 144 template <bool conjugate> 145 struct TransposeUsingTile<complex64, conjugate> { [all …]
|
D | transpose_functor.h | 61 template <typename Device, typename T, bool conjugate = false> 148 const gtl::ArraySlice<int32> perm, bool conjugate, in TransposeUsingEigen() argument 158 if (conjugate) { in TransposeUsingEigen() 159 y.device(d) = x.conjugate().shuffle(p); in TransposeUsingEigen() 167 const gtl::ArraySlice<int32> perm, bool conjugate, in DoTransposeImpl() argument 203 if (conjugate) { in DoTransposeImpl() 218 if (conjugate) { in DoTransposeImpl() 239 bool conjugate, Tensor* out) { in DoMatrixTransposeImpl() argument 245 return DoTransposeImpl(device, in, perm, conjugate, out); in DoMatrixTransposeImpl() 252 const gtl::ArraySlice<int32> perm, bool conjugate,
|
D | conv_2d_gpu.h | 41 template <typename T, bool conjugate> 44 if (conjugate) { in run() 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/test/ |
D | product_trmv.cpp | 44 …VERIFY(((s1*m3).conjugate() * v1).isApprox((s1*m1).conjugate().template triangularView<Eigen::Lowe… in trmv() 46 …VERIFY((m3.conjugate() * v1.conjugate()).isApprox(m1.conjugate().template triangularView<Eigen::Up… in trmv() 62 …ERIFY((m3.adjoint() * (s1*v1.conjugate())).isApprox(m1.adjoint().template triangularView<Eigen::Up… in trmv()
|
D | product_trsolve.cpp | 46 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Lower>(), cmRhs); in trsolve() 50 VERIFY_TRSM(cmLhs.conjugate().template triangularView<Upper>(), rmRhs); in trsolve() 53 VERIFY_TRSM(cmLhs.conjugate().template triangularView<UnitLower>(), cmRhs); in trsolve() 57 VERIFY_TRSM(rmLhs.conjugate().template triangularView<UnitUpper>(), rmRhs); in trsolve() 60 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<Lower>(), cmRhs); in trsolve() 63 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<Upper>(), rmRhs); in trsolve() 65 VERIFY_TRSM_ONTHERIGHT(cmLhs.conjugate().template triangularView<UnitLower>(), cmRhs); in trsolve() 69 VERIFY_TRSM_ONTHERIGHT(rmLhs.conjugate().template triangularView<UnitUpper>(), rmRhs); in trsolve()
|
D | product_extra.cpp | 51 …VERIFY_IS_APPROX( m1.adjoint() * (s1*m2).conjugate(), (m1.adjoint()).eval() * ((s1*m2).conjugate()… in product_extra() 56 VERIFY_IS_APPROX((-m1.conjugate() * s2) * (s1 * vc2), in product_extra() 57 (-m1.conjugate()*s2).eval() * (s1 * vc2).eval()); in product_extra() 58 VERIFY_IS_APPROX((-m1 * s2) * (s1 * vc2.conjugate()), in product_extra() 59 (-m1*s2).eval() * (s1 * vc2.conjugate()).eval()); in product_extra() 60 VERIFY_IS_APPROX((-m1.conjugate() * s2) * (s1 * vc2.conjugate()), in product_extra() 61 (-m1.conjugate()*s2).eval() * (s1 * vc2.conjugate()).eval()); in product_extra() 77 VERIFY_IS_APPROX((s1 * v1) * (-m1.conjugate() * s2), in product_extra() 78 (s1 * v1).eval() * (-m1.conjugate()*s2).eval()); in product_extra() 79 VERIFY_IS_APPROX((s1 * v1.conjugate()) * (-m1 * s2), in product_extra() [all …]
|
D | product_symm.cpp | 48 VERIFY_IS_APPROX(rhs12 = (s1*m2).conjugate().template selfadjointView<Lower>() * (s2*rhs1), in symm() 49 rhs13 = (s1*m1).conjugate() * (s2*rhs1)); in symm() 51 VERIFY_IS_APPROX(rhs12 = (s1*m2).template selfadjointView<Lower>().conjugate() * (s2*rhs1), in symm() 52 rhs13 = (s1*m1).conjugate() * (s2*rhs1)); in symm() 84 …RIFY_IS_APPROX(rhs12 = (s1*m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate(), in symm() 85 rhs13 = (s1*m1.adjoint()) * (s2*rhs3).conjugate()); in symm() 89 …rhs12.noalias() += s1 * ((m2.adjoint()).template selfadjointView<Lower>() * (s2*rhs3).conjugate()), in symm() 90 rhs13 += (s1*m1.adjoint()) * (s2*rhs3).conjugate()); in symm()
|
D | product_trmm.cpp | 54 …)).template triangularView<Mode>() * (s2*ge_left.transpose()), s1*triTr.conjugate() * (s2*ge_left.… in trmm() 55 …spose() * mat.adjoint().template triangularView<Mode>(), ge_right.transpose() * triTr.conjugate()); in trmm() 57 …t()).template triangularView<Mode>() * (s2*ge_left.adjoint()), s1*triTr.conjugate() * (s2*ge_left.… in trmm() 58 …adjoint() * mat.adjoint().template triangularView<Mode>(), ge_right.adjoint() * triTr.conjugate()); in trmm() 61 …VERIFY_IS_APPROX( (ge_xs_save + s1*triTr.conjugate() * (s2*ge_left.adjoint())).eval(), ge_xs.noali… in trmm() 64 …VERIFY_IS_APPROX( ge_sx_save - (ge_right.adjoint() * (-s1 * triTr).conjugate()).eval(), ge_sx.noal… in trmm() 66 …te triangularView<Mode>() * ge_left.adjoint(), numext::conj(s1) * triTr.conjugate() * ge_left.adjo… in trmm()
|
D | product_syrk.cpp | 94 …VERIFY_IS_APPROX((m2.template selfadjointView<Lower>().rankUpdate(m1.col(c).conjugate(),s1)._expre… in syrk() 95 …((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Low… in syrk() 98 …VERIFY_IS_APPROX((m2.template selfadjointView<Upper>().rankUpdate(m1.col(c).conjugate(),s1)._expre… in syrk() 99 …((s1 * m1.col(c).conjugate() * m1.col(c).conjugate().adjoint()).eval().template triangularView<Upp… in syrk()
|
D | sparse_solvers.cpp | 60 VERIFY_IS_APPROX(refMat2.conjugate().template triangularView<Upper>().solve(vec2), in sparse_solvers() 61 m2.conjugate().template triangularView<Upper>().solve(vec3)); in sparse_solvers() 66 VERIFY_IS_APPROX(refMat2.conjugate().template triangularView<Upper>().solve(vec2), in sparse_solvers() 67 mm2.conjugate().template triangularView<Upper>().solve(vec3)); in sparse_solvers()
|
D | householder.cpp | 87 HCoeffsVectorType hc = qr.hCoeffs().conjugate(); in householder() 100 SquareMatrixType hseq_mat_conj = hseq.conjugate(); in householder() 105 VERIFY_IS_APPROX(hseq_mat.conjugate(), hseq_mat_conj); in householder() 109 VERIFY_IS_APPROX(hseq_mat.conjugate() * m6, hseq_mat_conj * m6); in householder() 113 VERIFY_IS_APPROX(m6 * hseq_mat.conjugate(), m6 * hseq_mat_conj); in householder()
|
D | triangular.cpp | 63 VERIFY_IS_APPROX(m3.template triangularView<Lower>().conjugate().toDenseMatrix(), in triangular_square() 64 m3.conjugate().template triangularView<Lower>().toDenseMatrix()); in triangular_square() 79 …VERIFY(v2.isApprox(m3.conjugate() * (m1.conjugate().template triangularView<Lower>().solve(v2)), l… in triangular_square() 89 …VERIFY(m2.isApprox(m3.conjugate() * (m1.conjugate().template triangularView<Lower>().solve(m2)), l… in triangular_square()
|
D | cholesky.cpp | 123 …VERIFY_IS_APPROX(MatrixType(chollo.matrixL().transpose().conjugate()), MatrixType(chollo.matrixU()… in cholesky() 124 …VERIFY_IS_APPROX(MatrixType(chollo.matrixU().transpose().conjugate()), MatrixType(chollo.matrixL()… in cholesky() 125 …VERIFY_IS_APPROX(MatrixType(cholup.matrixL().transpose().conjugate()), MatrixType(cholup.matrixU()… in cholesky() 126 …VERIFY_IS_APPROX(MatrixType(cholup.matrixU().transpose().conjugate()), MatrixType(cholup.matrixL()… in cholesky() 189 …VERIFY_IS_APPROX(MatrixType(ldltlo.matrixL().transpose().conjugate()), MatrixType(ldltlo.matrixU()… in cholesky() 190 …VERIFY_IS_APPROX(MatrixType(ldltlo.matrixU().transpose().conjugate()), MatrixType(ldltlo.matrixL()… in cholesky() 191 …VERIFY_IS_APPROX(MatrixType(ldltup.matrixL().transpose().conjugate()), MatrixType(ldltup.matrixU()… in cholesky() 192 …VERIFY_IS_APPROX(MatrixType(ldltup.matrixU().transpose().conjugate()), MatrixType(ldltup.matrixL()… in cholesky()
|
D | adjoint.cpp | 96 VERIFY_IS_APPROX(m1.transpose().conjugate().adjoint(), m1); in adjoint() 97 VERIFY_IS_APPROX(m1.adjoint().conjugate().transpose(), m1); in adjoint() 114 VERIFY_IS_APPROX(m1.conjugate()(r,c), numext::conj(m1(r,c))); in adjoint() 140 VERIFY_IS_APPROX(m3,m1.conjugate()); in adjoint() 178 VERIFY_RAISES_ASSERT(a = a.conjugate().transpose()); in test_adjoint()
|
D | geo_quaternion.cpp | 147 VERIFY_IS_APPROX(q1 * (q1.conjugate() * v1), v1); in quaternion() 219 VERIFY_IS_APPROX(mq1 * (mq1.conjugate() * v1), v1); in mapQuaternion() 222 VERIFY_IS_APPROX(mcq1 * (mcq1.conjugate() * v1), v1); in mapQuaternion() 225 VERIFY_IS_APPROX(mq3 * (mq3.conjugate() * v1), v1); in mapQuaternion() 228 VERIFY_IS_APPROX(mcq3 * (mcq3.conjugate() * v1), v1); in mapQuaternion()
|
/external/python/cpython3/Lib/test/ |
D | 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())
|
/external/tensorflow/tensorflow/core/api_def/base_api/ |
D | api_def_Conj.pbtxt | 3 summary: "Returns the complex conjugate of a complex number." 6 complex numbers that are the complex conjugate of each element in `input`. The 10 The complex conjugate returned by this operation is of the form \\(a - bj\\).
|
/external/tensorflow/tensorflow/python/kernel_tests/ |
D | transpose_op_test.py | 41 def _compareCpu(self, x, p, conjugate=False): argument 48 if conjugate: 52 y = array_ops.transpose(inx, p, conjugate=conjugate) 72 def _compareGpu(self, x, p, conjugate=False): argument 79 if conjugate: 83 y = array_ops.transpose(inx, p, conjugate=conjugate) 112 self._compareCpu(x, p, conjugate=c) 114 self._compareGpu(x, p, conjugate=c) 117 self._compareCpu(x, None, conjugate=c) 119 self._compareGpu(x, None, conjugate=c)
|
/external/eigen/Eigen/src/Geometry/ |
D | OrthoMethods.h | 123 res.row(0) = (mat.row(1) * vec.coeff(2) - mat.row(2) * vec.coeff(1)).conjugate(); in cross() 124 res.row(1) = (mat.row(2) * vec.coeff(0) - mat.row(0) * vec.coeff(2)).conjugate(); in cross() 125 res.row(2) = (mat.row(0) * vec.coeff(1) - mat.row(1) * vec.coeff(0)).conjugate(); in cross() 130 res.col(0) = (mat.col(1) * vec.coeff(2) - mat.col(2) * vec.coeff(1)).conjugate(); in cross() 131 res.col(1) = (mat.col(2) * vec.coeff(0) - mat.col(0) * vec.coeff(2)).conjugate(); in cross() 132 res.col(2) = (mat.col(0) * vec.coeff(1) - mat.col(1) * vec.coeff(0)).conjugate(); in cross()
|
/external/python/cpython2/Lib/test/ |
D | 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/plugins/ |
D | CommonCwiseUnaryOps.h | 69 EIGEN_DOC_UNARY_ADDONS(conjugate,complex conjugate) in EIGEN_DOC_UNARY_ADDONS() argument 74 conjugate() const in EIGEN_DOC_UNARY_ADDONS()
|
/external/eigen/unsupported/test/ |
D | cxx11_tensor_of_complex.cpp | 60 Tensor<std::complex<float>, 1> conj1 = data1.conjugate(); in test_conjugate() 61 Tensor<std::complex<double>, 1> conj2 = data2.conjugate(); in test_conjugate() 62 Tensor<int, 1> conj3 = data3.conjugate(); in test_conjugate()
|
/external/eigen/Eigen/src/Core/products/ |
D | TriangularMatrixVector_BLAS.h | 102 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \ 130 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \ 184 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \ 212 if (ConjRhs) x_tmp = rhs.conjugate(); else x_tmp = rhs; \
|
D | GeneralMatrixMatrix_BLAS.h | 91 a_tmp = lhs.conjugate(); \ 98 b_tmp = rhs.conjugate(); \
|