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

1 2 3

  /external/srec/srec/include/
fft.h 2 * fft.h *
29 /* These are the data objects associated with the FFT and IFFT
36 int fft_perform_and_magsq(fft_info *fft);
37 void do_magsq(fft_info *fft);
39 void configure_fft(fft_info *fft, int size);
40 int place_sample_data(fft_info *fft, fftdata *seq, fftdata *smooth, int num);
41 void unconfigure_fft(fft_info *fft);
  /external/eigen/unsupported/test/
FFTW.cpp 11 #include <unsupported/Eigen/FFT>
83 typedef typename FFT<T>::Complex Complex;
84 typedef typename FFT<T>::Scalar Scalar;
88 FFT<T> fft; local
96 fft.SetFlag(fft.HalfSpectrum );
97 fft.fwd( freqBuf,tbuf);
101 fft.ClearFlag(fft.HalfSpectrum )
149 FFT<T> fft; local
220 FFT<float> fft; local
    [all...]
  /external/eigen/bench/
benchFFT.cpp 17 #include <unsupported/Eigen/FFT>
51 FFT< Scalar > fft; local
54 fft.SetFlag(fft.Unscaled);
58 fft.SetFlag(fft.HalfSpectrum);
64 fft.fwd( outbuf , inbuf);
72 fft.fwd( outbuf , inbuf);
75 fft.inv(inbuf,outbuf)
    [all...]
  /external/webrtc/src/modules/audio_processing/aecm/
aecm_core_neon.c 37 static void WindowAndFFTNeon(WebRtc_Word16* fft,
52 // fft[j] = (WebRtc_Word16)WEBRTC_SPL_MUL_16_16_RSFT((time_signal[i]
61 __asm__("vst2.16 {d20, d21}, [%0, :128]" : : "r"(&fft[j]) : "q10");
63 // fft[PART_LEN2 + j] = (WebRtc_Word16)WEBRTC_SPL_MUL_16_16_RSFT(
73 __asm__("vst2.16 {d20, d21}, [%0, :128]" : : "r"(&fft[PART_LEN2 + j]) : "q10");
76 WebRtcSpl_ComplexBitReverse(fft, PART_LEN_SHIFT);
77 WebRtcSpl_ComplexFFT(fft, PART_LEN_SHIFT, 1);
81 __asm__("vld2.16 {d20, d21, d22, d23}, [%0, :256]" : : "r"(&fft[j]) : "q10", "q11");
90 WebRtc_Word16* fft,
99 // We overwrite two more elements in fft[], but it's ok
    [all...]
aecm_core.c 361 static void WindowAndFFTC(WebRtc_Word16* fft,
368 memset(fft, 0, sizeof(WebRtc_Word16) * PART_LEN4);
369 // FFT of signal
373 // transformation array |fft|
374 fft[j] = (WebRtc_Word16)WEBRTC_SPL_MUL_16_16_RSFT(
378 fft[PART_LEN2 + j] = (WebRtc_Word16)WEBRTC_SPL_MUL_16_16_RSFT(
386 WebRtcSpl_ComplexBitReverse(fft, PART_LEN_SHIFT);
387 WebRtcSpl_ComplexFFT(fft, PART_LEN_SHIFT, 1);
392 freq_signal[i].real = fft[j];
395 freq_signal[i].imag = - fft[j+1]
1394 WebRtc_Word16 *fft = (WebRtc_Word16 *) (((uintptr_t) fft_buf + 31) & ~31); local
1532 WebRtc_Word16* fft = (WebRtc_Word16*) (((uintptr_t) fft_buf + 31) & ~ 31); local
    [all...]
aecm_core.h 11 // Performs echo control (suppression) with fft routines in fixed-point
38 #define PART_LEN1 (PART_LEN + 1) // Unique fft coefficients
358 WebRtc_Word16* fft,
366 WebRtc_Word16* fft, complex16_t* efw,
  /external/srec/srec/cfront/
spec_anl.c 79 ** The "NEW" fft performs shifting operations in fixed point, to maximise
83 channel->shift += place_sample_data(&freqobj->fft, channel->prebuff,
89 write_scaled_frames(freqobj->fft.size, 1, freqobj->fft.real, D_FIXED, (float)(0x01 << channel->shift));
90 write_scaled_frames(freqobj->fft.size, 1, freqobj->fft.imag, D_FIXED, (float)(0x01 << channel->shift));
94 write_scaled_frames(freqobj->fft.size, 1, freqobj->fft.real, D_FIXED, (float)1 / (0x01 << -channel->shift));
95 write_scaled_frames(freqobj->fft.size, 1, freqobj->fft.imag, D_FIXED, (float)1 / (0x01 << -channel->shift))
    [all...]
sp_fft.c 27 ** DESCRIPTION: Split-Radix FFT
140 /* cannot do smaller than 4 point FFT */
356 Compute a four point FFT that requires no multiplications
404 Compute a two point FFT that requires no multiplications
596 /* do a complex FFT of half size using the even indexed data
655 ** FFT will grow data log2Length. In order to avoid data overflow,
682 /* compute the real input fft, the real valued first and last component of
688 /* After fft, we now have the data,
692 ** to get fft data, we then need to reverse-shift the fixed data by the
706 ** = fftdata magnitude/FFT lengt
    [all...]
  /external/aac/libFDK/src/
FDK_hybrid.cpp 94 #include "fft.h"
502 FIXP_DBL fft[8]; local
524 /* write to fft coefficient n' */
525 fft[FFT_IDX_R(0)] = ( fMult(p[10], ( fMultSub(fMultDiv2(cr[ 2], pQmfReal[pReadIdx[ 2]]), ci[ 2], pQmfImag[pReadIdx[ 2]]))) +
528 fft[FFT_IDX_I(0)] = ( fMult(p[10], ( fMultAdd(fMultDiv2(ci[ 2], pQmfReal[pReadIdx[ 2]]), cr[ 2], pQmfImag[pReadIdx[ 2]]))) +
533 fft[FFT_IDX_R(1)] = ( fMult(p[ 9], ( fMultSub(fMultDiv2(cr[ 3], pQmfReal[pReadIdx[ 3]]), ci[ 3], pQmfImag[pReadIdx[ 3]]))) +
536 fft[FFT_IDX_I(1)] = ( fMult(p[ 9], ( fMultAdd(fMultDiv2(ci[ 3], pQmfReal[pReadIdx[ 3]]), cr[ 3], pQmfImag[pReadIdx[ 3]]))) +
541 fft[FFT_IDX_R(2)] = ( fMult(p[12], ( fMultSub(fMultDiv2(cr[ 0], pQmfReal[pReadIdx[ 0]]), ci[ 0], pQmfImag[pReadIdx[ 0]]))) +
545 fft[FFT_IDX_I(2)] = ( fMult(p[12], ( fMultAdd(fMultDiv2(ci[ 0], pQmfReal[pReadIdx[ 0]]), cr[ 0], pQmfImag[pReadIdx[ 0]]))) +
550 fft[FFT_IDX_R(3)] = ( fMult(p[11], ( fMultSub(fMultDiv2(cr[ 1], pQmfReal[pReadIdx[ 1]]), ci[ 1], pQmf (…)
    [all...]
dct.cpp 92 By default implementations which are based on a single, standard complex FFT-kernel are used (dctII_f() and dctIII_f()).
93 These are specifically helpful in cases where optimized FFT libraries are already available. The FFT used in these
94 implementation is FFT rad2 from FDK_tools.
97 type IV implementations are only available in a version based on a complex FFT kernel.
104 #include "fft.h"
164 fft(M, tmp, pDat_e);
227 fft(M, tmp, pDat_e);
355 fft(M, pDat, pDat_e);
481 fft(M, pDat, pDat_e)
    [all...]
  /external/webrtc/src/modules/audio_processing/aec/
aec_core.c 287 //static void FilterAdaptationUnconstrained(aec_t *aec, float *fft,
311 static void FilterAdaptation(aec_t *aec, float *fft, float ef[2][PART_LEN1]) {
325 fft[2 * j] = MulRe(aec->xfBuf[0][xPos + j],
328 fft[2 * j + 1] = MulIm(aec->xfBuf[0][xPos + j],
332 fft[1] = MulRe(aec->xfBuf[0][xPos + PART_LEN],
336 aec_rdft_inverse_128(fft);
337 memset(fft + PART_LEN, 0, sizeof(float) * PART_LEN);
339 // fft scaling
343 fft[j] *= scale;
346 aec_rdft_forward_128(fft);
545 float fft[PART_LEN2]; local
639 float fft[PART_LEN2]; local
856 float fft[PART_LEN2]; local
    [all...]
aec_core_sse2.c 131 static void FilterAdaptationSSE2(aec_t *aec, float *fft, float ef[2][PART_LEN1]) {
161 _mm_storeu_ps(&fft[2*j + 0], g);
162 _mm_storeu_ps(&fft[2*j + 4], h);
165 fft[1] = MulRe(aec->xfBuf[0][xPos + PART_LEN],
169 aec_rdft_inverse_128(fft);
170 memset(fft + PART_LEN, 0, sizeof(float)*PART_LEN);
172 // fft scaling
177 const __m128 fft_ps = _mm_loadu_ps(&fft[j]);
179 _mm_storeu_ps(&fft[j], fft_scale);
182 aec_rdft_forward_128(fft);
    [all...]
aec_core.h 25 #define PART_LEN1 (PART_LEN + 1) // Unique fft coefficients
92 float xfBuf[2][NR_PART * PART_LEN1]; // farend fft buffer
93 float wfBuf[2][NR_PART * PART_LEN1]; // filter fft
96 complex_t xfwBuf[NR_PART * PART_LEN1]; // farend windowed fft buffer
161 (aec_t *aec, float *fft, float ef[2][PART_LEN1]);
  /cts/suite/audio_quality/test_description/processing/
calc_thd.py 19 import scipy.fftpack as fft namespace
25 fftData = abs(fft.fft(data * np.hanning(len(data))))
gen_random.py 20 import scipy.fftpack as fft namespace
34 fftData = fft.rfft(randomSignal)
47 filteredData = fft.irfft(fftData)
49 #plt.plot(freq, abs(fft.fft(filteredData)))
  /frameworks/av/include/media/
Visualizer.h 36 * - Frequency data: 8-bit magnitude FFT by using the getFft() method
39 * getCaptureSize() and setCaptureSize() methods. Note that the size of the FFT
84 // callback used to return periodic PCM or FFT captures to the application. Either one or both
85 // types of data are returned (PCM and FFT) according to flags indicated when installing the
92 uint8_t *fft,
129 // return a capture in FFT 8 bit signed format. The size of the capture is equal to
130 // getCaptureSize() but the length of the FFT is half of the size (both parts of the spectrum
132 status_t getFft(uint8_t *fft);
158 status_t doFft(uint8_t *fft, uint8_t *waveform);
  /frameworks/base/media/java/android/media/audiofx/
Visualizer.java 43 * <li>Frequency data: 8-bit magnitude FFT by using the {@link #getFft(byte[])} method</li>
97 * captured data. A low playback volume will lead to low sample and fft values, and vice-versa.
178 * PCM and FFT capture listener registered by client
444 * <p>The capture is an 8-bit magnitude FFT, the frequency range covered being 0 (DC) to half of
479 * @param fft array of bytes where the FFT should be returned
485 public int getFft(byte[] fft)
491 return native_getFft(fft);
558 * <p>Data in the fft buffer is valid only within the scope of the callback.
559 * Applications which needs access to the fft data after returning from the callbac
    [all...]
  /frameworks/av/media/libmedia/
Visualizer.cpp 281 status_t Visualizer::getFft(uint8_t *fft)
283 if (fft == NULL) {
295 status = doFft(fft, buf);
298 memset(fft, 0, mCaptureSize);
303 status_t Visualizer::doFft(uint8_t *fft, uint8_t *waveform)
321 fft[i] = tmp;
325 fft[i + 1] = tmp;
344 uint8_t fft[mCaptureSize]; local
346 status = doFft(fft, waveform);
360 fftPtr = fft;
    [all...]
  /external/aac/libSBRdec/src/
psdec_hybrid.cpp 87 #include "fft.h"
213 Implementation using a FFT of length 8
242 Try to split off FFT Modulation Term:
243 FFT(x[t], q) = sum(x[t+k]*exp(-j*2*pi/N *q * k))
255 n m *exp(-j*2*pi) | n' fft
272 now use fft modulation coefficients
273 m[6] = = fft[0]
274 m[7] = = fft[1]
275 m[8] = m[ 0] = fft[2]
276 m[9] = m[ 1] = fft[3
383 FIXP_DBL *fft = (FIXP_DBL *)ALIGN_PTR(_fft); local
    [all...]
  /frameworks/base/media/tests/EffectsTest/src/com/android/effectstest/
VisualizerTest.java 158 public void onFftDataCapture(Visualizer visualizer, byte[] fft, int samplingRate) {
160 if (fft.length > 0) {
161 Log.d(TAG, "onFftDataCapture(): "+fft[0]);
162 displayVal(R.id.fftMin, fft[0]);
163 displayVal(R.id.fftMax, fft[fft.length - 1]);
164 displayVal(R.id.fftCenter, fft[fft.length/2]);
  /external/libvorbis/lib/
psytune.c 329 float *fft=work[i]; local
335 /* fft and mdct transforms */
337 fft[j]=pcm[i][j]*=window[j];
339 drft_forward(&f_look,fft);
342 fft[0]*=scale;
343 fft[0]=todB(fft);
345 float temp=scale*FAST_HYPOT(fft[j],fft[j+1]);
346 temp=fft[(j+1)>>1]=todB(&temp)
361 float *fft=work[i]; local
    [all...]
  /external/eigen/unsupported/doc/examples/
FFT.cpp 1 // To use the simple FFT implementation
2 // g++ -o demofft -I.. -Wall -O3 FFT.cpp
5 // g++ -o demofft -I.. -DUSE_FFTW -Wall -O3 FFT.cpp -lfftw3 -lfftw3f -lfftw3l
17 #include <unsupported/Eigen/FFT>
82 static FFT<Scalar> fft; local
83 fft.fwd(freqbuf,timebuf);
86 fft.inv(timebuf2,freqbuf);
  /external/webrtc/src/modules/audio_coding/codecs/isac/main/source/
Android.mk 30 fft.c \
  /external/speex/libspeex/
fftwrap.c 104 speex_warning("FFT should not be done in-place");
120 speex_warning("FFT should not be done in-place");
175 fftwf_plan fft; member in struct:fftw_config
186 table->fft = fftwf_plan_dft_r2c_1d(size, table->in, (fftwf_complex *) table->out, FFTW_PATIENT);
196 fftwf_destroy_plan(t->fft);
215 fftwf_execute(t->fft);
306 #error No other FFT implemented
  /cts/tests/tests/media/src/android/media/cts/
VisualizerTest.java 194 assertNotNull("FFT capture failed", mFft);
296 Visualizer visualizer, byte[] fft, int samplingRate) {
301 mFft = fft;

Completed in 600 milliseconds

1 2 3