[Scipy-svn] r4372 - branches/refactor_fft/scipy/fftpack/fftpack/src

scipy-svn at scipy.org scipy-svn at scipy.org
Fri May 16 04:32:30 EDT 2008


Author: cdavid
Date: 2008-05-16 03:32:20 -0500 (Fri, 16 May 2008)
New Revision: 4372

Removed:
   branches/refactor_fft/scipy/fftpack/fftpack/src/convolve.cxx
   branches/refactor_fft/scipy/fftpack/fftpack/src/fftpack.cxx
Log:
Remove dead code.

Deleted: branches/refactor_fft/scipy/fftpack/fftpack/src/convolve.cxx
===================================================================
--- branches/refactor_fft/scipy/fftpack/fftpack/src/convolve.cxx	2008-05-16 08:30:14 UTC (rev 4371)
+++ branches/refactor_fft/scipy/fftpack/fftpack/src/convolve.cxx	2008-05-16 08:32:20 UTC (rev 4372)
@@ -1,54 +0,0 @@
-/*
-  Generic functions for computing 1D convolutions of periodic sequences.
-
-  Supported FFT libraries:
-    DJBFFT  - optional, used for power-of-two length arrays
-    FFTW    - optional
-    FFTPACK - used if any of the above libraries is not available
-
-  Author: Pearu Peterson, September 2002
- */
-
-#include "fftpack.h"
-
-#define GEN_CONVOLVE_API(name) \
-extern "C" void convolve(int n,double* inout,double* omega,int swap_real_imag)  \
-{\
-        convolve_##name(n, inout, omega, swap_real_imag);\
-}\
-extern "C" void convolve_z(int n,double* inout,double* omega_real,double* omega_imag)  \
-{\
-        convolve_z_##name(n, inout, omega_real, omega_imag);\
-}\
-extern "C" void init_convolution_kernel(int n,double* omega, int d, \
-			     double (*kernel_func)(int), \
-			     int zero_nyquist) \
-{\
-        init_convolution_kernel_##name(n,omega, d, kernel_func, zero_nyquist);\
-} \
-extern "C" void destroy_convolve_cache(void)  \
-{\
-}
-
-/**************** FFTW *****************************/
-#ifdef WITH_FFTW
-
-#include "fftw/api.h"
-#ifndef WITH_DJBFFT
-        GEN_CONVOLVE_API(fftw)
-#endif
-
-#else
-/**************** FFTPACK ZFFT **********************/
-#include "fftpack/api.h"
-
-#ifndef WITH_DJBFFT
-        GEN_CONVOLVE_API(fftpack)
-#endif
-
-#endif
-
-#ifdef WITH_DJBFFT
-	#include "djbfft/api.h"
-        GEN_CONVOLVE_API(djbfft)
-#endif

Deleted: branches/refactor_fft/scipy/fftpack/fftpack/src/fftpack.cxx
===================================================================
--- branches/refactor_fft/scipy/fftpack/fftpack/src/fftpack.cxx	2008-05-16 08:30:14 UTC (rev 4371)
+++ branches/refactor_fft/scipy/fftpack/fftpack/src/fftpack.cxx	2008-05-16 08:32:20 UTC (rev 4372)
@@ -1,72 +0,0 @@
-#include "fftpack.h"
-
-/* The following macro convert private backend specific function to the public
- * functions exported by the module  */
-#define GEN_ZFFT_API(name) \
-extern "C" void zfft(complex_double *inout, int n, \
-        int direction, int howmany, int normalize)\
-{\
-        zfft_##name(inout, n, direction, howmany, normalize);\
-}
-
-#define GEN_DRFFT_API(name) \
-extern "C" void drfft(double *inout, int n, \
-        int direction, int howmany, int normalize)\
-{\
-        drfft_##name(inout, n, direction, howmany, normalize);\
-}
-
-#define GEN_ZFFTND_API(name) \
-extern "C" void zfftnd(complex_double * inout, int rank,\
-		           int *dims, int direction, int howmany, int normalize)\
-{\
-        zfftnd_##name(inout, rank, dims, direction, howmany, normalize);\
-}
-
-
-/*
- * Each backend define public functions in the backend specific api.h file, and
- * depending on the options, we set the function called by the python extension
- * to a backend specific one.
- */
-
-#ifdef WITH_FFTW3
-    #include "fftw3/api.h"
-    #ifndef WITH_DJBFFT
-        GEN_ZFFT_API(fftw3)
-        GEN_DRFFT_API(fftw3)
-        GEN_ZFFTND_API(fftw3)
-    #endif
-#elif defined WITH_FFTW
-    #include "fftw/api.h"
-    #ifndef WITH_DJBFFT
-        GEN_ZFFT_API(fftw)
-        GEN_DRFFT_API(fftw)
-        GEN_ZFFTND_API(fftw)
-    #endif
-#elif defined WITH_MKL
-    #include "mkl/api.h"
-    #ifndef WITH_DJBFFT
-        GEN_ZFFT_API(mkl)
-        GEN_ZFFTND_API(mkl)
-    #endif
-    GEN_DRFFT_API(fftpack)
-#endif
-
-#if (!defined WITH_DJBFFT) && (!defined WITH_MKL) \
-        && (!defined WITH_FFTW) && (!defined WITH_FFTW3)
-GEN_ZFFT_API(fftpack)
-GEN_DRFFT_API(fftpack)
-GEN_ZFFTND_API(fftpack)
-#endif 
-
-/* 
- * djbfft must be used at the end, because it needs another backend (defined
- * above) for non 2^n * size 
- */
-#ifdef WITH_DJBFFT
-    #include "djbfft/api.h"
-    GEN_DRFFT_API(djbfft)
-    GEN_ZFFT_API(djbfft)
-    GEN_ZFFTND_API(fftpack)
-#endif




More information about the Scipy-svn mailing list