HomeSort by relevance Sort by last modified time
    Searched refs:coeff (Results 1 - 25 of 192) sorted by null

1 2 3 4 5 6 7 8

  /external/eigen/Eigen/src/Geometry/
EulerAngles.h 49 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(j,j))
    [all...]
OrthoMethods.h 36 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)
    [all...]
Hyperplane.h 157 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(1)-coeffs().coeff(0))
    [all...]
  /frameworks/av/media/libstagefright/codecs/m4v_h263/enc/src/
fastquant_inline.h 30 __inline int32 aan_scale(int32 q_value, int32 coeff, int32 round, int32 QPdiv2)
32 q_value = coeff * q_value + round;
33 coeff = q_value >> 16;
34 if (coeff < 0) coeff += QPdiv2;
35 else coeff -= QPdiv2;
37 return coeff;
41 __inline int32 coeff_quant(int32 coeff, int32 q_scale, int32 shift)
45 q_value = coeff * q_scale; //q_value = -((-(coeff + QPdiv2)*q_scale)>>LSL)
54 int32 coeff = q_value + ac_clip; local
64 int32 coeff; local
126 int32 coeff; local
178 smlabb q_value, coeff, q_value, round local
179 movs coeff, q_value, asr #16 local
180 addle coeff, coeff, QPdiv2 local
181 subgt coeff, coeff, QPdiv2 local
194 mov coeff, q_value, asr shift \/*smull tmp, coeff, q_scale, coeff*\/ local
195 add q_value, coeff, coeff, lsr #31 local
204 int32 coeff; local
209 smulbb coeff, q_value, QPx2 local
210 sublt coeff, coeff, Addition local
211 addge coeff, coeff, Addition local
212 add q_value, coeff, tmp local
215 eorhi coeff, tmp, coeff, asr #31 local
225 smlabb q_value, coeff, q_value, round local
246 int32 coeff; local
249 movs coeff, q_value, lsl #1 local
251 addgt coeff, coeff, #1 local
252 sublt coeff, coeff, #1 local
253 smulbb q_value, coeff, stepsize local
256 add coeff, q_value, tmp local
257 subs coeff, coeff, #0xf00 local
258 subcss coeff, coeff, #0xfe local
273 mla q_value, coeff, q_value, round local
274 movs coeff, q_value, asr #16 local
275 addle coeff, coeff, QPdiv2 local
276 subgt coeff, coeff, QPdiv2 local
289 mov coeff, q_value, asr shift \/*smull tmp, coeff, q_scale, coeff*\/ local
290 add q_value, coeff, coeff, lsr #31 local
300 int32 coeff; local
305 mul coeff, q_value, QPx2 local
306 sublt coeff, coeff, Addition local
307 addge coeff, coeff, Addition local
308 add q_value, coeff, tmp local
311 eorhi coeff, tmp, coeff, asr #31 local
321 mla q_value, coeff, q_value, round local
343 int32 coeff; local
346 movs coeff, q_value, lsl #1 local
348 addgt coeff, coeff, #1 local
349 sublt coeff, coeff, #1 local
350 mul q_value, coeff, stepsize local
353 add coeff, q_value, tmp local
354 subs coeff, coeff, #0xf00 local
355 subcss coeff, coeff, #0xfe local
367 int32 coeff; local
371 add coeff, q_value, ac_clip local
372 subs coeff, coeff, ac_clip, lsl #1 local
384 cmp coeff, #0 local
385 addle coeff, coeff, QP, asr #1 local
386 subgt coeff, coeff, QP, asr #1 local
395 int32 coeff; local
399 add coeff, q_value, tmp local
400 subs coeff, coeff, #0xf00 local
401 subcss coeff, coeff, #0xfe local
410 int32 coeff; local
417 add coeff, q_value, tmp local
418 subs coeff, coeff, #0xf00 local
419 subcss coeff, coeff, #0xfe local
471 register int32 coeff; local
555 register int32 coeff; local
    [all...]
fastquant.cpp 122 Input: coeff=> DCT coefficient
154 Int tmp, coeff, q_value; local
164 Int ac_clip; /* quantized coeff bound */
192 coeff = rcoeff[i];
193 if (coeff == 0x7fff) /* all zero column */
201 if (coeff >= -QPx2plus && coeff < QPx2plus) /* quantize to zero */
206 coeff = rcoeff[i];
207 if (coeff > -QPx2plus && coeff < QPx2plus) /* quantize to zero *
274 Int tmp, coeff, q_value; local
444 Int coeff, scale_q; local
498 Int tmp, coeff; local
549 Int tmp, coeff, q_value = 0; local
678 Int tmp, coeff, q_value = 0; local
855 Int q_value, coeff, stepsize; local
923 Int tmp, coeff, q_value; local
    [all...]
  /external/eigen/unsupported/test/
kronecker_product.cpp 31 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(1,3), -0.4278731019742696)
    [all...]
  /external/eigen/Eigen/src/LU/
Determinant.h 21 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(m,2) * matrix.coeff(n,3) - matrix.coeff(n,2) * matrix.coeff(m,3))
    [all...]
  /external/libvorbis/lib/
lpc.h 26 extern void vorbis_lpc_predict(float *coeff,float *prime,int m,
  /frameworks/rs/cpu_ref/
rsCpuIntrinsicConvolve5x5.cpp 72 const float* coeff) {
80 float4 px = convert_float4(py0[x0]) * coeff[0] +
81 convert_float4(py0[x1]) * coeff[1] +
82 convert_float4(py0[x2]) * coeff[2] +
83 convert_float4(py0[x3]) * coeff[3] +
84 convert_float4(py0[x4]) * coeff[4] +
86 convert_float4(py1[x0]) * coeff[5] +
87 convert_float4(py1[x1]) * coeff[6] +
88 convert_float4(py1[x2]) * coeff[7] +
89 convert_float4(py1[x3]) * coeff[8]
    [all...]
rsCpuIntrinsicColorMatrix.cpp 82 const uchar4 *py, const float* coeff) {
86 sum.x = i.x * coeff[0] +
87 i.y * coeff[4] +
88 i.z * coeff[8] +
89 i.w * coeff[12];
90 sum.y = i.x * coeff[1] +
91 i.y * coeff[5] +
92 i.z * coeff[9] +
93 i.w * coeff[13];
94 sum.z = i.x * coeff[2]
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
RealSchur.h 236 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(iu, iu-1))
    [all...]
EigenSolver.h 307 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(i,j), m_eivec.coeff(i,j+1))
    [all...]
ComplexSchur.h 222 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(0,0) * t.coeff(1,1) - b
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/Geometry/
Hyperplane.h 146 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(1)-coeffs().coeff(0))
    [all...]
Quaternion.h 69 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(0,1)) * t
    [all...]
  /frameworks/av/media/libstagefright/codecs/amrwbenc/src/
q_gain2.c 43 /* MA prediction coeff ={0.5, 0.4, 0.3, 0.2} in Q13 */
81 Word16 coeff[5], coeff_lo[5], exp_coeff[5]; local
130 * coeff[0] = y1 y1 *
131 * coeff[1] = -2 xn y1 *
132 * coeff[2] = y2 y2 *
133 * coeff[3] = -2 xn y2 *
134 * coeff[4] = 2 y1 y2 *
140 coeff[0] = g_coeff[0];
142 coeff[1] = negate(g_coeff[2]); /* coeff[1] = -2 xn y1 *
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixSquareRoot.h 104 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(i,i) * Matrix<Scalar,2,2>::Identity()
    [all...]
  /external/eigen/Eigen/src/Core/
BooleanRedux.h 27 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;
Select.h 75 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);
NestByValue.h 50 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/eigen/Eigen/src/SparseCore/
CoreIterators.h 40 return (IsRowMajor) ? m_expression.coeff(m_outer, m_inner)
41 : m_expression.coeff(m_inner, m_outer);
  /external/eigen/test/
product_small.cpp 20 VERIFY_IS_APPROX( (matAstatic * matBstatic).coeff(0,0),
27 VERIFY_IS_APPROX( (matAdynamic * matBdynamic).coeff(0,0),
  /external/libvpx/libvpx/vp8/encoder/x86/
vp8_enc_stubs_sse2.c 20 short *coeff_ptr = mb->block[0].coeff;
28 short *s_ptr = &mb->coeff[256];
  /external/skia/include/effects/
SkKernel33MaskFilter.h 38 SkKernel33MaskFilter(const int coeff[3][3], int shift, int percent256 = 256)
40 memcpy(fKernel, coeff, 9 * sizeof(int));
  /external/skia/legacy/include/effects/
SkKernel33MaskFilter.h 42 SkKernel33MaskFilter(const int coeff[3][3], int shift, int percent256 = 256)
44 memcpy(fKernel, coeff, 9 * sizeof(int));

Completed in 1936 milliseconds

1 2 3 4 5 6 7 8