Searched refs:numext (Results 1 - 25 of 75) sorted by path

123

/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h271 if (numext::real(mat.coeff(0,0)) > 0) sign = PositiveSemiDef;
272 else if (numext::real(mat.coeff(0,0)) < 0) sign = NegativeSemiDef;
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));
324 RealScalar realAkk = numext::real(mat.coeffRef(k,k));
351 using numext::isfinite;
369 RealScalar dj = numext::real(mat.coeff(j,j));
371 RealScalar swj2 = sigma*numext::abs2(wj);
382 mat.col(j).tail(rs) += (sigma*numext
[all...]
H A DLLT.h235 RealScalar Ljj = numext::real(mat.coeff(j,j));
236 RealScalar dj = numext::abs2(Ljj);
238 RealScalar swj2 = sigma*numext::abs2(wj);
254 mat.col(j).tail(rs) = (nLjj/Ljj) * mat.col(j).tail(rs) + (nLjj * sigma*numext::conj(wj)/gamma)*temp.tail(rs);
280 RealScalar x = numext::real(mat.coeff(k,k));
/external/eigen/Eigen/src/Core/
H A DDot.h115 return numext::real((*this).cwiseAbs2().sum());
232 return numext::abs2(nested.dot(otherNested)) <= prec * prec * nested.squaredNorm() * otherNested.squaredNorm();
H A DFunctors.h174 inline Scalar operator() (const Scalar& a, const OtherScalar& b) const { return numext::pow(a, b); }
313 EIGEN_STRONG_INLINE const result_type operator() (const Scalar& a) const { return numext::abs2(a); }
329 EIGEN_STRONG_INLINE const Scalar operator() (const Scalar& a) const { using numext::conj; return conj(a); }
366 EIGEN_STRONG_INLINE result_type operator() (const Scalar& a) const { return numext::real(a); }
381 EIGEN_STRONG_INLINE result_type operator() (const Scalar& a) const { return numext::imag(a); }
396 EIGEN_STRONG_INLINE result_type& operator() (const Scalar& a) const { return numext::real_ref(*const_cast<Scalar*>(&a)); }
411 EIGEN_STRONG_INLINE result_type& operator() (const Scalar& a) const { return numext::imag_ref(*const_cast<Scalar*>(&a)); }
804 inline Scalar operator() (const Scalar& a) const { return numext::pow(a, m_exponent); }
H A DFuzzy.h45 return x.cwiseAbs2().sum() <= numext::abs2(prec) * y.cwiseAbs2().sum();
63 return x.cwiseAbs2().sum() <= numext::abs2(prec * y);
H A DGeneralProduct.h438 bool alphaIsCompatible = (!ComplexByReal) || (numext::imag(actualAlpha)==RealScalar(0));
H A DGenericPacketMath.h109 pconj(const Packet& a) { return numext::conj(a); }
H A DMathFunctions.h554 namespace numext { namespace in namespace:Eigen
635 } // end namespace numext
696 return numext::abs2(x) <= numext::abs2(y) * prec * prec;
701 return numext::abs2(x - y) <= (min)(numext::abs2(x), numext::abs2(y)) * prec * prec;
H A DSelfAdjointView.h217 dst.coeffRef(row, col) = numext::real(src.coeff(row, col));
219 dst.coeffRef(col, row) = numext::conj(dst.coeffRef(row, col) = src.coeff(row, col));
242 dst.coeffRef(row, col) = numext::real(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));
H A DStableNorm.h25 ssq = ssq * numext::abs2(scale/maxCoeff);
100 if(ax > ab2) abig += numext::abs2(ax*s2m);
101 else if(ax < b1) asml += numext::abs2(ax*s1m);
102 else amed += numext::abs2(ax);
136 return abig * sqrt(RealScalar(1) + numext::abs2(asml/abig));
/external/eigen/Eigen/src/Core/arch/SSE/
H A DComplex.h84 template<> EIGEN_STRONG_INLINE Packet2cf pload <Packet2cf>(const std::complex<float>* from) { EIGEN_DEBUG_ALIGNED_LOAD return Packet2cf(pload<Packet4f>(&numext::real_ref(*from))); }
85 template<> EIGEN_STRONG_INLINE Packet2cf ploadu<Packet2cf>(const std::complex<float>* from) { EIGEN_DEBUG_UNALIGNED_LOAD return Packet2cf(ploadu<Packet4f>(&numext::real_ref(*from))); }
107 template<> EIGEN_STRONG_INLINE void pstore <std::complex<float> >(std::complex<float> * to, const Packet2cf& from) { EIGEN_DEBUG_ALIGNED_STORE pstore(&numext::real_ref(*to), from.v); }
108 template<> EIGEN_STRONG_INLINE void pstoreu<std::complex<float> >(std::complex<float> * to, const Packet2cf& from) { EIGEN_DEBUG_UNALIGNED_STORE pstoreu(&numext::real_ref(*to), from.v); }
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixVector.h82 alpha = numext::conj(alpha);
H A DSelfadjointMatrixMatrix.h33 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed
35 blockA[count++] = numext::real(lhs(k,k)); // real (diagonal)
44 blockA[count++] = numext::conj(lhs(k, i+w)); // transposed
68 blockA[count++] = numext::real(lhs(i, i)); // real (diagonal)
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));
127 blockB[count+h] = numext
[all...]
H A DSelfadjointMatrixVector.h62 Scalar cjAlpha = ConjugateRhs ? numext::conj(alpha) : alpha;
101 res[j] += cjd.pmul(numext::real(A0[j]), t0);
102 res[j+1] += cjd.pmul(numext::real(A1[j+1]), t1);
117 t2 += numext::conj(A0[i]) * rhs[i];
118 t3 += numext::conj(A1[i]) * rhs[i];
155 res[j] += cjd.pmul(numext::real(A0[j]), t1);
H A 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);
H A DTriangularMatrixVector.h248 bool alphaIsCompatible = (!ComplexByReal) || (numext::imag(actualAlpha)==RealScalar(0));
/external/eigen/Eigen/src/Core/util/
H A DBlasUtil.h45 inline T operator()(const T& x) { return numext::conj(x); }
70 { return Scalar(numext::real(x)*numext::real(y) + numext::imag(x)*numext::imag(y), numext::imag(x)*numext::real(y) - numext::real(x)*numext::imag(y)); }
80 { return Scalar(numext
[all...]
/external/eigen/Eigen/src/Eigen2Support/
H A DMathFunctions.h15 template<typename T> inline typename NumTraits<T>::Real ei_real(const T& x) { return numext::real(x); }
16 template<typename T> inline typename NumTraits<T>::Real ei_imag(const T& x) { return numext::imag(x); }
17 template<typename T> inline T ei_conj(const T& x) { return numext::conj(x); }
19 template<typename T> inline typename NumTraits<T>::Real ei_abs2(const T& x) { return numext::abs2(x); }
26 template<typename T> inline T ei_pow (const T& x,const T& y) { return numext::pow(x,y); }
H A DSVD.h318 Scalar t(numext::hypot(m_sigma[j],f));
347 Scalar t(numext::hypot(m_sigma[j],f));
395 Scalar t = numext::hypot(f,g);
413 t = numext::hypot(f,g);
/external/eigen/Eigen/src/Eigenvalues/
H A DComplexEigenSolver.h297 numext::real_ref(z) = NumTraits<RealScalar>::epsilon() * matrixnorm;
H A DComplexSchur.h266 RealScalar d = numext::norm1(m_matT.coeff(i,i)) + numext::norm1(m_matT.coeff(i+1,i+1));
267 RealScalar sd = numext::norm1(m_matT.coeff(i+1,i));
285 return abs(numext::real(m_matT.coeff(iu,iu-1))) + abs(numext::real(m_matT.coeff(iu-1,iu-2)));
302 if(numext::norm1(eival1) > numext::norm1(eival2))
308 if(numext::norm1(eival1-t.coeff(1,1)) < numext::norm1(eival2-t.coeff(1,1)))
H A DEigenSolver.h320 if (internal::isMuchSmallerThan(numext::imag(m_eivalues.coeff(i)), numext::real(m_eivalues.coeff(i))))
321 matD.coeffRef(i,i) = numext::real(m_eivalues.coeff(i));
324 matD.template block<2,2>(i,i) << numext::real(m_eivalues.coeff(i)), numext::imag(m_eivalues.coeff(i)),
325 -numext::imag(m_eivalues.coeff(i)), numext::real(m_eivalues.coeff(i));
341 if (internal::isMuchSmallerThan(numext::imag(m_eivalues.coeff(j)), numext::real(m_eivalues.coeff(j))) || j+1==n)
518 m_matT.coeffRef(n-1,n-1) = numext
[all...]
H A DHessenbergDecomposition.h316 .applyHouseholderOnTheRight(matA.col(i).tail(remainingSize-1).conjugate(), numext::conj(h), &temp.coeffRef(0));
H A DSelfAdjointEigenSolver.h398 m_eivalues.coeffRef(0,0) = numext::real(matrix.coeff(0,0));
672 const Scalar t0 = Scalar(0.5) * sqrt( numext::abs2(m(0,0)-m(1,1)) + Scalar(4)*m(1,0)*m(1,0));
702 Scalar a2 = numext::abs2(scaledMat(0,0));
703 Scalar c2 = numext::abs2(scaledMat(1,1));
704 Scalar b2 = numext::abs2(scaledMat(1,0));
747 // RealScalar e2 = numext::abs2(subdiag[end-1]);
755 RealScalar e2 = numext::abs2(subdiag[end-1]);
756 RealScalar h = numext::hypot(td,e);
H A DSelfAdjointEigenSolver_MKL.h59 m_eivalues.coeffRef(0,0) = numext::real(matrix.coeff(0,0)); \

Completed in 376 milliseconds

123