Searched refs:coeff (Results 1 - 25 of 302) sorted by relevance

1234567891011>>

/external/eigen/Eigen/src/Geometry/
H A DEulerAngles.h55 res[0] = atan2(coeff(j,i), coeff(k,i));
59 Scalar s2 = Vector2(coeff(j,i), coeff(k,i)).norm();
60 res[1] = -atan2(s2, coeff(i,i));
64 Scalar s2 = Vector2(coeff(j,i), coeff(k,i)).norm();
65 res[1] = atan2(s2, coeff(i,i));
80 res[2] = atan2(c1*coeff(j,k)-s1*coeff(
[all...]
H A DOrthoMethods.h36 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(
[all...]
H A DHyperplane.h157 inline const Scalar& offset() const { return m_coeffs.coeff(dim()); }
183 Scalar det = coeffs().coeff(0) * other.coeffs().coeff(1) - coeffs().coeff(1) * other.coeffs().coeff(0);
188 if(abs(coeffs().coeff(1))>abs(coeffs().coeff(0)))
189 return VectorType(coeffs().coeff(1), -coeffs().coeff(2)/coeffs().coeff(
[all...]
/external/chromium_org/third_party/skia/src/gpu/
H A DGrBlend.h15 static inline bool GrBlendCoeffRefsSrc(GrBlendCoeff coeff) { argument
16 switch (coeff) {
27 static inline bool GrBlendCoeffRefsDst(GrBlendCoeff coeff) { argument
28 switch (coeff) {
/external/skia/src/gpu/
H A DGrBlend.h15 static inline bool GrBlendCoeffRefsSrc(GrBlendCoeff coeff) { argument
16 switch (coeff) {
27 static inline bool GrBlendCoeffRefsDst(GrBlendCoeff coeff) { argument
28 switch (coeff) {
/external/eigen/unsupported/test/
H A Dkronecker_product.cpp32 VERIFY_IS_APPROX(ab.coeff(0,0), -0.4017367630386106);
33 VERIFY_IS_APPROX(ab.coeff(0,1), 0.1056863433932735);
34 VERIFY_IS_APPROX(ab.coeff(0,2), -0.7255206194554212);
35 VERIFY_IS_APPROX(ab.coeff(0,3), 0.1908653336744706);
36 VERIFY_IS_APPROX(ab.coeff(0,4), 0.350864567234111);
37 VERIFY_IS_APPROX(ab.coeff(0,5), -0.0923032108308013);
38 VERIFY_IS_APPROX(ab.coeff(1,0), 0.415417514804677);
39 VERIFY_IS_APPROX(ab.coeff(1,1), -0.2369227701722048);
40 VERIFY_IS_APPROX(ab.coeff(1,2), 0.7502275131458511);
41 VERIFY_IS_APPROX(ab.coeff(
[all...]
/external/eigen/Eigen/src/LU/
H A DDeterminant.h21 return matrix.coeff(0,a)
22 * (matrix.coeff(1,b) * matrix.coeff(2,c) - matrix.coeff(1,c) * matrix.coeff(2,b));
29 return (matrix.coeff(j,0) * matrix.coeff(k,1) - matrix.coeff(k,0) * matrix.coeff(j,1))
30 * (matrix.coeff(
[all...]
/external/libvorbis/lib/
H A Dlpc.h26 extern void vorbis_lpc_predict(float *coeff,float *prime,int m,
/external/eigen/test/
H A DsparseLM.cpp41 Scalar coeff; local
46 coeff = (x(j)-i)/v(i);
47 coeff *= coeff;
48 if (coeff < 1. && coeff > 0.)
49 y(j) += u(i)*std::pow((1-coeff), 2);
69 Scalar coeff; local
74 coeff = (m_x(j)-i)/v(i);
75 coeff *
93 Scalar coeff; local
[all...]
H A Dproduct_small.cpp20 VERIFY_IS_APPROX( (matAstatic * matBstatic).coeff(0,0),
27 VERIFY_IS_APPROX( (matAdynamic * matBdynamic).coeff(0,0),
/external/chromium_org/third_party/skia/src/core/
H A DSkValidationUtils.h14 /** Returns true if coeff's value is in the SkXfermode::Coeff enum.
16 static inline bool SkIsValidCoeff(SkXfermode::Coeff coeff) { argument
17 return coeff >= 0 && coeff < SkXfermode::kCoeffCount;
/external/skia/src/core/
H A DSkValidationUtils.h14 /** Returns true if coeff's value is in the SkXfermode::Coeff enum.
16 static inline bool SkIsValidCoeff(SkXfermode::Coeff coeff) { argument
17 return coeff >= 0 && coeff < SkXfermode::kCoeffCount;
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DHyperplane.h146 inline const Scalar& offset() const { return m_coeffs.coeff(dim()); }
171 Scalar det = coeffs().coeff(0) * other.coeffs().coeff(1) - coeffs().coeff(1) * other.coeffs().coeff(0);
176 if(ei_abs(coeffs().coeff(1))>ei_abs(coeffs().coeff(0)))
177 return VectorType(coeffs().coeff(1), -coeffs().coeff(2)/coeffs().coeff(
[all...]
/external/eigen/Eigen/src/Eigenvalues/
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)
352 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(
[all...]
H A DRealQZ.h237 if(m_S.coeff(i,j) != 0)
239 G.makeGivens(m_S.coeff(i-1,j), m_S.coeff(i,j), &m_S.coeffRef(i-1, j));
248 if(m_T.coeff(i,i-1)!=Scalar(0))
250 G.makeGivens(m_T.coeff(i,i), m_T.coeff(i,i-1), &m_T.coeffRef(i,i));
285 Scalar s = abs(m_S.coeff(res-1,res-1)) + abs(m_S.coeff(res,res));
288 if (abs(m_S.coeff(res,res-1)) < NumTraits<Scalar>::epsilon() * s)
302 if (abs(m_T.coeff(re
[all...]
H A DRealSchur.h294 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift;
352 Scalar s = abs(m_matT.coeff(res-1,res-1)) + abs(m_matT.coeff(res,res));
355 if (abs(m_matT.coeff(res,res-1)) < NumTraits<Scalar>::epsilon() * s)
372 Scalar p = Scalar(0.5) * (m_matT.coeff(iu-1,iu-1) - m_matT.coeff(iu,iu));
373 Scalar q = p * p + m_matT.coeff(iu,iu-1) * m_matT.coeff(iu-1,iu); // q = tr^2 / 4 - det = discr/4
382 rot.makeGivens(p + z, m_matT.coeff(iu, iu-1));
384 rot.makeGivens(p - z, m_matT.coeff(i
[all...]
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)));
294 ComplexScalar b = t.coeff(0,1) * t.coeff(1,0);
295 ComplexScalar c = t.coeff(0,0) - t.coeff(1,1);
297 ComplexScalar det = t.coeff(
[all...]
H A DGeneralizedEigenSolver.h313 if (i == A.cols() - 1 || m_matS.coeff(i+1, i) == Scalar(0))
315 m_alphas.coeffRef(i) = m_matS.coeff(i, i);
316 m_betas.coeffRef(i) = m_realQZ.matrixT().coeff(i,i);
321 Scalar p = Scalar(0.5) * (m_matS.coeff(i, i) - m_matS.coeff(i+1, i+1));
322 Scalar z = sqrt(abs(p * p + m_matS.coeff(i+1, i) * m_matS.coeff(i, i+1)));
323 m_alphas.coeffRef(i) = ComplexScalar(m_matS.coeff(i+1, i+1) + p, z);
324 m_alphas.coeffRef(i+1) = ComplexScalar(m_matS.coeff(i+1, i+1) + p, -z);
326 m_betas.coeffRef(i) = m_realQZ.matrixT().coeff(
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixSquareRoot.h96 if (i == size - 1 || T.coeff(i+1, i) == 0) {
98 sqrtT.coeffRef(i,i) = sqrt(T.coeff(i,i));
115 if (T.coeff(j, j-1) != 0) // if T(j-1:j, j-1:j) is a 2-by-2 block
118 if (i > 0 && T.coeff(i, i-1) != 0) // if T(i-1:i, i-1:i) is a 2-by-2 block
120 bool iBlockIs2x2 = (i < size - 1) && (T.coeff(i+1, i) != 0);
121 bool jBlockIs2x2 = (j < size - 1) && (T.coeff(j+1, j) != 0);
157 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j));
169 Matrix<Scalar,2,2> A = sqrtT.coeff(
[all...]
/external/chromium_org/third_party/libvpx/source/libvpx/vp8/encoder/x86/
H A Dvp8_enc_stubs_sse2.c20 short *coeff_ptr = mb->block[0].coeff;
28 short *s_ptr = &mb->coeff[256];
/external/chromium_org/third_party/libvpx/source/libvpx/vp9/encoder/
H A Dvp9_quantize.c27 const int coeff = coeff_ptr[rc]; local
28 const int coeff_sign = (coeff >> 31);
29 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
52 const int coeff = coeff_ptr[rc]; local
53 const int coeff_sign = (coeff >> 31);
54 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
73 const int coeff = coeff_ptr[rc]; local
74 const int coeff_sign = (coeff >> 31);
75 const int abs_coeff = (coeff ^ coeff_sign) - coeff_sign;
99 const int coeff local
139 const int coeff = coeff_ptr[rc]; local
182 const int coeff = coeff_ptr[rc]; local
224 const int coeff = coeff_ptr[rc]; local
268 const int coeff = coeff_ptr[rc]; local
311 const int coeff = coeff_ptr[rc]; local
323 const int coeff = coeff_ptr[rc]; local
365 const int coeff = coeff_ptr[rc]; local
377 const int coeff = coeff_ptr[rc]; local
423 const int coeff = coeff_ptr[rc]; local
435 const int coeff = coeff_ptr[rc]; local
482 const int coeff = coeff_ptr[rc]; local
494 const int coeff = coeff_ptr[rc]; local
[all...]
/external/eigen/Eigen/src/Core/
H A DSelect.h75 const Scalar coeff(Index i, Index j) const function in class:Eigen::Select
77 if (m_condition.coeff(i,j))
78 return m_then.coeff(i,j);
80 return m_else.coeff(i,j);
83 const Scalar coeff(Index i) const function in class:Eigen::Select
85 if (m_condition.coeff(i))
86 return m_then.coeff(i);
88 return m_else.coeff(i);
H A DNestByValue.h50 inline const CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::NestByValue
52 return m_expression.coeff(row, col);
60 inline const CoeffReturnType coeff(Index index) const function in class:Eigen::NestByValue
62 return m_expression.coeff(index);
/external/libvpx/libvpx/vp8/encoder/x86/
H A Dvp8_enc_stubs_sse2.c20 short *coeff_ptr = mb->block[0].coeff;
28 short *s_ptr = &mb->coeff[256];
/external/chromium_org/skia/ext/
H A Dconvolver_SSE2.cc49 __m128i coeff, coeff16; local
51 coeff = _mm_loadl_epi64(reinterpret_cast<const __m128i*>(filter_values));
53 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(1, 1, 0, 0));
76 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(3, 3, 2, 2));
102 __m128i coeff, coeff16; local
103 coeff = _mm_loadl_epi64(reinterpret_cast<const __m128i*>(filter_values));
105 coeff = _mm_and_si128(coeff, mask[r]);
106 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFLE(1, 1, 0, 0));
121 coeff16 = _mm_shufflelo_epi16(coeff, _MM_SHUFFL
175 __m128i coeff, coeff16lo, coeff16hi; local
218 __m128i coeff; local
[all...]

Completed in 503 milliseconds

1234567891011>>