Searched defs:imag (Results 1 - 25 of 28) sorted by relevance

12

/external/chromium_org/third_party/openmax_dl/dl/sp/src/x86/
H A DomxSP_FFTInit_R_F32.c58 OMX_F32 imag; local
84 // imag data are stored into first and last halves of the buffer separately
90 imag = armSP_FFT_F32TwiddleTable[j + 1];
93 pTwiddle[i + N] = -imag;
95 pTwiddle[NBy4 - i] = imag;
98 pTwiddle[NBy4 + i] = -imag;
102 pTwiddle[NBy2 - i + N] = -imag;
105 pTwiddle[NBy2 + i + N] = imag;
107 pTwiddle[NBy4 * 3 - i] = -imag;
110 pTwiddle[NBy4 * 3 + i] = imag;
[all...]
H A Dx86SP_SSE_Math.h31 * in real and corresponding imaginary parts in imag.
35 __m128 imag; member in struct:VComplex
41 _mm_mul_ps(a->imag, b->imag));
42 out->imag = _mm_add_ps(_mm_mul_ps(a->real, b->imag),
43 _mm_mul_ps(a->imag, b->real));
49 _mm_mul_ps(a->imag, b->imag));
50 out->imag
[all...]
/external/compiler-rt/lib/builtins/ppc/
H A Ddivtc3.c46 DD imag = { .ld = __gcc_qdiv(imagNumerator, denom) }; local
50 imag.s.hi = crt_scalbn(imag.s.hi, -ilogbw);
51 imag.s.lo = crt_scalbn(imag.s.lo, -ilogbw);
53 if (crt_isnan(real.s.hi) && crt_isnan(imag.s.hi))
64 imag.s.hi = crt_copysign(CRT_INFINITY,cDD.s.hi) * bDD.s.hi;
65 imag.s.lo = 0.0;
75 imag.s.hi = CRT_INFINITY * (bDD.s.hi*cDD.s.hi - aDD.s.hi*dDD.s.hi);
76 imag
[all...]
H A Dmultc3.c33 DD imag = { .ld = __gcc_qadd(ad,bc) }; local
35 if (crt_isnan(real.s.hi) && crt_isnan(imag.s.hi))
84 imag.s.hi = CRT_INFINITY * (aDD.s.hi*dDD.s.hi + bDD.s.hi*cDD.s.hi);
85 imag.s.lo = 0.0;
91 __imag__ z = imag.ld;
/external/eigen/Eigen/src/plugins/
H A DCommonCwiseUnaryOps.h34 /** \internal the return type of imag() const */
36 /** \internal the return type of imag() */
108 * \sa imag() */
116 imag() const { return derived(); } function
164 * \sa imag() */
172 imag() { return derived(); } function
/external/chromium_org/third_party/WebKit/Source/platform/audio/android/
H A DFFTFrameOpenMAXDLAndroid.cpp119 float* imag = m_imagData.data(); local
123 imag[k] = c[index + 1];
126 imag[0] = c[m_FFTSize];
142 const float* imag = m_imagData.data(); local
146 fftData[index + 1] = imag[k];
150 fftData[m_FFTSize] = imag[0];
/external/chromium_org/third_party/WebKit/Source/platform/audio/ffmpeg/
H A DFFTFrameFFMPEG.cpp123 float* imag = m_imagData.data(); local
129 imag[i] = p[baseComplexIndex + 1];
164 const float* imag = m_imagData.data(); local
169 c[baseComplexIndex + 1] = imag[i];
/external/srec/srec/include/
H A Dsp_fft.h221 fftdata *imag; member in struct:__anon30267
/external/ceres-solver/internal/ceres/
H A Dpolynomial_test.cc66 // p(x) = poly(x) * (x - real - imag*i) * (x - real + imag*i).
67 Vector AddComplexRootPair(const Vector& poly, double real, double imag) { argument
70 // Multiply poly by x^2 - 2real + abs(real,imag)^2
73 poly2.tail(poly.size()) += (real*real + imag*imag) * poly;
123 Vector imag; local
124 bool success = FindPolynomialRoots(poly, &real, &imag);
132 Vector imag; local
133 bool success = FindPolynomialRoots(poly, &real, &imag);
172 Vector imag; local
[all...]
/external/eigen/test/
H A Dexceptions.cpp73 ScalarWithExceptions imag(const ScalarWithExceptions & ) { return 0; } function
/external/stlport/stlport/stl/
H A D_complex.h70 value_type imag() const { return _M_im; } function in struct:complex
196 value_type imag() const { return _M_im; } function in struct:complex
335 value_type imag() const { return _M_im; } function in struct:complex
473 value_type imag() const { return _M_im; } function in struct:complex
731 inline _Tp _STLP_CALL imag(const complex<_Tp>& __z) function
770 { return _Tp(abs(complex<double>(double(__z.real()), double(__z.imag())))); }
774 { return _Tp(arg(complex<double>(double(__z.real()), double(__z.imag())))); }
779 return complex<_Tp>(_Tp(__tmp.real()), _Tp(__tmp.imag()));
/external/chromium_org/third_party/WebKit/Source/modules/webaudio/
H A DPeriodicWave.cpp48 PassRefPtrWillBeRawPtr<PeriodicWave> PeriodicWave::create(float sampleRate, Float32Array* real, Float32Array* imag) argument
50 bool isGood = real && imag && real->length() == imag->length();
55 periodicWave->createBandLimitedTables(real->data(), imag->data(), numberOfComponents);
228 AudioFloatArray imag(halfSize);
230 float* imagP = imag.data();
H A DAudioContext.cpp523 PassRefPtrWillBeRawPtr<PeriodicWave> AudioContext::createPeriodicWave(Float32Array* real, Float32Array* imag, ExceptionState& exceptionState) argument
534 if (!imag) {
541 if (real->length() != imag->length()) {
545 + ") and length of imaginary array (" + String::number(imag->length())
558 if (imag->length() > 4096) {
561 "length of imaginary array (" + String::number(imag->length())
566 return PeriodicWave::create(sampleRate(), real, imag);
/external/aac/libFDK/src/arm/
H A Dqmf_arm.cpp478 FIXP_DBL A, B, real, imag, sta0; local
481 imag = *--imagSlot;
485 *sta++ = SMLAWT( sta[1], imag, B ); /* index=9...........319 */
487 *sta++ = SMLAWB( sta[1], imag, B ); /* index=8,18, ...318 */
491 *sta++ = SMLAWT( sta[1], imag, B ); /* index=7...........317 */
493 *sta++ = SMLAWB( sta[1], imag, B ); /* index=6...........316 */
497 *sta++ = SMULWT( imag, B ); /* index=5,15, ... 315 */
503 imag = *--imagSlot;
507 *sta++ = SMLAWB( sta[1], imag, B ); /* index=14..........324 */
512 *sta++ = SMLAWT( sta[1], imag,
562 FIXP_DBL A, B, real, imag; local
[all...]
/external/chromium_org/third_party/webrtc/modules/audio_processing/aecm/
H A Daecm_core.h31 int16_t imag; member in struct:__anon15189
/external/chromium_org/third_party/webrtc/modules/audio_processing/ns/
H A Dnsx_core.h104 int16_t imag[ANAL_BLOCKL_MAX]; member in struct:NsxInst_t_
H A Dnsx_core_mips.c767 int16_t *imag = inst->imag; local
780 "lh %[tmp_3], 0(%[imag]) \n\t"
786 "sh %[tmp_3], 0(%[imag]) \n\t"
791 "addiu %[imag], %[imag], 2 \n\t"
797 "lh %[tmp_3], 0(%[imag]) \n\t"
800 "lh %[tmp_6], 2(%[imag]) \n\t"
813 "sh %[tmp_3], 0(%[imag]) \n\t"
818 "sh %[tmp_6], 2(%[imag]) \
[all...]
H A Dns_core.c742 float real[ANAL_BLOCKL_MAX], imag[HALF_ANAL_BLOCKL]; local
845 imag[0] = 0;
848 imag[inst->magnLen - 1] = 0;
866 imag[i] = winData[2 * i + 1];
869 fTmp += imag[i] * imag[i];
1122 imag[i] *= inst->smooth[i];
1134 winData[2 * i + 1] = imag[i];
/external/eigen/Eigen/src/Core/
H A DMathFunctions.h92 * Implementation of imag *
111 using std::imag;
112 return imag(x);
236 return real(x)*real(x) + imag(x)*imag(x);
257 return abs(real(x)) + abs(imag(x));
527 random(imag(x), imag(y)));
575 inline EIGEN_MATHFUNC_RETVAL(imag, Scalar) imag(cons function in namespace:Eigen::numext
[all...]
/external/eigen/unsupported/Eigen/src/AutoDiff/
H A DAutoDiffScalar.h51 * - internal::conj, internal::real, internal::imag, numext::abs2.
537 inline typename DerType::Scalar imag(const AutoDiffScalar<DerType>&) { return 0.; } function in namespace:Eigen
/external/webrtc/src/modules/audio_processing/ns/
H A Dnsx_core.h97 WebRtc_Word16 imag[ANAL_BLOCKL_MAX]; member in struct:NsxInst_t_
/external/aac/libFDK/src/
H A Dqmf.cpp179 FIXP_QMF *RESTRICT imagSlot, /*!< Input: Pointer to imag Slot */
199 FIXP_QMF imag = imagSlot[j]; // no_channels-1 .. 0 local
220 sta[0] = sta[1] + FX_DBL2FX_QSS(fMultDiv2( p_flt [4] , imag ));
222 sta[2] = sta[3] + FX_DBL2FX_QSS(fMultDiv2( p_flt [3] , imag ));
224 sta[4] = sta[5] + FX_DBL2FX_QSS(fMultDiv2( p_flt [2] , imag ));
226 sta[6] = sta[7] + FX_DBL2FX_QSS(fMultDiv2( p_flt [1] , imag ));
228 sta[8] = FX_DBL2FX_QSS(fMultDiv2( p_flt [0] , imag ));
247 FIXP_QMF *RESTRICT imagSlot, /*!< Input: Pointer to imag Slot */
268 FIXP_QMF imag = imagSlot[j]; // no_channels-1 .. 0 local
285 sta[0] = sta[1] + FX_DBL2FX_QSS(fMultDiv2( p_flt [4] , imag ));
[all...]
/external/srec/srec/cfront/
H A Dsp_fft.c94 fftdata* real, fftdata* imag)
104 *imag = himul32(a, d) + himul32(b, c);
829 fft->imag = fft->real + size / 2 + 1;
92 complex_multiplier(trigonomydata a, trigonomydata b, fftdata c, fftdata d, fftdata* real, fftdata* imag) argument
/external/clang/lib/CodeGen/
H A DCGCleanup.cpp86 llvm::Value *imag = local
88 return RValue::getComplex(real, imag);
/external/webrtc/src/modules/audio_processing/aecm/
H A Daecm_core.h104 WebRtc_Word16 imag; member in struct:__anon32599

Completed in 1086 milliseconds

12