/external/libcxx/test/numerics/complex.number/cmplx.over/ |
D | conj.pass.cpp | 28 static_assert((std::is_same<decltype(std::conj(x)), std::complex<double> >::value), ""); in test() 29 assert(std::conj(x) == conj(std::complex<double>(x, 0))); in test() 36 static_assert((std::is_same<decltype(std::conj(x)), std::complex<T> >::value), ""); in test() 37 assert(std::conj(x) == conj(std::complex<T>(x, 0))); in test() 45 static_assert((std::is_same<decltype(std::conj(x)), std::complex<T> >::value), ""); in test() 46 assert(std::conj(x) == conj(std::complex<T>(x, 0))); in test()
|
D | Android.mk | 19 test_name := numerics/complex.number/cmplx.over/conj 20 test_src := conj.pass.cpp
|
/external/eigen/Eigen/src/Geometry/ |
D | OrthoMethods.h | 36 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), in cross() 37 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), in cross() 38 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)) in cross() 52 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), in run() 53 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), in run() 54 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)), in run() 144 perp.coeffRef(maxi) = -numext::conj(src.coeff(sndi)) * invnm; in run() 145 perp.coeffRef(sndi) = numext::conj(src.coeff(maxi)) * invnm; in run() 171 perp.coeffRef(0) = -numext::conj(src.y())*invnm; 172 perp.coeffRef(1) = numext::conj(src.x())*invnm; [all …]
|
/external/eigen/Eigen/src/Core/products/ |
D | SelfadjointRank2Update.h | 33 (numext::conj(alpha) * numext::conj(u.coeff(i))) * v.tail(size-i) 34 + (alpha * numext::conj(v.coeff(i))) * u.tail(size-i); 47 (numext::conj(alpha) * numext::conj(u.coeff(i))) * v.head(i+1) 48 + (alpha * numext::conj(v.coeff(i))) * u.head(i+1); 78 * numext::conj(VBlasTraits::extractScalarFactor(v.derived())); 80 actualAlpha = numext::conj(actualAlpha);
|
D | SelfadjointMatrixMatrix.h | 33 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed in pack() 44 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed in pack() 71 blockA[count++] = numext::conj(lhs(k, i)); // transposed in operator() 110 blockB[count+0] = numext::conj(rhs(j2+0,k)); in operator() 111 blockB[count+1] = numext::conj(rhs(j2+1,k)); in operator() 114 blockB[count+2] = numext::conj(rhs(j2+2,k)); in operator() 115 blockB[count+3] = numext::conj(rhs(j2+3,k)); in operator() 131 blockB[count+w] = numext::conj(rhs(j2+w,k)); in operator() 154 blockB[count+0] = numext::conj(rhs(j2+0,k)); in operator() 155 blockB[count+1] = numext::conj(rhs(j2+1,k)); in operator() [all …]
|
D | TriangularSolverMatrix.h | 75 conj_if<Conjugate> conj; 121 Scalar a = (Mode & UnitDiag) ? Scalar(1) : Scalar(1)/conj(tri(i,i)); 130 b += conj(l[i3]) * r[i3]; 141 r[i3] -= b * conj(l[i3]); 224 conj_if<Conjugate> conj; 300 Scalar b = conj(rhs(IsLower ? j+1+k3 : absolute_j2+k3,j)); 305 Scalar b = (Mode & UnitDiag) ? Scalar(1) : Scalar(1)/conj(rhs(j,j));
|
D | SelfadjointMatrixVector.h | 62 Scalar cjAlpha = ConjugateRhs ? numext::conj(alpha) : alpha; in run() 117 t2 += numext::conj(A0[i]) * rhs[i]; in run() 118 t3 += numext::conj(A1[i]) * rhs[i]; in run()
|
/external/eigen/Eigen/src/Jacobi/ |
D | Jacobi.h | 53 using numext::conj; 54 return JacobiRotation(m_c * other.m_c - conj(m_s) * other.m_s, 55 conj(m_c * conj(other.m_s) + conj(m_s) * conj(other.m_c))); 59 JacobiRotation transpose() const { using numext::conj; return JacobiRotation(m_c, -conj(m_s)); } in transpose() 62 JacobiRotation adjoint() const { using numext::conj; return JacobiRotation(conj(m_c), -m_s); } in adjoint() 109 m_s = - sign_t * (numext::conj(y) / abs(y)) * abs(t) * n; in makeJacobi() 160 using numext::conj; in makeGivens() 190 m_s = -qs*conj(ps)*(m_c/p2); in makeGivens() 207 m_s = -conj(ps) * (q/u); in makeGivens() 340 x[i] = c * xi + numext::conj(s) * yi; in apply_rotation_in_the_plane() [all …]
|
/external/eigen/blas/ |
D | Rank2Update.h | 27 …numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i … in run() 28 … + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)); in run() 46 …numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i … in run() 47 … + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)); in run()
|
/external/eigen/test/ |
D | adjoint.cpp | 19 …_isApproxWithRef((s1 * v1 + s2 * v2).dot(v3), numext::conj(s1) * v1.dot(v3) + numext::conj(s2)… in run() 34 …_isApproxWithRef((s1 * v1 + s2 * v2).dot(v3), numext::conj(s1) * v1.dot(v3) + numext::conj(s2)… in run() 89 VERIFY_IS_APPROX((s1 * m1).adjoint(), numext::conj(s1) * m1.adjoint()); in adjoint() 92 VERIFY_IS_APPROX(numext::conj(v1.dot(v2)), v2.dot(v1)); in adjoint() 102 VERIFY_IS_APPROX(m1.conjugate()(r,c), numext::conj(m1(r,c))); in adjoint() 103 VERIFY_IS_APPROX(m1.adjoint()(c,r), numext::conj(m1(r,c))); in adjoint()
|
D | jacobi.cpp | 43 VERIFY_IS_APPROX(b.row(p), c * a.row(p) + numext::conj(s) * a.row(q)); in jacobi() 44 VERIFY_IS_APPROX(b.row(q), -s * a.row(p) + numext::conj(c) * a.row(q)); in jacobi() 57 VERIFY_IS_APPROX(b.col(q), numext::conj(s) * a.col(p) + numext::conj(c) * a.col(q)); in jacobi()
|
D | product_selfadjoint.cpp | 47 …VERIFY_IS_APPROX(m2, (m1 + (s3*(-v1)*(s2*v2).adjoint()+numext::conj(s3)*(s2*v2)*(-v1).adjoint())).… in product_selfadjoint() 51 …VERIFY_IS_APPROX(m2, (m1 + s1*(-s2*r1.adjoint())*(r2.adjoint()*s3).adjoint() + numext::conj(s1)*(r… in product_selfadjoint()
|
D | determinant.cpp | 42 VERIFY_IS_APPROX(numext::conj(m2.determinant()), m2.adjoint().determinant()); in determinant()
|
D | exceptions.cpp | 74 ScalarWithExceptions conj(const ScalarWithExceptions &x) { return x; } in conj() function
|
/external/eigen/Eigen/src/SparseCholesky/ |
D | SimplicialCholesky_impl.h | 134 y[i] += numext::conj(it.value()); /* scatter A(i,k) into Y (sum duplicates) */ in factorize_preordered() 166 y[Li[p]] -= numext::conj(Lx[p]) * yi; in factorize_preordered() 167 d -= numext::real(l_ki * numext::conj(yi)); in factorize_preordered()
|
/external/libcxx/test/numerics/complex.number/complex.value.ops/ |
D | Android.mk | 23 test_name := numerics/complex.number/complex.value.ops/conj 24 test_src := conj.pass.cpp
|
D | conj.pass.cpp | 23 assert(conj(z) == x); in test()
|
/external/eigen/unsupported/Eigen/src/FFT/ |
D | ei_kissfft_impl.h | 324 Complex fpnk = conj(dst[ncfft-k]); in fwd() 329 dst[ncfft-k] = conj(f1k -tw)*Scalar(.5); in fwd() 352 m_tmpBuf1[nfft-k] = conj(m_tmpBuf1[k]); in inv() 365 Complex fnkc = conj(src[ncfft-k]); in inv() 368 Complex fok = tmp * conj(rtw[k-1]); in inv() 370 m_tmpBuf1[ncfft-k] = conj(fek - fok); in inv()
|
/external/eigen/Eigen/src/Core/ |
D | SelfAdjointView.h | 219 dst.coeffRef(col, row) = numext::conj(dst.coeffRef(row, col) = src.coeff(row, col)); 244 dst.coeffRef(col, row) = numext::conj(dst.coeffRef(row, col) = src.coeff(row, col)); 265 dst.coeffRef(j,i) = numext::conj(dst.coeff(i,j)); 283 dst.coeffRef(j,i) = numext::conj(dst.coeff(i,j));
|
D | MathFunctions.h | 206 using std::conj; 207 return conj(x); 593 inline EIGEN_MATHFUNC_RETVAL(conj, Scalar) conj(const Scalar& x) 595 return EIGEN_MATHFUNC_IMPL(conj, Scalar)::run(x);
|
/external/eigen/Eigen/src/SparseCore/ |
D | SparseDot.h | 33 res += numext::conj(i.value()) * other.coeff(i.index()); in dot() 67 res += numext::conj(i.value()) * j.value(); in dot()
|
/external/eigen/Eigen/src/Householder/ |
D | Householder.h | 71 using numext::conj; in makeHouseholder() 91 tau = conj((beta - c0) / beta); in makeHouseholder()
|
/external/clang/test/CodeGen/ |
D | complex-builtints.c | 8 extern double _Complex conj (double _Complex);
|
/external/eigen/Eigen/src/Eigenvalues/ |
D | Tridiagonalization.h | 348 using numext::conj; 368 * (conj(h) * matA.col(i).tail(remainingSize))); 370 …hCoeffs.tail(n-i-1) += (conj(h)*Scalar(-0.5)*(hCoeffs.tail(remainingSize).dot(matA.col(i).tail(rem…
|
/external/eigen/Eigen/src/Cholesky/ |
D | LDLT.h | 296 mat.coeffRef(i,k) = numext::conj(mat.coeffRef(index_of_biggest_in_corner,i)); 297 mat.coeffRef(index_of_biggest_in_corner,i) = numext::conj(tmp); 300 …mat.coeffRef(index_of_biggest_in_corner,k) = numext::conj(mat.coeff(index_of_biggest_in_corner,k)); 382 mat.col(j).tail(rs) += (sigma*numext::conj(wj)/gamma)*w.tail(rs);
|