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

12345678

/external/eigen/Eigen/src/Geometry/
H A DEulerAngles.h49 Scalar s = Vector2(coeff(j,i) , coeff(k,i)).norm();
50 res[1] = internal::atan2(s, coeff(i,i));
53 res[0] = internal::atan2(coeff(j,i), coeff(k,i));
54 res[2] = internal::atan2(coeff(i,j),-coeff(i,k));
59 res[2] = (coeff(i,i)>0?1:-1)*internal::atan2(-coeff(k,j), coeff(
[all...]
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(
[all...]
H A DHyperplane.h157 inline const Scalar& offset() const { return m_coeffs.coeff(dim()); }
182 Scalar det = coeffs().coeff(0) * other.coeffs().coeff(1) - coeffs().coeff(1) * other.coeffs().coeff(0);
187 if(internal::abs(coeffs().coeff(1))>internal::abs(coeffs().coeff(0)))
188 return VectorType(coeffs().coeff(1), -coeffs().coeff(2)/coeffs().coeff(
[all...]
/external/eigen/unsupported/test/
H A Dkronecker_product.cpp31 VERIFY_IS_APPROX(ab.coeff(0,0), -0.4017367630386106);
32 VERIFY_IS_APPROX(ab.coeff(0,1), 0.1056863433932735);
33 VERIFY_IS_APPROX(ab.coeff(0,2), -0.7255206194554212);
34 VERIFY_IS_APPROX(ab.coeff(0,3), 0.1908653336744706);
35 VERIFY_IS_APPROX(ab.coeff(0,4), 0.350864567234111);
36 VERIFY_IS_APPROX(ab.coeff(0,5), -0.0923032108308013);
37 VERIFY_IS_APPROX(ab.coeff(1,0), 0.415417514804677);
38 VERIFY_IS_APPROX(ab.coeff(1,1), -0.2369227701722048);
39 VERIFY_IS_APPROX(ab.coeff(1,2), 0.7502275131458511);
40 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...]
H A DInverse.h43 result.coeffRef(0,0) = Scalar(1) / matrix.coeff(0,0);
58 determinant = matrix.coeff(0,0);
73 result.coeffRef(0,0) = matrix.coeff(1,1) * invdet;
74 result.coeffRef(1,0) = -matrix.coeff(1,0) * invdet;
75 result.coeffRef(0,1) = -matrix.coeff(0,1) * invdet;
76 result.coeffRef(1,1) = matrix.coeff(0,0) * invdet;
123 return m.coeff(i1, j1) * m.coeff(i2, j2)
124 - m.coeff(i1, j2) * m.coeff(i
[all...]
/external/libvorbis/lib/
H A Dlpc.h26 extern void vorbis_lpc_predict(float *coeff,float *prime,int m,
/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...]
H A DQuaternion.h69 inline Scalar x() const { return m_coeffs.coeff(0); }
71 inline Scalar y() const { return m_coeffs.coeff(1); }
73 inline Scalar z() const { return m_coeffs.coeff(2); }
75 inline Scalar w() const { return m_coeffs.coeff(3); }
460 q.x() = (mat.coeff(2,1) - mat.coeff(1,2)) * t;
461 q.y() = (mat.coeff(0,2) - mat.coeff(2,0)) * t;
462 q.z() = (mat.coeff(1,0) - mat.coeff(
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DEigenSolver.h307 if (internal::isMuchSmallerThan(internal::imag(m_eivalues.coeff(i)), internal::real(m_eivalues.coeff(i))))
308 matD.coeffRef(i,i) = internal::real(m_eivalues.coeff(i));
311 matD.template block<2,2>(i,i) << internal::real(m_eivalues.coeff(i)), internal::imag(m_eivalues.coeff(i)),
312 -internal::imag(m_eivalues.coeff(i)), internal::real(m_eivalues.coeff(i));
328 if (internal::isMuchSmallerThan(internal::imag(m_eivalues.coeff(j)), internal::real(m_eivalues.coeff(j))) || j+1==n)
339 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(
[all...]
H A DRealSchur.h236 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift;
292 Scalar s = internal::abs(m_matT.coeff(res-1,res-1)) + internal::abs(m_matT.coeff(res,res));
295 if (internal::abs(m_matT.coeff(res,res-1)) < NumTraits<Scalar>::epsilon() * s)
310 Scalar p = Scalar(0.5) * (m_matT.coeff(iu-1,iu-1) - m_matT.coeff(iu,iu));
311 Scalar q = p * p + m_matT.coeff(iu,iu-1) * m_matT.coeff(iu-1,iu); // q = tr^2 / 4 - det = discr/4
320 rot.makeGivens(p + z, m_matT.coeff(iu, iu-1));
322 rot.makeGivens(p - z, m_matT.coeff(i
[all...]
H A DComplexSchur.h222 RealScalar d = internal::norm1(m_matT.coeff(i,i)) + internal::norm1(m_matT.coeff(i+1,i+1));
223 RealScalar sd = internal::norm1(m_matT.coeff(i+1,i));
240 return internal::abs(internal::real(m_matT.coeff(iu,iu-1))) + internal::abs(internal::real(m_matT.coeff(iu-1,iu-2)));
249 ComplexScalar b = t.coeff(0,1) * t.coeff(1,0);
250 ComplexScalar c = t.coeff(0,0) - t.coeff(1,1);
252 ComplexScalar det = t.coeff(
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixSquareRoot.h104 if (i == size - 1 || T.coeff(i+1, i) == 0) {
106 sqrtT.coeffRef(i,i) = internal::sqrt(T.coeff(i,i));
123 if (T.coeff(j, j-1) != 0) // if T(j-1:j, j-1:j) is a 2-by-2 block
126 if (i > 0 && T.coeff(i, i-1) != 0) // if T(i-1:i, i-1:i) is a 2-by-2 block
128 bool iBlockIs2x2 = (i < size - 1) && (T.coeff(i+1, i) != 0);
129 bool jBlockIs2x2 = (j < size - 1) && (T.coeff(j+1, j) != 0);
165 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j));
177 Matrix<Scalar,2,2> A = sqrtT.coeff(
[all...]
/external/eigen/Eigen/src/Core/
H A DBooleanRedux.h27 return all_unroller<Derived, UnrollCount-1>::run(mat) && mat.coeff(row, col);
34 static inline bool run(const Derived &mat) { return mat.coeff(0, 0); }
53 return any_unroller<Derived, UnrollCount-1>::run(mat) || mat.coeff(row, col);
60 static inline bool run(const Derived &mat) { return mat.coeff(0, 0); }
95 if (!coeff(i, j)) return false;
121 if (coeff(i, j)) return true;
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);
H A DFlagged.h58 inline CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::Flagged
60 return m_matrix.coeff(row, col);
63 inline CoeffReturnType coeff(Index index) const function in class:Eigen::Flagged
65 return m_matrix.coeff(index);
H A DForceAlignedAccess.h49 inline const CoeffReturnType coeff(Index row, Index col) const function in class:Eigen::ForceAlignedAccess
51 return m_expression.coeff(row, col);
59 inline const CoeffReturnType coeff(Index index) const function in class:Eigen::ForceAlignedAccess
61 return m_expression.coeff(index);
/external/eigen/test/
H A Dproduct_small.cpp20 VERIFY_IS_APPROX( (matAstatic * matBstatic).coeff(0,0),
27 VERIFY_IS_APPROX( (matAdynamic * matBdynamic).coeff(0,0),
/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];
H A Dvp8_enc_stubs_mmx.c31 short *coeff_ptr = b->coeff;
55 short *coeff_ptr = mb->block[0].coeff;
63 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...]
/external/eigen/bench/
H A DBenchUtil.h54 dst(i,j) = src.coeff(i,j);
68 gsl_matrix_set(*dst, i, j, src.coeff(i,j));
81 dst(i,j) = src.coeff(i,j);
88 dst[j] = src.coeff(j);
/external/aac/libSBRenc/src/
H A Dresampler.cpp375 const FIXP_SGL *coeff = downFilter->coeffa; local
405 state0 = input + fMult(state1, coeff[B1]) + fMult(state2, coeff[B2]);
406 y = state0 - fMult(state1b, coeff[A1]) - fMult(state2b, coeff[A2]);
421 coeff += BIQUAD_COEFSTEP;
440 state0 = input - fMult(state1, coeff[A1]) - fMult(state2, coeff[A2]);
441 y = state0 + fMult(state1, coeff[B1]) + fMult(state2, coeff[B
[all...]
/external/chromium_org/third_party/skia/include/effects/
H A DSkKernel33MaskFilter.h40 SkKernel33MaskFilter(const int coeff[3][3], int shift, int percent256 = 256) argument
42 memcpy(fKernel, coeff, 9 * sizeof(int));

Completed in 385 milliseconds

12345678