[SciPy-dev] scipy / SGI MIPSpro compiler

Steve M. Robbins steven.robbins at videotron.ca
Fri Aug 23 16:09:32 EDT 2002


Hello,

I'm trying to build scipy on an IRIX 6.5 system using the
vendor compiler.  (That's what I built python with).

The compiler complained bitterly about signal/S_bspline_util.c because
there are function prototypes mixed with old-style function
declarations.  Here's a patch that changes them all to "new style" (I
forget the technical term) declarations.

Cheers,
-Steve



Index: signal/S_bspline_util.c
===================================================================
RCS file: /home/cvsroot/world/scipy/signal/S_bspline_util.c,v
retrieving revision 1.4
diff -u -b -B -r1.4 S_bspline_util.c
--- signal/S_bspline_util.c	30 Jun 2002 23:55:05 -0000	1.4
+++ signal/S_bspline_util.c	23 Aug 2002 20:11:36 -0000
@@ -28,12 +28,8 @@
 /* with a given starting value loaded into the array */
 
 void 
-S_IIR_order1 (a1, a2, x, y, N, stridex, stridey) 
-     float a1; 
-     float a2; 
-     float *x; 
-     float *y; 
-     int N, stridex, stridey; 
+S_IIR_order1 ( float a1, float a2, float *x, float *y, 
+	       int N, int stridex, int stridey )
 { 
     float *yvec = y+stridey; 
     float *xvec = x+stridex; 
@@ -51,13 +47,8 @@
 /* y[n] = a1 * x[n] + a2 * y[n-1]  + a3 * y[n-2] */
 /* with two starting values loaded into the array */
 void 
-S_IIR_order2 (a1, a2, a3, x, y, N, stridex, stridey) 
-     float a1; 
-     float a2; 
-     float a3; 
-     float *x; 
-     float *y; 
-     int N, stridex, stridey; 
+S_IIR_order2 ( float a1, float a2, float a3, float *x, float *y,
+	       int N, int stridex, int stridey )
 { 
     float *yvec = y+2*stridey; 
     float *xvec = x+2*stridex; 
@@ -86,14 +77,8 @@
 */
 
 void 
-S_IIR_order2_cascade (cs, z1, z2, y1_0, x, yp, N, stridex, stridey) 
-     float cs; 
-     float z1; 
-     float z2; 
-     float y1_0; 
-     float *x; 
-     float *yp; 
-     int N, stridex, stridey; 
+S_IIR_order2_cascade ( float cs, float z1, float z2, float y1_0, float *x,
+		       float *yp, int N, int stridex, int stridey)
 { 
     float *yvec = yp+stridey; 
     float *xvec = x+stridex; 
@@ -137,13 +122,8 @@
 */
 
 int 
-S_IIR_forback1 (c0, z1, x, y, N, stridex, stridey, precision)
-     float c0; 
-     float z1; 
-     float *x; 
-     float *y; 
-     int N, stridex, stridey; 
-     float precision; 
+S_IIR_forback1 ( float c0, float z1, float *x, float *y,
+		 int N, int stridex, int stridey, float precision )
 { 
     float *yp = NULL; 
     float *xptr = x;
@@ -189,12 +169,8 @@
 /* h must be odd length */
 /* strides in units of sizeof(float) bytes */
 void 
-S_FIR_mirror_symmetric (in, out, N, h, Nh, instride, outstride)
-     float *in;
-     float *out;
-     int N, Nh;
-     float *h;
-     int instride, outstride;
+S_FIR_mirror_symmetric ( float *in, float *out, int N, float *h, int Nh, 
+			 int instride, int outstride )
 {    
     int n, k;
     int Nhdiv2 = Nh >> 1;
@@ -254,14 +230,9 @@
 }
 
 int
-S_separable_2Dconvolve_mirror(in, out, M, N, hr, hc, Nhr, 
-				   Nhc, instrides, outstrides)
-     float *in;
-     float *out;
-     int M, N;
-     float *hr, *hc;
-     int Nhr, Nhc;
-     int *instrides, *outstrides;
+S_separable_2Dconvolve_mirror( float *in, float *out, int M, int N,
+			       float *hr, float *hc, int Nhr, int Nhc,
+			       int *instrides, int *outstrides )
 {
     int m, n;
     float *tmpmem;
@@ -305,10 +276,7 @@
 static float S_hs(int,float,double,double);
 
 float
-S_hc(k, cs, r, omega)
-     int k;
-     float cs;
-     double r, omega;
+S_hc( int k, float cs, double r, double omega )
 {
     if (k < 0) return 0.0;
     if (omega == 0.0) 
@@ -319,10 +287,7 @@
 }
 
 float
-S_hs(k, cs, rsq, omega)
-     int k;
-     float cs;
-     double rsq, omega;
+S_hs( int k, float cs, double rsq, double omega )
 {
     float cssq;
     float c0;
@@ -383,12 +348,8 @@
 */
 
 int 
-S_IIR_forback2 (r, omega, x, y, N, stridex, stridey, precision) 
-     double r,omega;
-     float *x;
-     float *y; 
-     int N, stridex, stridey; 
-     float precision; 
+S_IIR_forback2 ( double r, double omega, float *x, float *y,
+		 int N, int stridex, int stridey, float precision )
 { 
     float cs;
     float *yp = NULL; 
@@ -497,13 +458,8 @@
 */
 
 int 
-S_cubic_spline2D(image, coeffs, M, N, lambda, strides, cstrides, precision)
-     float *image;
-     float *coeffs;
-     int M, N;
-     double lambda;
-     int *strides, *cstrides; 
-     float precision;
+S_cubic_spline2D( float *image, float *coeffs, int M, int N, double lambda,
+		  int *strides, int *cstrides, float precision )
 {    
     double r, omega;
     float *inptr;
@@ -590,13 +546,9 @@
 */
 
 int 
-S_quadratic_spline2D(image, coeffs, M, N, lambda, strides, cstrides, precision)
-     float *image;
-     float *coeffs;
-     int M, N;
-     double lambda;
-     int *strides, *cstrides; 
-     float precision;
+S_quadratic_spline2D( float *image, float *coeffs, int M, int N,
+		      double lambda, int *strides, int *cstrides,
+		      float precision )
 {    
     double r;
     float *inptr;



More information about the SciPy-Dev mailing list