Searched refs:conj (Results 1 - 25 of 43) sorted by relevance

12

/external/eigen/Eigen/src/Geometry/
H A DOrthoMethods.h36 internal::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)),
37 internal::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)),
38 internal::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0))
52 internal::conj(lhs.coeff(1) * rhs.coeff(2) - lhs.coeff(2) * rhs.coeff(1)),
53 internal::conj(lhs.coeff(2) * rhs.coeff(0) - lhs.coeff(0) * rhs.coeff(2)),
54 internal::conj(lhs.coeff(0) * rhs.coeff(1) - lhs.coeff(1) * rhs.coeff(0)),
144 perp.coeffRef(maxi) = -conj(src.coeff(sndi)) * invnm;
145 perp.coeffRef(sndi) = conj(src.coeff(maxi)) * invnm;
171 perp.coeffRef(0) = -conj(src.y())*invnm;
172 perp.coeffRef(1) = conj(sr
[all...]
/external/eigen/Eigen/src/Core/products/
H A DSelfadjointRank2Update.h17 /* Optimized selfadjoint matrix += alpha * uv' + conj(alpha)*vu'
33 (conj(alpha) * conj(u.coeff(i))) * v.tail(size-i)
34 + (alpha * conj(v.coeff(i))) * u.tail(size-i);
47 (conj(alpha) * conj(u.coeff(i))) * v.head(i+1)
48 + (alpha * conj(v.coeff(i))) * u.head(i+1);
78 * internal::conj(VBlasTraits::extractScalarFactor(v.derived()));
80 actualAlpha = internal::conj(actualAlpha);
H A DSelfadjointMatrixMatrix.h33 blockA[count++] = conj(lhs(k, i+w)); // transposed
44 blockA[count++] = conj(lhs(k, i+w)); // transposed
71 blockA[count++] = conj(lhs(k, i)); // transposed
110 blockB[count+0] = conj(rhs(j2+0,k));
111 blockB[count+1] = conj(rhs(j2+1,k));
114 blockB[count+2] = conj(rhs(j2+2,k));
115 blockB[count+3] = conj(rhs(j2+3,k));
131 blockB[count+w] = conj(rhs(j2+w,k));
154 blockB[count+0] = conj(rhs(j2+0,k));
155 blockB[count+1] = conj(rh
[all...]
H A DTriangularSolverMatrix.h68 conj_if<Conjugate> conj; local
114 Scalar a = (Mode & UnitDiag) ? Scalar(1) : Scalar(1)/conj(tri(i,i));
123 b += conj(l[i3]) * r[i3];
134 r[i3] -= b * conj(l[i3]);
211 conj_if<Conjugate> conj; local
287 Scalar b = conj(rhs(IsLower ? j+1+k3 : absolute_j2+k3,j));
292 Scalar b = (Mode & UnitDiag) ? Scalar(1) : Scalar(1)/conj(rhs(j,j));
H A DGeneralMatrixMatrix_MKL.h64 using std::conj; \
H A DSelfadjointMatrixVector.h54 Scalar cjAlpha = ConjugateRhs ? conj(alpha) : alpha;
109 t2 += conj(A0[i]) * rhs[i];
110 t3 += conj(A1[i]) * rhs[i];
/external/eigen/test/
H A Djacobi.cpp44 VERIFY_IS_APPROX(b.row(p), c * a.row(p) + internal::conj(s) * a.row(q));
45 VERIFY_IS_APPROX(b.row(q), -s * a.row(p) + internal::conj(c) * a.row(q));
58 VERIFY_IS_APPROX(b.col(q), internal::conj(s) * a.col(p) + internal::conj(c) * a.col(q));
H A Dadjoint.cpp46 VERIFY_IS_APPROX((s1 * m1).adjoint(), internal::conj(s1) * m1.adjoint());
52 VERIFY(test_isApproxWithRef((s1 * v1 + s2 * v2).dot(v3), internal::conj(s1) * v1.dot(v3) + internal::conj(s2) * v2.dot(v3), ref));
54 VERIFY_IS_APPROX(internal::conj(v1.dot(v2)), v2.dot(v1));
76 VERIFY_IS_APPROX(m1.conjugate()(r,c), internal::conj(m1(r,c)));
77 VERIFY_IS_APPROX(m1.adjoint()(c,r), internal::conj(m1(r,c)));
H A Dproduct_selfadjoint.cpp48 VERIFY_IS_APPROX(m2, (m1 + (s3*(-v1)*(s2*v2).adjoint()+internal::conj(s3)*(s2*v2)*(-v1).adjoint())).template triangularView<Upper>().toDenseMatrix());
52 VERIFY_IS_APPROX(m2, (m1 + s1*(-s2*r1.adjoint())*(r2.adjoint()*s3).adjoint() + internal::conj(s1)*(r2.adjoint()*s3) * (-s2*r1.adjoint()).adjoint()).template triangularView<Upper>().toDenseMatrix());
H A Ddeterminant.cpp42 VERIFY_IS_APPROX(internal::conj(m2.determinant()), m2.adjoint().determinant());
/external/eigen/Eigen/src/Jacobi/
H A DJacobi.h53 return JacobiRotation(m_c * other.m_c - internal::conj(m_s) * other.m_s,
54 internal::conj(m_c * internal::conj(other.m_s) + internal::conj(m_s) * internal::conj(other.m_c)));
58 JacobiRotation transpose() const { return JacobiRotation(m_c, -internal::conj(m_s)); }
61 JacobiRotation adjoint() const { return JacobiRotation(internal::conj(m_c), -m_s); }
106 m_s = - sign_t * (internal::conj(y) / internal::abs(y)) * internal::abs(t) * n;
183 m_s = -qs*internal::conj(ps)*(m_c/p2);
200 m_s = -internal::conj(p
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseDot.h33 res += internal::conj(i.value()) * other.coeff(i.index());
67 res += internal::conj(i.value()) * j.value();
H A DSparseSelfAdjointView.h243 dest.row(b) += internal::conj(v) * m_rhs.row(a);
370 dest.valuePtr()[k] = internal::conj(it.value());
431 dest.valuePtr()[k] = conj(it.value());
/external/clang/test/CodeGen/
H A Dcomplex-builtints.c4 /* Test for builtin conj, creal, cimag. */
8 extern double _Complex conj (double _Complex);
/external/eigen/Eigen/src/Core/
H A DSelfAdjointView.h125 * \f$ this = this + \alpha u v^* + conj(\alpha) v u^* \f$
219 dst.coeffRef(col, row) = conj(dst.coeffRef(row, col) = src.coeff(row, col));
244 dst.coeffRef(col, row) = conj(dst.coeffRef(row, col) = src.coeff(row, col));
265 dst.coeffRef(j,i) = conj(dst.coeff(i,j));
283 dst.coeffRef(j,i) = conj(dst.coeff(i,j));
H A DMathFunctions.h219 * Implementation of conj *
236 using std::conj;
237 return conj(x);
248 inline EIGEN_MATHFUNC_RETVAL(conj, Scalar) conj(const Scalar& x) function in namespace:Eigen::internal
250 return EIGEN_MATHFUNC_IMPL(conj, Scalar)::run(x);
/external/eigen/unsupported/Eigen/src/FFT/
H A Dei_kissfft_impl.h323 Complex fpnk = conj(dst[ncfft-k]);
328 dst[ncfft-k] = conj(f1k -tw)*Scalar(.5);
351 m_tmpBuf1[nfft-k] = conj(m_tmpBuf1[k]);
364 Complex fnkc = conj(src[ncfft-k]);
367 Complex fok = tmp * conj(rtw[k-1]);
369 m_tmpBuf1[ncfft-k] = conj(fek - fok);
/external/eigen/Eigen/src/Householder/
H A DHouseholder.h88 tau = internal::conj((beta - c0) / beta);
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h304 mat.coeffRef(i,k) = conj(mat.coeffRef(index_of_biggest_in_corner,i));
305 mat.coeffRef(index_of_biggest_in_corner,i) = conj(tmp);
308 mat.coeffRef(index_of_biggest_in_corner,k) = conj(mat.coeff(index_of_biggest_in_corner,k));
375 mat.col(j).tail(rs) += (sigma*conj(wj)/gamma)*w.tail(rs);
/external/eigen/Eigen/src/Eigen2Support/
H A DMathFunctions.h17 template<typename T> inline T ei_conj(const T& x) { return internal::conj(x); }
/external/eigen/Eigen/src/Eigenvalues/
H A DHessenbergDecomposition.h316 .applyHouseholderOnTheRight(matA.col(i).tail(remainingSize-1).conjugate(), internal::conj(h), &temp.coeffRef(0));
H A DTridiagonalization.h367 * (conj(h) * matA.col(i).tail(remainingSize)));
369 hCoeffs.tail(n-i-1) += (conj(h)*Scalar(-0.5)*(hCoeffs.tail(remainingSize).dot(matA.col(i).tail(remainingSize)))) * matA.col(i).tail(n-i-1);
/external/eigen/blas/
H A Dlevel2_cplx_impl.h143 matrix(a,*n,*n,*lda).col(j).tail(*n-j) += alpha * internal::conj(x_cpy[j]) * vector(x_cpy+j,*n-j);
146 matrix(a,*n,*n,*lda).col(j).head(j+1) += alpha * internal::conj(x_cpy[j]) * vector(x_cpy,j+1);
/external/eigen/Eigen/src/Core/util/
H A DBlasUtil.h45 inline T operator()(const T& x) { return conj(x); }
187 static inline Scalar extractScalarFactor(const XprType& x) { return conj(Base::extractScalarFactor(x.nestedExpression())); }
/external/opencv/cxcore/src/
H A D_cxcore.h166 inline CvComplex32f conj(CvComplex32f a) function
256 inline CvComplex64f conj(CvComplex64f a) function

Completed in 3127 milliseconds

12