/external/eigen/unsupported/test/ |
cxx11_tensor_of_complex.cpp | 64 VERIFY_IS_APPROX(conj1(i), std::conj(data1(i))); 65 VERIFY_IS_APPROX(conj2(i), std::conj(data2(i)));
|
/external/clang/test/CodeGen/ |
complex-builtints.c | 4 /* Test for builtin conj, creal, cimag. */ 8 extern double _Complex conj (double _Complex);
|
/external/tensorflow/tensorflow/core/kernels/ |
sparse_tensor_dense_matmul_op.h | 64 return Eigen::numext::conj(m_(j, i));
|
cwise_ops_gradients.h | 78 const T out_conj = numext::conj(output); 102 const T out_conj = numext::conj(output); 127 const T out_conj = numext::conj(output);
|
qr_op_impl.h | 264 functor::UnaryFunctor<GPUDevice, functor::conj<Scalar>> conj; variable 265 conj(device, q->flat<Scalar>() /*out*/,
|
/external/eigen/test/ |
product_selfadjoint.cpp | 47 VERIFY_IS_APPROX(m2, (m1 + (s3*(-v1)*(s2*v2).adjoint()+numext::conj(s3)*(s2*v2)*(-v1).adjoint())).template triangularView<Upper>().toDenseMatrix()); 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());
|
determinant.cpp | 42 VERIFY_IS_APPROX(numext::conj(m2.determinant()), m2.adjoint().determinant());
|
exceptions.cpp | 74 ScalarWithExceptions conj(const ScalarWithExceptions &x) { return x; } function
|
/external/tensorflow/tensorflow/contrib/solvers/python/ops/ |
util.py | 67 return math_ops.reduce_sum(math_ops.conj(x) * y)
|
/external/webrtc/webrtc/common_audio/ |
real_fourier_ooura.cc | 27 [=](complex<float>& v) { v = std::conj(v); });
|
/external/eigen/Eigen/src/Core/products/ |
TriangularSolverMatrix.h | 77 conj_if<Conjugate> conj; local 124 Scalar a = (Mode & UnitDiag) ? Scalar(1) : Scalar(1)/conj(tri(i,i)); 133 b += conj(l[i3]) * r[i3]; 143 r[i3] -= b * conj(l[i3]); 228 conj_if<Conjugate> conj; local 303 Scalar b = conj(rhs(IsLower ? j+1+k3 : absolute_j2+k3,j)); 310 Scalar inv_rjj = RealScalar(1)/conj(rhs(j,j));
|
GeneralMatrixMatrix_BLAS.h | 66 using std::conj; \
|
/external/eigen/unsupported/Eigen/src/FFT/ |
ei_kissfft_impl.h | 324 Complex fpnk = conj(dst[ncfft-k]); 329 dst[ncfft-k] = conj(f1k -tw)*Scalar(.5); 352 m_tmpBuf1[nfft-k] = conj(m_tmpBuf1[k]); 365 Complex fnkc = conj(src[ncfft-k]); 368 Complex fok = tmp * conj(rtw[k-1]); 370 m_tmpBuf1[ncfft-k] = conj(fek - fok);
|
/external/tensorflow/tensorflow/python/kernel_tests/ |
matrix_solve_ls_op_test.py | 66 gramian = np.dot(np.conj(matrix.T), matrix) + preconditioner 67 rhs = np.dot(np.conj(matrix.T), rhs) 71 gramian = np.dot(matrix, np.conj(matrix.T)) + preconditioner 73 return np.dot(np.conj(matrix.T), z) 102 np_r = np.dot(np.conj(a.T), b - np.dot(a, np_ans)) 103 np_r_norm = np.sqrt(np.sum(np.conj(np_r) * np_r))
|
self_adjoint_eig_op_test.py | 97 phases = np.sum(np.conj(x) * y, -2, keepdims=True) 131 a += np.conj(a.T) 176 a += np.conj(a.T) 210 x_init += np.conj(x_init.T)
|
cholesky_op_test.py | 55 grad_a += math_ops.conj(array_ops.matrix_transpose(grad_a)) 74 z_h = math_ops.conj(array_ops.matrix_transpose(l_inverse_middle)) 144 matrices[i] = np.dot(matrices[i].T.conj(), matrices[i]) 269 x, math_ops.conj(array_ops.transpose(x))) / shape[0] 281 e, math_ops.conj(array_ops.transpose(e))) / shape[0]
|
/external/eigen/Eigen/src/Eigenvalues/ |
Tridiagonalization.h | 349 using numext::conj; 368 * (conj(h) * matA.col(i).tail(remainingSize))); 370 hCoeffs.tail(n-i-1) += (conj(h)*RealScalar(-0.5)*(hCoeffs.tail(remainingSize).dot(matA.col(i).tail(remainingSize)))) * matA.col(i).tail(n-i-1);
|
/bionic/libc/include/ |
complex.h | 145 /* 7.3.9.3 The conj functions */ 146 double complex conj(double complex __z) __INTRODUCED_IN(23); 148 long double complex conjl(long double complex __z) __RENAME_LDBL(conj, 23, 23);
|
/bionic/tests/ |
complex_test.cpp | 222 TEST(COMPLEX_TEST, conj) { 223 ASSERT_EQ(0.0, conj(0));
|
/external/tensorflow/tensorflow/python/ops/linalg/ |
linear_operator_diag.py | 226 diag_term = math_ops.conj(self._diag) if adjoint else self._diag 239 diag_term = math_ops.conj(self._diag) if adjoint else self._diag
|
/external/tensorflow/tensorflow/python/ops/ |
spectral_grad.py | 120 y0_term = math_ops.matmul(tiled_mask, math_ops.conj(y0)) 124 ym_term = math_ops.matmul(tiled_mask, math_ops.conj(ym))
|
/prebuilts/gcc/linux-x86/host/x86_64-w64-mingw32-4.8/x86_64-w64-mingw32/include/ |
complex.h | 55 double _Complex __MINGW_ATTRIB_CONST conj (double _Complex); 133 __CRT_INLINE double _Complex __MINGW_ATTRIB_CONST conj (double _Complex _Z) function
|
/external/eigen/Eigen/src/SVD/ |
UpperBidiagonalization.h | 212 y_k *= numext::conj(tau_v); 244 x_k *= numext::conj(tau_u); 245 tau_u = numext::conj(tau_u);
|
/bionic/tests/headers/posix/ |
tgmath_h.c | 115 TGMATHCONLY(conj);
|
/external/eigen/Eigen/src/Cholesky/ |
LDLT.h | 333 mat.coeffRef(i,k) = numext::conj(mat.coeffRef(index_of_biggest_in_corner,i)); 334 mat.coeffRef(index_of_biggest_in_corner,i) = numext::conj(tmp); 337 mat.coeffRef(index_of_biggest_in_corner,k) = numext::conj(mat.coeff(index_of_biggest_in_corner,k)); 436 mat.col(j).tail(rs) += (sigma*numext::conj(wj)/gamma)*w.tail(rs);
|