diff options
author | Mark Wiebe <mwiebe@enthought.com> | 2011-07-26 12:07:14 -0500 |
---|---|---|
committer | Mark Wiebe <mwiebe@enthought.com> | 2011-07-26 12:09:24 -0500 |
commit | affea42d886e8233fdd6f3c5760708e3a9e9b1b8 (patch) | |
tree | d99aa6da31a7a7fcff39c39a334fc2023d2f79b4 /numpy/numarray | |
parent | 694a3835a98e5f68dbbd416d3df81418fb16f28d (diff) | |
download | numpy-affea42d886e8233fdd6f3c5760708e3a9e9b1b8.tar.gz |
STY: Remove trailing whitespace
Diffstat (limited to 'numpy/numarray')
-rw-r--r-- | numpy/numarray/include/numpy/arraybase.h | 6 | ||||
-rw-r--r-- | numpy/numarray/include/numpy/cfunc.h | 6 | ||||
-rw-r--r-- | numpy/numarray/include/numpy/numcomplex.h | 8 | ||||
-rw-r--r-- | numpy/numarray/include/numpy/nummacro.h | 14 |
4 files changed, 17 insertions, 17 deletions
diff --git a/numpy/numarray/include/numpy/arraybase.h b/numpy/numarray/include/numpy/arraybase.h index a964979ce..32f9948f4 100644 --- a/numpy/numarray/include/numpy/arraybase.h +++ b/numpy/numarray/include/numpy/arraybase.h @@ -12,7 +12,7 @@ typedef npy_uint8 UInt8; typedef npy_int16 Int16; typedef npy_uint16 UInt16; typedef npy_int32 Int32; -typedef npy_uint32 UInt32; +typedef npy_uint32 UInt32; typedef npy_int64 Int64; typedef npy_uint64 UInt64; typedef npy_float32 Float32; @@ -65,7 +65,7 @@ typedef struct { Float64 r, i; } Complex64; #define PyArray(m) ((PyArrayObject *)(m)) #define PyArray_ISFORTRAN_CONTIGUOUS(m) (((PyArray(m))->flags & FORTRAN_CONTIGUOUS) != 0) -#define PyArray_ISWRITABLE PyArray_ISWRITEABLE +#define PyArray_ISWRITABLE PyArray_ISWRITEABLE -#endif +#endif diff --git a/numpy/numarray/include/numpy/cfunc.h b/numpy/numarray/include/numpy/cfunc.h index b581be08f..1739290ae 100644 --- a/numpy/numarray/include/numpy/cfunc.h +++ b/numpy/numarray/include/numpy/cfunc.h @@ -6,11 +6,11 @@ typedef int (*UFUNC)(long, long, long, void **, long*); /* typedef void (*CFUNC_2ARG)(long, void *, void *); */ /* typedef void (*CFUNC_3ARG)(long, void *, void *, void *); */ typedef int (*CFUNCfromPyValue)(PyObject *, void *); -typedef int (*CFUNC_STRIDE_CONV_FUNC)(long, long, maybelong *, +typedef int (*CFUNC_STRIDE_CONV_FUNC)(long, long, maybelong *, void *, long, maybelong*, void *, long, maybelong *); -typedef int (*CFUNC_STRIDED_FUNC)(PyObject *, long, PyArrayObject **, - char **data); +typedef int (*CFUNC_STRIDED_FUNC)(PyObject *, long, PyArrayObject **, + char **data); #define MAXARRAYS 16 diff --git a/numpy/numarray/include/numpy/numcomplex.h b/numpy/numarray/include/numpy/numcomplex.h index 9ed4198c7..7b4960e40 100644 --- a/numpy/numarray/include/numpy/numcomplex.h +++ b/numpy/numarray/include/numpy/numcomplex.h @@ -68,7 +68,7 @@ typedef struct { Float64 a, theta; } PolarComplex64; #define NUM_CLE(p, q) ((p).r <= (q).r) #define NUM_CGE(p, q) ((p).r >= (q).r) -/* e**z = e**x * (cos(y)+ i*sin(y)) where z = x + i*y +/* e**z = e**x * (cos(y)+ i*sin(y)) where z = x + i*y so e**z = e**x * cos(y) + i * e**x * sin(y) */ #define NUM_CEXP(p, s) \ @@ -79,7 +79,7 @@ typedef struct { Float64 a, theta; } PolarComplex64; /* e**w = z; w = u + i*v; z = r * e**(i*theta); -e**u * e**(i*v) = r * e**(i*theta); +e**u * e**(i*v) = r * e**(i*theta); log(z) = w; log(z) = log(r) + i*theta; */ @@ -110,7 +110,7 @@ log(z) = w; log(z) = log(r) + i*theta; NUM_CEXP(s, s); \ } \ } - + #define NUM_CSQRT(p, s) { Complex64 temp; temp.r = 0.5; temp.i=0; \ NUM_CPOW(p, temp, s); \ } @@ -201,7 +201,7 @@ log(z) = w; log(z) = log(r) + i*theta; NUM_CIMUL(s, s); \ NUM_CRMUL(s, 0.5, s); \ } - + /* asinh(z) = log( z + (z**2 + 1)**0.5 ) */ #define NUM_CASINH(p, s) { Complex64 p1; NUM_CASS(p, p1); \ NUM_CMUL(p, p, s); \ diff --git a/numpy/numarray/include/numpy/nummacro.h b/numpy/numarray/include/numpy/nummacro.h index 6eb98ddd0..0f87dfb84 100644 --- a/numpy/numarray/include/numpy/nummacro.h +++ b/numpy/numarray/include/numpy/nummacro.h @@ -6,7 +6,7 @@ /* The structs defined here are private implementation details of numarray which are subject to change w/o notice. */ - + #define PY_BOOL_CHAR "b" #define PY_INT8_CHAR "b" #define PY_INT16_CHAR "h" @@ -44,7 +44,7 @@ typedef enum #define UNCONVERTED 0 #define C_ARRAY (NUM_CONTIGUOUS | NUM_NOTSWAPPED | NUM_ALIGNED) -#define MUST_BE_COMPUTED 2 +#define MUST_BE_COMPUTED 2 #define NUM_FLOORDIVIDE(a,b,out) (out) = floor((a)/(b)) @@ -334,7 +334,7 @@ _makeSetPa(Bool) out[i] = NA_GETPb(ai, type, base); \ base += stride; \ } \ - } + } #define NA_GET1Da(ai, type, base, cnt, out) \ { int i, stride = PyArray_STRIDES(ai)[PyArray_NDIM(ai)-1]; \ @@ -342,7 +342,7 @@ _makeSetPa(Bool) out[i] = NA_GETPa(ai, type, base); \ base += stride; \ } \ - } + } #define NA_GET1Df(ai, type, base, cnt, out) \ { int i, stride = PyArray_STRIDES(ai)[PyArray_NDIM(ai)-1]; \ @@ -350,7 +350,7 @@ _makeSetPa(Bool) out[i] = NA_GETPf(ai, type, base); \ base += stride; \ } \ - } + } #define NA_GET1D(ai, type, base, cnt, out) \ if (PyArray_ISCARRAY(ai)) { \ @@ -360,7 +360,7 @@ _makeSetPa(Bool) } else { \ NA_GET1Da(ai, type, base, cnt, out); \ } - + #define NA_SET1Db(ai, type, base, cnt, in) \ { int i, stride = PyArray_STRIDES(ai)[PyArray_NDIM(ai)-1]; \ for(i=0; i<cnt; i++) { \ @@ -393,7 +393,7 @@ _makeSetPa(Bool) } else { \ NA_SET1Da(ai, type, base, cnt, out); \ } - + /* ========================== utilities ================================== */ #if !defined(MIN) |