/external/libcxx/test/numerics/complex.number/cmplx.over/ |
conj.pass.cpp | 12 // template<class T> complex<T> conj(const complex<T>&); 13 // complex<long double> conj(long double); 14 // complex<double> conj(double); 15 // template<Integral T> complex<double> conj(T); 16 // complex<float> conj(float); 28 static_assert((std::is_same<decltype(std::conj(x)), std::complex<double> >::value), ""); 29 assert(std::conj(x) == conj(std::complex<double>(x, 0))); 36 static_assert((std::is_same<decltype(std::conj(x)), std::complex<T> >::value), ""); 37 assert(std::conj(x) == conj(std::complex<T>(x, 0))) [all...] |
Android.mk | 19 test_name := numerics/complex.number/cmplx.over/conj 20 test_src := conj.pass.cpp
|
/ndk/sources/cxx-stl/llvm-libc++/libcxx/test/numerics/complex.number/cmplx.over/ |
conj.pass.cpp | 12 // template<class T> complex<T> conj(const complex<T>&); 13 // complex<long double> conj(long double); 14 // complex<double> conj(double); 15 // template<Integral T> complex<double> conj(T); 16 // complex<float> conj(float); 28 static_assert((std::is_same<decltype(std::conj(x)), std::complex<double> >::value), ""); 29 assert(std::conj(x) == conj(std::complex<double>(x, 0))); 36 static_assert((std::is_same<decltype(std::conj(x)), std::complex<T> >::value), ""); 37 assert(std::conj(x) == conj(std::complex<T>(x, 0))) [all...] |
/external/eigen/blas/ |
Rank2Update.h | 15 /* Optimized selfadjoint matrix += alpha * uv' + conj(alpha)*vu' 27 numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)) 28 + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)); 33 /* Optimized selfadjoint matrix += alpha * uv' + conj(alpha)*vu' 46 numext::conj(alpha) * numext::conj(u[i]) * OtherMap(v+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)) 47 + alpha * numext::conj(v[i]) * OtherMap(u+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1));
|
level3_impl.h | 25 func[ADJ | (NOTR << 2)] = (internal::general_matrix_matrix_product<DenseIndex,Scalar,RowMajor,Conj, Scalar,ColMajor,false,ColMajor>::run); 28 func[ADJ | (TR << 2)] = (internal::general_matrix_matrix_product<DenseIndex,Scalar,RowMajor,Conj, Scalar,RowMajor,false,ColMajor>::run); 29 func[NOTR | (ADJ << 2)] = (internal::general_matrix_matrix_product<DenseIndex,Scalar,ColMajor,false,Scalar,RowMajor,Conj, ColMajor>::run); 30 func[TR | (ADJ << 2)] = (internal::general_matrix_matrix_product<DenseIndex,Scalar,RowMajor,false,Scalar,RowMajor,Conj, ColMajor>::run); 31 func[ADJ | (ADJ << 2)] = (internal::general_matrix_matrix_product<DenseIndex,Scalar,RowMajor,Conj, Scalar,RowMajor,Conj, ColMajor>::run); 80 func[ADJ | (LEFT << 2) | (UP << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Lower|0, Conj, RowMajor,ColMajor>::run); 84 func[ADJ | (RIGHT << 2) | (UP << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Lower|0, Conj, RowMajor,ColMajor>::run); 88 func[ADJ | (LEFT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheLeft, Upper|0, Conj, RowMajor,ColMajor>::run); 92 func[ADJ | (RIGHT << 2) | (LO << 3) | (NUNIT << 4)] = (internal::triangular_solve_matrix<Scalar,DenseIndex,OnTheRight,Upper|0, Conj, RowMajor,ColMajor>::run) [all...] |
level2_impl.h | 25 func[ADJ ] = (internal::general_matrix_vector_product<int,Scalar,RowMajor,Conj, Scalar,false>::run); 89 func[ADJ | (UP << 2) | (NUNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Lower|0, Conj, RowMajor>::run); 93 func[ADJ | (LO << 2) | (NUNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|0, Conj, RowMajor>::run); 97 func[ADJ | (UP << 2) | (UNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Lower|UnitDiag,Conj, RowMajor>::run); 101 func[ADJ | (LO << 2) | (UNIT << 3)] = (internal::triangular_solve_vector<Scalar,Scalar,int,OnTheLeft, Upper|UnitDiag,Conj, RowMajor>::run); 144 func[ADJ | (UP << 2) | (NUNIT << 3)] = (internal::triangular_matrix_vector_product<int,Lower|0, Scalar,Conj, Scalar,false,RowMajor>::run); 148 func[ADJ | (LO << 2) | (NUNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|0, Scalar,Conj, Scalar,false,RowMajor>::run); 152 func[ADJ | (UP << 2) | (UNIT << 3)] = (internal::triangular_matrix_vector_product<int,Lower|UnitDiag,Scalar,Conj, Scalar,false,RowMajor>::run); 156 func[ADJ | (LO << 2) | (UNIT << 3)] = (internal::triangular_matrix_vector_product<int,Upper|UnitDiag,Scalar,Conj, Scalar,false,RowMajor>::run); 345 func[ADJ | (UP << 2) | (NUNIT << 3)] = (internal::band_solve_triangular_selector<int,Lower|0, Scalar,Conj, Scalar,RowMajor>::run) [all...] |
/external/eigen/Eigen/src/Core/products/ |
SelfadjointRank2Update.h | 17 /* Optimized selfadjoint matrix += alpha * uv' + conj(alpha)*vu' 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);
|
SelfadjointMatrixMatrix.h | 33 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed 44 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed 71 blockA[count++] = numext::conj(lhs(k, i)); // transposed 110 blockB[count+0] = numext::conj(rhs(j2+0,k)); 111 blockB[count+1] = numext::conj(rhs(j2+1,k)); 114 blockB[count+2] = numext::conj(rhs(j2+2,k)); 115 blockB[count+3] = numext::conj(rhs(j2+3,k)); 131 blockB[count+w] = numext::conj(rhs(j2+w,k)); 154 blockB[count+0] = numext::conj(rhs(j2+0,k)); 155 blockB[count+1] = numext::conj(rhs(j2+1,k)) [all...] |
TriangularSolverMatrix.h | 75 conj_if<Conjugate> conj; local 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; local 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));
|
/external/eigen/Eigen/src/Geometry/ |
OrthoMethods.h | 36 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), 37 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), 38 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)) 52 numext::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)), 53 numext::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)), 54 numext::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)), 144 perp.coeffRef(maxi) = -numext::conj(src.coeff(sndi)) * invnm; 145 perp.coeffRef(sndi) = numext::conj(src.coeff(maxi)) * invnm; 171 perp.coeffRef(0) = -numext::conj(src.y())*invnm; 172 perp.coeffRef(1) = numext::conj(src.x())*invnm [all...] |
/external/eigen/Eigen/src/Jacobi/ |
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)); } 62 JacobiRotation adjoint() const { using numext::conj; return JacobiRotation(conj(m_c), -m_s); [all...] |
/external/eigen/test/ |
jacobi.cpp | 43 VERIFY_IS_APPROX(b.row(p), c * a.row(p) + numext::conj(s) * a.row(q)); 44 VERIFY_IS_APPROX(b.row(q), -s * a.row(p) + numext::conj(c) * a.row(q)); 57 VERIFY_IS_APPROX(b.col(q), numext::conj(s) * a.col(p) + numext::conj(c) * a.col(q));
|
adjoint.cpp | 19 VERIFY(test_isApproxWithRef((s1 * v1 + s2 * v2).dot(v3), numext::conj(s1) * v1.dot(v3) + numext::conj(s2) * v2.dot(v3), 0)); 34 VERIFY(test_isApproxWithRef((s1 * v1 + s2 * v2).dot(v3), numext::conj(s1) * v1.dot(v3) + numext::conj(s2) * v2.dot(v3), ref)); 89 VERIFY_IS_APPROX((s1 * m1).adjoint(), numext::conj(s1) * m1.adjoint()); 92 VERIFY_IS_APPROX(numext::conj(v1.dot(v2)), v2.dot(v1)); 102 VERIFY_IS_APPROX(m1.conjugate()(r,c), numext::conj(m1(r,c))); 103 VERIFY_IS_APPROX(m1.adjoint()(c,r), numext::conj(m1(r,c)));
|
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());
|
/external/clang/test/CodeGen/ |
complex-builtints.c | 4 /* Test for builtin conj, creal, cimag. */ 8 extern double _Complex conj (double _Complex);
|
/external/libcxx/test/numerics/complex.number/complex.value.ops/ |
conj.pass.cpp | 14 // conj(const complex<T>& x); 23 assert(conj(z) == x);
|
Android.mk | 23 test_name := numerics/complex.number/complex.value.ops/conj 24 test_src := conj.pass.cpp
|
/ndk/sources/cxx-stl/llvm-libc++/libcxx/test/numerics/complex.number/complex.value.ops/ |
conj.pass.cpp | 14 // conj(const complex<T>& x); 23 assert(conj(z) == x);
|
/external/eigen/Eigen/src/Core/util/ |
BlasUtil.h | 45 inline T operator()(const T& x) { return numext::conj(x); } 93 template<typename RealScalar,bool Conj> struct conj_helper<std::complex<RealScalar>, RealScalar, Conj,false> 99 { return conj_if<Conj>()(x)*y; } 102 template<typename RealScalar,bool Conj> struct conj_helper<RealScalar, std::complex<RealScalar>, false,Conj> 108 { return x*conj_if<Conj>()(y); } 187 static inline Scalar extractScalarFactor(const XprType& x) { return conj(Base::extractScalarFactor(x.nestedExpression())); }
|
/external/eigen/Eigen/src/SparseCore/ |
SparseDot.h | 33 res += numext::conj(i.value()) * other.coeff(i.index()); 67 res += numext::conj(i.value()) * j.value();
|
/bionic/libm/upstream-freebsd/lib/msun/src/ |
s_conj.c | 34 conj(double complex z) function
|
/external/eigen/Eigen/src/Core/ |
SelfAdjointView.h | 125 * \f$ this = this + \alpha u v^* + conj(\alpha) v u^* \f$ 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));
|
/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/eigen/Eigen/src/SparseCholesky/ |
SimplicialCholesky_impl.h | 134 y[i] += numext::conj(it.value()); /* scatter A(i,k) into Y (sum duplicates) */ 166 y[Li[p]] -= numext::conj(Lx[p]) * yi; 167 d -= numext::real(l_ki * numext::conj(yi));
|
/bionic/libm/include/ |
complex.h | 66 double complex conj(double complex) __pure2;
|