Home
last modified time | relevance | path

Searched refs:conj (Results 1 – 25 of 72) sorted by relevance

123

/external/libcxx/test/std/numerics/complex.number/cmplx.over/
Dconj.pass.cpp28 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()
DUDT_is_rejected.fail.cpp61 std::conj(ft); // expected-error {{no matching function}} in main()
62 std::conj(dt); // expected-error {{no matching function}} in main()
63 std::conj(ldt); // expected-error {{no matching function}} in main()
64 std::conj(it); // expected-error {{no matching function}} in main()
65 std::conj(uit); // expected-error {{no matching function}} in main()
/external/eigen/Eigen/src/Geometry/
DOrthoMethods.h44 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), in cross()
45 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), in cross()
46 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)) in cross()
60 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), in run()
61 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), in run()
62 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)), in run()
156 perp.coeffRef(maxi) = -numext::conj(src.coeff(sndi)) * invnm; in run()
157 perp.coeffRef(sndi) = numext::conj(src.coeff(maxi)) * invnm; in run()
184 perp.coeffRef(0) = -numext::conj(src.y())*invnm;
185 perp.coeffRef(1) = numext::conj(src.x())*invnm;
[all …]
/external/eigen/Eigen/src/Core/products/
DSelfadjointMatrixMatrix.h33 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed in pack()
44 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed in pack()
78 blockA[count++] = numext::conj(lhs(k, i)); // transposed in operator()
128 blockB[count+0] = numext::conj(rhs(j2+0,k)); in operator()
129 blockB[count+1] = numext::conj(rhs(j2+1,k)); in operator()
130 blockB[count+2] = numext::conj(rhs(j2+2,k)); in operator()
131 blockB[count+3] = numext::conj(rhs(j2+3,k)); in operator()
132 blockB[count+4] = numext::conj(rhs(j2+4,k)); in operator()
133 blockB[count+5] = numext::conj(rhs(j2+5,k)); in operator()
134 blockB[count+6] = numext::conj(rhs(j2+6,k)); in operator()
[all …]
DSelfadjointRank2Update.h33 (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);
DTriangularSolverMatrix.h77 conj_if<Conjugate> conj;
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;
303 Scalar b = conj(rhs(IsLower ? j+1+k3 : absolute_j2+k3,j));
310 Scalar inv_rjj = RealScalar(1)/conj(rhs(j,j));
/external/eigen/Eigen/src/Jacobi/
DJacobi.h53 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()
110 m_s = - sign_t * (numext::conj(y) / abs(y)) * abs(t) * n; in makeJacobi()
161 using numext::conj; in makeGivens()
191 m_s = -qs*conj(ps)*(m_c/p2); in makeGivens()
208 m_s = -conj(ps) * (q/u); in makeGivens()
346 x[i] = c * xi + numext::conj(s) * yi; in apply_rotation_in_the_plane()
[all …]
/external/eigen/blas/
DRank2Update.h27 …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/webrtc/webrtc/modules/audio_processing/intelligibility/
Dintelligibility_utils.cc121 (old_sum + std::conj(sample - old_mean) * (sample - running_mean_[i])) in InfiniteStep()
141 running_mean_sq_[i] = sample * std::conj(sample); in DecayStep()
148 decay_ * prev2 + (1.0f - decay_) * sample * std::conj(sample); in DecayStep()
150 running_mean_[i] * std::conj(running_mean_[i])).real(); in DecayStep()
179 (old_sum + std::conj(sample - old_mean) * (sample - mean)).real(); in WindowedStep()
197 AddToMean(data[i] * std::conj(data[i]), count_ + 1, in BlockedStep()
205 std::conj(NewMean(running_mean_[i], sub_running_mean_[i], blocks))) in BlockedStep()
233 sub_running_mean_sq_[i] += data[i] * std::conj(data[i]); in BlockBasedMovingAverage()
259 std::conj(running_mean_[i]) * scale); in BlockBasedMovingAverage()
/external/eigen/test/
Dadjoint.cpp19 …_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()
101 VERIFY_IS_APPROX((s1 * m1).adjoint(), numext::conj(s1) * m1.adjoint()); in adjoint()
104 VERIFY_IS_APPROX(numext::conj(v1.dot(v2)), v2.dot(v1)); in adjoint()
114 VERIFY_IS_APPROX(m1.conjugate()(r,c), numext::conj(m1(r,c))); in adjoint()
115 VERIFY_IS_APPROX(m1.adjoint()(c,r), numext::conj(m1(r,c))); in adjoint()
Djacobi.cpp43 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()
Dproduct_selfadjoint.cpp47 …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()
/external/eigen/Eigen/src/SparseCholesky/
DSimplicialCholesky_impl.h134 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/eigen/unsupported/Eigen/src/FFT/
Dei_kissfft_impl.h324 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/webrtc/webrtc/modules/audio_processing/beamformer/
Dcomplex_matrix.h41 data[i] = conj(data[i]); in PointwiseConjugate()
87 elements[i][j] = conj(src[j][i]); in ConjugateTranspose()
/external/eigen/Eigen/src/SparseCore/
DSparseDot.h34 res += numext::conj(i.value()) * other.coeff(i.index()); in dot()
64 res += numext::conj(i.value()) * j.value(); in dot()
/external/eigen/unsupported/test/
Dcxx11_tensor_of_complex.cpp64 VERIFY_IS_APPROX(conj1(i), std::conj(data1(i))); in test_conjugate()
65 VERIFY_IS_APPROX(conj2(i), std::conj(data2(i))); in test_conjugate()
/external/eigen/Eigen/src/Householder/
DHouseholder.h71 using numext::conj; in makeHouseholder()
92 tau = conj((beta - c0) / beta); in makeHouseholder()
/external/libcxx/test/std/numerics/complex.number/complex.value.ops/
Dconj.pass.cpp23 assert(conj(z) == x); in test()
/external/eigen/Eigen/src/Eigenvalues/
DTridiagonalization.h349 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…
/external/clang/test/CodeGen/
Dcomplex-builtints.c8 extern double _Complex conj (double _Complex);
/external/eigen/Eigen/src/Cholesky/
DLDLT.h333 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);
/external/webrtc/webrtc/common_audio/
Dreal_fourier_ooura.cc27 [=](complex<float>& v) { v = std::conj(v); }); in Conjugate()
/external/eigen/Eigen/src/SVD/
DUpperBidiagonalization.h212 y_k *= numext::conj(tau_v); in upperbidiagonalization_blocked_helper()
244 x_k *= numext::conj(tau_u); in upperbidiagonalization_blocked_helper()
245 tau_u = numext::conj(tau_u); in upperbidiagonalization_blocked_helper()
/external/eigen/doc/
DCustomizingEigen_CustomScalar.dox12 …ense for your type. This includes standard ones like sqrt, pow, sin, tan, conj, real, imag, etc, a…
51 inline const adouble& conj(const adouble& x) { return x; }

123