[Scipy-svn] r2160 - in trunk/Lib: fftpack/dfftpack fftpack/fftpack integrate/odepack interpolate/fitpack sandbox/odr/odrpack special/cdflib
scipy-svn at scipy.org
scipy-svn at scipy.org
Mon Aug 14 00:23:06 EDT 2006
Author: cookedm
Date: 2006-08-13 23:22:28 -0500 (Sun, 13 Aug 2006)
New Revision: 2160
Modified:
trunk/Lib/fftpack/dfftpack/dcosqb.f
trunk/Lib/fftpack/dfftpack/dcosqf.f
trunk/Lib/fftpack/dfftpack/dcost.f
trunk/Lib/fftpack/dfftpack/dfftb1.f
trunk/Lib/fftpack/dfftpack/dfftf1.f
trunk/Lib/fftpack/dfftpack/dffti1.f
trunk/Lib/fftpack/dfftpack/dsint1.f
trunk/Lib/fftpack/dfftpack/zffti1.f
trunk/Lib/fftpack/fftpack/cffti1.f
trunk/Lib/fftpack/fftpack/cosqb.f
trunk/Lib/fftpack/fftpack/cosqf.f
trunk/Lib/fftpack/fftpack/cost.f
trunk/Lib/fftpack/fftpack/rfftb1.f
trunk/Lib/fftpack/fftpack/rfftf1.f
trunk/Lib/fftpack/fftpack/rffti1.f
trunk/Lib/fftpack/fftpack/sint1.f
trunk/Lib/integrate/odepack/cntnzu.f
trunk/Lib/integrate/odepack/lsodes.f
trunk/Lib/integrate/odepack/lsodi.f
trunk/Lib/integrate/odepack/lsoibt.f
trunk/Lib/integrate/odepack/mdi.f
trunk/Lib/integrate/odepack/mdu.f
trunk/Lib/integrate/odepack/nsfc.f
trunk/Lib/interpolate/fitpack/bispev.f
trunk/Lib/interpolate/fitpack/clocur.f
trunk/Lib/interpolate/fitpack/cocosp.f
trunk/Lib/interpolate/fitpack/concur.f
trunk/Lib/interpolate/fitpack/curev.f
trunk/Lib/interpolate/fitpack/curfit.f
trunk/Lib/interpolate/fitpack/fpadno.f
trunk/Lib/interpolate/fitpack/fpchep.f
trunk/Lib/interpolate/fitpack/fpfrno.f
trunk/Lib/interpolate/fitpack/fpintb.f
trunk/Lib/interpolate/fitpack/fppasu.f
trunk/Lib/interpolate/fitpack/fppogr.f
trunk/Lib/interpolate/fitpack/fppola.f
trunk/Lib/interpolate/fitpack/fpregr.f
trunk/Lib/interpolate/fitpack/fpseno.f
trunk/Lib/interpolate/fitpack/fpspgr.f
trunk/Lib/interpolate/fitpack/fpsphe.f
trunk/Lib/interpolate/fitpack/fpsurf.f
trunk/Lib/interpolate/fitpack/parcur.f
trunk/Lib/interpolate/fitpack/parder.f
trunk/Lib/interpolate/fitpack/parsur.f
trunk/Lib/interpolate/fitpack/percur.f
trunk/Lib/interpolate/fitpack/pogrid.f
trunk/Lib/interpolate/fitpack/regrid.f
trunk/Lib/interpolate/fitpack/spgrid.f
trunk/Lib/interpolate/fitpack/surev.f
trunk/Lib/sandbox/odr/odrpack/d_lpkbls.f
trunk/Lib/special/cdflib/gam1.f
trunk/Lib/special/cdflib/gamma_fort.f
trunk/Lib/special/cdflib/gratio.f
Log:
More 1960's Fortran removal: replace arithmetic IF's.
This cuts down the warnings from gfortran by a lot.
Modified: trunk/Lib/fftpack/dfftpack/dcosqb.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dcosqb.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dcosqb.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -2,7 +2,9 @@
IMPLICIT DOUBLE PRECISION (A-H,O-Z)
DIMENSION X(*) ,WSAVE(*)
DATA TSQRT2 /2.82842712474619009760D0/
- IF (N-2) 101,102,103
+ IF (N.lt.2) GO TO 101
+ IF (N.eq.2) GO TO 102
+ GO TO 103
101 X(1) = 4.0D0*X(1)
RETURN
102 X1 = 4.0D0*(X(1)+X(2))
Modified: trunk/Lib/fftpack/dfftpack/dcosqf.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dcosqf.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dcosqf.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -2,7 +2,9 @@
IMPLICIT DOUBLE PRECISION (A-H,O-Z)
DIMENSION X(*) ,WSAVE(*)
DATA SQRT2 /1.41421356237309504880D0/
- IF (N-2) 102,101,103
+ IF (N.lt.2) GO TO 102
+ IF (N.eq.2) GO TO 101
+ GO TO 103
101 TSQX = SQRT2*X(2)
X(2) = X(1)-TSQX
X(1) = X(1)+TSQX
Modified: trunk/Lib/fftpack/dfftpack/dcost.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dcost.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dcost.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -4,7 +4,9 @@
NM1 = N-1
NP1 = N+1
NS2 = N/2
- IF (N-2) 106,101,102
+ IF (N.lt.2) GO TO 106
+ IF (N.eq.2) GO TO 101
+ GO TO 102
101 X1H = X(1)+X(2)
X(2) = X(1)-X(2)
X(1) = X1H
Modified: trunk/Lib/fftpack/dfftpack/dfftb1.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dfftb1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dfftb1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -229,7 +229,9 @@
CH(1,K,1) = CC(1,1,K)+CC(IDO,2,K)
CH(1,K,2) = CC(1,1,K)-CC(IDO,2,K)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
@@ -305,7 +307,9 @@
CH(1,K,3) = TR2-TR3
CH(1,K,4) = TR1+TR4
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
Modified: trunk/Lib/fftpack/dfftpack/dfftf1.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dfftf1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dfftf1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -236,7 +236,9 @@
CH(1,1,K) = CC(1,K,1)+CC(1,K,2)
CH(IDO,2,K) = CC(1,K,1)-CC(1,K,2)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
@@ -308,7 +310,9 @@
CH(IDO,2,K) = CC(1,K,1)-CC(1,K,3)
CH(1,3,K) = CC(1,K,4)-CC(1,K,2)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
Modified: trunk/Lib/fftpack/dfftpack/dffti1.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dffti1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dffti1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -6,13 +6,15 @@
NF = 0
J = 0
101 J = J+1
- IF (J-4) 102,102,103
+ IF (J.le.4) GO TO 102
+ GO TO 103
102 NTRY = NTRYH(J)
GO TO 104
103 NTRY = NTRY+2
104 NQ = NL/NTRY
NR = NL-NTRY*NQ
- IF (NR) 101,105,101
+ IF (NR.eq.0) GO TO 105
+ GO TO 101
105 NF = NF+1
IFAC(NF+2) = NTRY
NL = NQ
Modified: trunk/Lib/fftpack/dfftpack/dsint1.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/dsint1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/dsint1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -6,7 +6,9 @@
XH(I) = WAR(I)
WAR(I) = X(I)
100 CONTINUE
- IF (N-2) 101,102,103
+ IF (N.lt.2) GO TO 101
+ IF (N.eq.2) GO TO 102
+ GO TO 103
101 XH(1) = XH(1)+XH(1)
GO TO 106
102 XHOLD = SQRT3*(XH(1)+XH(2))
Modified: trunk/Lib/fftpack/dfftpack/zffti1.f
===================================================================
--- trunk/Lib/fftpack/dfftpack/zffti1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/dfftpack/zffti1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -6,13 +6,15 @@
NF = 0
J = 0
101 J = J+1
- IF (J-4) 102,102,103
+ IF (J.le.4) GO TO 102
+ GO TO 103
102 NTRY = NTRYH(J)
GO TO 104
103 NTRY = NTRY+2
104 NQ = NL/NTRY
NR = NL-NTRY*NQ
- IF (NR) 101,105,101
+ IF (NR.eq.0) GO TO 105
+ GO TO 101
105 NF = NF+1
IFAC(NF+2) = NTRY
NL = NQ
Modified: trunk/Lib/fftpack/fftpack/cffti1.f
===================================================================
--- trunk/Lib/fftpack/fftpack/cffti1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/cffti1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -5,13 +5,15 @@
NF = 0
J = 0
101 J = J+1
- IF (J-4) 102,102,103
+ IF (J.le.4) GO TO 102
+ GO TO 103
102 NTRY = NTRYH(J)
GO TO 104
103 NTRY = NTRY+2
104 NQ = NL/NTRY
NR = NL-NTRY*NQ
- IF (NR) 101,105,101
+ IF (NR.eq.0) GO TO 105
+ GO TO 101
105 NF = NF+1
IFAC(NF+2) = NTRY
NL = NQ
Modified: trunk/Lib/fftpack/fftpack/cosqb.f
===================================================================
--- trunk/Lib/fftpack/fftpack/cosqb.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/cosqb.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -1,7 +1,9 @@
SUBROUTINE COSQB (N,X,WSAVE)
DIMENSION X(*) ,WSAVE(*)
DATA TSQRT2 /2.82842712474619/
- IF (N-2) 101,102,103
+ IF (N.lt.2) GO TO 101
+ IF (N.eq.2) GO TO 102
+ GO TO 103
101 X(1) = 4.*X(1)
RETURN
102 X1 = 4.*(X(1)+X(2))
Modified: trunk/Lib/fftpack/fftpack/cosqf.f
===================================================================
--- trunk/Lib/fftpack/fftpack/cosqf.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/cosqf.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -1,7 +1,9 @@
SUBROUTINE COSQF (N,X,WSAVE)
DIMENSION X(*) ,WSAVE(*)
DATA SQRT2 /1.4142135623731/
- IF (N-2) 102,101,103
+ IF (N.lt.2) GO TO 102
+ IF (N.eq.2) GO TO 101
+ GO TO 103
101 TSQX = SQRT2*X(2)
X(2) = X(1)-TSQX
X(1) = X(1)+TSQX
Modified: trunk/Lib/fftpack/fftpack/cost.f
===================================================================
--- trunk/Lib/fftpack/fftpack/cost.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/cost.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -3,7 +3,9 @@
NM1 = N-1
NP1 = N+1
NS2 = N/2
- IF (N-2) 106,101,102
+ IF (N.lt.2) GO TO 106
+ IF (N.eq.2) GO TO 101
+ GO TO 102
101 X1H = X(1)+X(2)
X(2) = X(1)-X(2)
X(1) = X1H
Modified: trunk/Lib/fftpack/fftpack/rfftb1.f
===================================================================
--- trunk/Lib/fftpack/fftpack/rfftb1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/rfftb1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -64,7 +64,9 @@
CH(1,K,1) = CC(1,1,K)+CC(IDO,2,K)
CH(1,K,2) = CC(1,1,K)-CC(IDO,2,K)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
@@ -135,7 +137,9 @@
CH(1,K,3) = TR2-TR3
CH(1,K,4) = TR1+TR4
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
Modified: trunk/Lib/fftpack/fftpack/rfftf1.f
===================================================================
--- trunk/Lib/fftpack/fftpack/rfftf1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/rfftf1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -64,7 +64,9 @@
CH(1,1,K) = CC(1,K,1)+CC(1,K,2)
CH(IDO,2,K) = CC(1,K,1)-CC(1,K,2)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
@@ -131,7 +133,9 @@
CH(IDO,2,K) = CC(1,K,1)-CC(1,K,3)
CH(1,3,K) = CC(1,K,4)-CC(1,K,2)
101 CONTINUE
- IF (IDO-2) 107,105,102
+ IF (IDO.lt.2) GO TO 107
+ IF (IDO.eq.2) GO TO 105
+ GO TO 102
102 IDP2 = IDO+2
DO 104 K=1,L1
DO 103 I=3,IDO,2
Modified: trunk/Lib/fftpack/fftpack/rffti1.f
===================================================================
--- trunk/Lib/fftpack/fftpack/rffti1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/rffti1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -5,13 +5,15 @@
NF = 0
J = 0
101 J = J+1
- IF (J-4) 102,102,103
+ IF (J.le.4) GO TO 102
+ GO TO 103
102 NTRY = NTRYH(J)
GO TO 104
103 NTRY = NTRY+2
104 NQ = NL/NTRY
NR = NL-NTRY*NQ
- IF (NR) 101,105,101
+ IF (NR.eq.0) GO TO 105
+ GO TO 101
105 NF = NF+1
IFAC(NF+2) = NTRY
NL = NQ
Modified: trunk/Lib/fftpack/fftpack/sint1.f
===================================================================
--- trunk/Lib/fftpack/fftpack/sint1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/fftpack/fftpack/sint1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -5,7 +5,9 @@
XH(I) = WAR(I)
WAR(I) = X(I)
100 CONTINUE
- IF (N-2) 101,102,103
+ IF (N.lt.2) GO TO 101
+ IF (N.eq.2) GO TO 102
+ GO TO 103
101 XH(1) = XH(1)+XH(1)
GO TO 106
102 XHOLD = SQRT3*(XH(1)+XH(2))
Modified: trunk/Lib/integrate/odepack/cntnzu.f
===================================================================
--- trunk/Lib/integrate/odepack/cntnzu.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/cntnzu.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -16,7 +16,9 @@
jmax = ia(ii+1) - 1
if (jmin .gt. jmax) go to 50
do 40 j = jmin,jmax
- if (ja(j) - ii) 10, 40, 30
+ if (ja(j).lt.ii) go to 10
+ if (ja(j).eq.ii) go to 40
+ go to 30
10 jj =ja(j)
kmin = ia(jj)
kmax = ia(jj+1) - 1
Modified: trunk/Lib/integrate/odepack/lsodes.f
===================================================================
--- trunk/Lib/integrate/odepack/lsodes.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/lsodes.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -1433,7 +1433,9 @@
lyhd = lyh - lyhn
imax = lyhn - 1 + lenyhm
c move yh. branch for move right, no move, or move left. --------------
- if (lyhd) 70,80,74
+ if (lyhd.lt.0) go to 70
+ if (lyhd.eq.0) go to 80
+ go to 74
70 do 72 i = lyhn,imax
j = imax + lyhn - i
72 rwork(j) = rwork(j+lyhd)
Modified: trunk/Lib/integrate/odepack/lsodi.f
===================================================================
--- trunk/Lib/integrate/odepack/lsodi.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/lsodi.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -1325,7 +1325,9 @@
call ainvg( res, adda, neq, t, y, rwork(lyd0), miter,
1 ml, mu, rwork(lp), iwork(21), ier )
nre = nre + 1
- if (ier) 560,110,565
+ if (ier.lt.0) go to 560
+ if (ier.eq.0) go to 110
+ go to 565
110 continue
do 115 i = 1,n
115 rwork(i+lyh-1) = y(i)
Modified: trunk/Lib/integrate/odepack/lsoibt.f
===================================================================
--- trunk/Lib/integrate/odepack/lsoibt.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/lsoibt.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -1379,7 +1379,9 @@
call aigbt( res, adda, neq, t, y, rwork(lyd0),
1 mb, nb, rwork(lp), iwork(21), ier )
nre = nre + 1
- if (ier) 560,110,565
+ if (ier.lt.0) go to 560
+ if (ier.eq.0) go to 110
+ go to 565
110 continue
do 115 i = 1,n
115 rwork(i+lyh-1) = y(i)
Modified: trunk/Lib/integrate/odepack/mdi.f
===================================================================
--- trunk/Lib/integrate/odepack/mdi.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/mdi.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -22,7 +22,9 @@
if (jmin.gt.jmax) go to 6
do 5 j=jmin,jmax
vj = ja(j)
- if (vj-vi) 2, 5, 4
+ if (vj.lt.vi) go to 2
+ if (vj.eq.vi) go to 5
+ go to 4
c
c------if a(vi,vj) is in strict lower triangle
c------check for previous occurrence of a(vj,vi)
Modified: trunk/Lib/integrate/odepack/mdu.f
===================================================================
--- trunk/Lib/integrate/odepack/mdu.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/mdu.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -19,7 +19,9 @@
do 10 ilp=1,ilpmax
i = l(i)
vi = v(i)
- if (last(vi)) 1, 10, 8
+ if (last(vi).lt.0) go to 1
+ if (last(vi).eq.0) go to 10
+ go to 8
c
c------if vi neither prototype nor duplicate vertex, then merge elements
c------to compute degree
Modified: trunk/Lib/integrate/odepack/nsfc.f
===================================================================
--- trunk/Lib/integrate/odepack/nsfc.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/integrate/odepack/nsfc.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -148,7 +148,9 @@
11 if (jlmin .gt. jlptr) go to 15
qm = q(qm)
do 12 j=jlmin,jlptr
- if (jl(j) - qm) 12, 13, 15
+ if (jl(j).lt.qm) go to 12
+ if (jl(j).eq.qm) go to 13
+ go to 15
12 continue
go to 15
13 ijl(k) = j
@@ -250,7 +252,9 @@
28 if (jumin .gt. juptr) go to 32
qm = q(qm)
do 29 j=jumin,juptr
- if (ju(j) - qm) 29, 30, 32
+ if (ju(j).lt.qm) go to 29
+ if (ju(j).eq.qm) go to 30
+ go to 32
29 continue
go to 32
30 iju(k) = j
Modified: trunk/Lib/interpolate/fitpack/bispev.f
===================================================================
--- trunk/Lib/interpolate/fitpack/bispev.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/bispev.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -83,11 +83,15 @@
lwest = (kx+1)*mx+(ky+1)*my
if(lwrk.lt.lwest) go to 100
if(kwrk.lt.(mx+my)) go to 100
- if(mx-1) 100,30,10
+ if (mx.lt.1) go to 100
+ if (mx.eq.1) go to 30
+ go to 10
10 do 20 i=2,mx
if(x(i).lt.x(i-1)) go to 100
20 continue
- 30 if(my-1) 100,60,40
+ 30 if (my.lt.1) go to 100
+ if (my.eq.1) go to 60
+ go to 40
40 do 50 i=2,my
if(y(i).lt.y(i-1)) go to 100
50 continue
Modified: trunk/Lib/interpolate/fitpack/clocur.f
===================================================================
--- trunk/Lib/interpolate/fitpack/clocur.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/clocur.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -331,7 +331,8 @@
t(i1) = t(j1)+per
60 continue
call fpchep(u,m,t,n,k,ier)
- if(ier) 90,80,90
+ if (ier.eq.0) go to 80
+ go to 90
70 if(s.lt.0.) go to 90
if(s.eq.0. .and. nest.lt.(m+2*k)) go to 90
ier = 0
Modified: trunk/Lib/interpolate/fitpack/cocosp.f
===================================================================
--- trunk/Lib/interpolate/fitpack/cocosp.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/cocosp.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -148,7 +148,8 @@
if(x(i-1).ge.x(i) .or. w(i).le.0.) go to 40
10 continue
call fpchec(x,m,t,n,3,ier)
- if(ier) 40,20,40
+ if (ier.eq.0) go to 20
+ go to 40
c set numbers e(i)
20 n6 = n-6
do 30 i=1,n6
Modified: trunk/Lib/interpolate/fitpack/concur.f
===================================================================
--- trunk/Lib/interpolate/fitpack/concur.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/concur.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -330,7 +330,8 @@
j = j-1
20 continue
call fpched(u,m,t,n,k,ib,ie,ier)
- if(ier) 90,40,90
+ if (ier.eq.0) go to 40
+ go to 90
30 if(s.lt.0.) go to 90
nmax = m+k1+ib1+ie1
if(s.eq.0. .and. nest.lt.nmax) go to 90
Modified: trunk/Lib/interpolate/fitpack/curev.f
===================================================================
--- trunk/Lib/interpolate/fitpack/curev.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/curev.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -63,7 +63,9 @@
c before starting computations a data check is made. if the input data
c are invalid control is immediately repassed to the calling program.
ier = 10
- if(m-1) 100,30,10
+ if (m.lt.1) go to 100
+ if (m.eq.1) go to 30
+ go to 10
10 do 20 i=2,m
if(u(i).lt.u(i-1)) go to 100
20 continue
Modified: trunk/Lib/interpolate/fitpack/curfit.f
===================================================================
--- trunk/Lib/interpolate/fitpack/curfit.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/curfit.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -243,7 +243,8 @@
j = j-1
20 continue
call fpchec(x,m,t,n,k,ier)
- if(ier) 50,40,50
+ if (ier.eq.0) go to 40
+ go to 50
30 if(s.lt.0.) go to 50
if(s.eq.0. .and. nest.lt.(m+k1)) go to 50
ier = 0
Modified: trunk/Lib/interpolate/fitpack/fpadno.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpadno.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpadno.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -25,7 +25,9 @@
10 k = left(point)
bool = .true.
20 if(k.eq.0) go to 50
- if(info(k)-jbind(niveau)) 30,40,50
+ if (info(k)-jbind(niveau).lt.0) go to 30
+ if (info(k)-jbind(niveau).eq.0) go to 40
+ go to 50
30 point = k
k = right(point)
bool = .false.
Modified: trunk/Lib/interpolate/fitpack/fpchep.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpchep.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpchep.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -66,7 +66,8 @@
70 i = i+1
if(i.gt.mm) go to 120
i2 = i-m1
- if(i2) 80,80,90
+ if (i2.le.0) go to 80
+ go to 90
80 xi = x(i)
go to 100
90 xi = x(i2)+per
Modified: trunk/Lib/interpolate/fitpack/fpfrno.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpfrno.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpfrno.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -26,7 +26,9 @@
i = l
j = j+1
go to 20
- 30 if(i-count) 110,100,40
+ 30 if (i.lt.count) go to 110
+ if (i.eq.count) go to 100
+ go to 40
40 if(up(count).eq.0) go to 50
count = count+1
go to 30
Modified: trunk/Lib/interpolate/fitpack/fpintb.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpintb.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpintb.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -39,7 +39,9 @@
a = x
b = y
min = 0
- if(a-b) 30,160,20
+ if (a.lt.b) go to 30
+ if (a.eq.b) go to 160
+ go to 20
20 a = y
b = x
min = 1
Modified: trunk/Lib/interpolate/fitpack/fppasu.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fppasu.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fppasu.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -256,7 +256,9 @@
ier = 0
c adjust the parameter reducu or reducv according to the direction
c in which the last added knots were located.
- if(lastdi) 150,170,160
+ if (lastdi.lt.0) go to 150
+ if (lastdi.eq.0) go to 170
+ go to 160
150 reducu = fpold-fp
go to 170
160 reducv = fpold-fp
@@ -276,7 +278,9 @@
rn = nplusv
if(reducv.gt.acc) npl1 = rn*fpms/reducv
nplv = min0(nplusv*2,max0(npl1,nplusv/2,1))
- 190 if(nplu-nplv) 210,200,230
+ 190 if (nplu.lt.nplv) go to 210
+ if (nplu.eq.nplv) go to 200
+ go to 230
200 if(lastdi.lt.0) go to 230
210 if(nu.eq.nue) go to 230
c addition in the u-direction.
Modified: trunk/Lib/interpolate/fitpack/fppogr.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fppogr.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fppogr.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -266,7 +266,9 @@
ier = 0
c adjust the parameter reducu or reducv according to the direction
c in which the last added knots were located.
- if(lastdi) 160,155,170
+ if (lastdi.lt.0) go to 160
+ if (lastdi.eq.0) go to 155
+ go to 170
155 nplv = 3
idd(2) = ider(2)
fpold = fp
@@ -291,7 +293,9 @@
if(reducv.gt.acc) npl1 = rn*fpms/reducv
nplv = min0(nplusv*2,max0(npl1,nplusv/2,1))
c test whether we are going to add knots in the u- or v-direction.
- 190 if(nplu-nplv) 210,200,230
+ 190 if (nplu.lt.nplv) go to 210
+ if (nplu.eq.nplv) go to 200
+ go to 230
200 if(lastdi.lt.0) go to 230
210 if(nu.eq.nue) go to 230
c addition in the u-direction.
Modified: trunk/Lib/interpolate/fitpack/fppola.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fppola.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fppola.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -52,7 +52,8 @@
acc = tol*s
if(iopt1.eq.0) go to 10
if(s.lt.sup) then
- if(nv-nvmin) 70,90,90
+ if (nv.lt.nvmin) go to 70
+ go to 90
endif
c if iopt1 = 0 we begin by computing the weighted least-squares
c polymomial of the form
@@ -419,11 +420,13 @@
430 call fprppo(nu,nv,iopt2,iopt3,cosi,ratio,c,ff,ncoff)
c test whether the least-squares spline is an acceptable solution.
if(iopt1.lt.0) then
- if(fp) 970,970,980
+ if (fp.le.0) go to 970
+ go to 980
endif
fpms = fp-s
if(abs(fpms).le.acc) then
- if(fp) 970,970,980
+ if (fp.le.0) go to 970
+ go to 980
endif
c if f(p=inf) < s, accept the choice of knots.
if(fpms.lt.0.) go to 580
@@ -641,7 +644,8 @@
piv = h(1)
i2 = min0(iband1,ncof-irot)
if(piv.eq.0.) then
- if(i2) 720,720,690
+ if (i2.le.0) go to 720
+ go to 690
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),co,si)
@@ -706,7 +710,8 @@
piv = h(1)
i2 = min0(iband3,ncof-irot)
if(piv.eq.0.) then
- if(i2) 810,810,780
+ if (i2.le.0) go to 810
+ go to 780
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),co,si)
Modified: trunk/Lib/interpolate/fitpack/fpregr.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpregr.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpregr.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -230,7 +230,9 @@
ier = 0
c adjust the parameter reducx or reducy according to the direction
c in which the last added knots were located.
- if(lastdi) 150,170,160
+ if (lastdi.lt.0) go to 150
+ if (lastdi.eq.0) go to 170
+ go to 160
150 reducx = fpold-fp
go to 170
160 reducy = fpold-fp
@@ -250,7 +252,9 @@
rn = nplusy
if(reducy.gt.acc) npl1 = rn*fpms/reducy
nply = min0(nplusy*2,max0(npl1,nplusy/2,1))
- 190 if(nplx-nply) 210,200,230
+ 190 if (nplx.lt.nply) go to 210
+ if (nplx.eq.nply) go to 200
+ go to 230
200 if(lastdi.lt.0) go to 230
210 if(nx.eq.nxe) go to 230
c addition in the x-direction.
Modified: trunk/Lib/interpolate/fitpack/fpseno.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpseno.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpseno.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -25,7 +25,8 @@
20 k = right(merk)
if(k.ne.0) go to 30
merk = up(merk)
- if(merk-1) 40,40,20
+ if (merk.le.1) go to 40
+ go to 20
30 merk = k
k = left(merk)
if(k.ne.0) go to 30
Modified: trunk/Lib/interpolate/fitpack/fpspgr.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpspgr.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpspgr.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -294,7 +294,9 @@
ier = 0
c adjust the parameter reducu or reducv according to the direction
c in which the last added knots were located.
- if(lastdi) 160,155,170
+ if (lastdi.lt.0) go to 160
+ if (lastdi.eq.0) go to 155
+ go to 170
155 nplv = 3
idd(2) = ider(2)
idd(4) = ider(4)
@@ -320,7 +322,9 @@
if(reducv.gt.acc) npl1 = rn*fpms/reducv
nplv = min0(nplusv*2,max0(npl1,nplusv/2,1))
c test whether we are going to add knots in the u- or v-direction.
- 190 if(nplu-nplv) 210,200,230
+ 190 if (nplu.lt.nplv) go to 210
+ if (nplu.eq.nplv) go to 200
+ go to 230
200 if(lastdi.lt.0) go to 230
210 if(nu.eq.nue) go to 230
c addition in the u-direction.
Modified: trunk/Lib/interpolate/fitpack/fpsphe.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpsphe.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpsphe.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -45,7 +45,8 @@
acc = tol*s
if(iopt.eq.0) go to 10
if(s.lt.sup) then
- if(np-11) 60,70,70
+ if (np.lt.11) go to 60
+ go to 70
endif
c if iopt=0 we begin by computing the weighted least-squares polynomial
c of the form
@@ -369,11 +370,13 @@
390 call fprpsp(nt,np,coco,cosi,c,ff,ncoff)
c test whether the least-squares spline is an acceptable solution.
if(iopt.lt.0) then
- if(fp) 970,970,980
+ if (fp.le.0) go to 970
+ go to 980
endif
fpms = fp-s
if(abs(fpms).le.acc) then
- if(fp) 970,970,980
+ if (fp.le.0) go to 970
+ go to 980
endif
c if f(p=inf) < s, accept the choice of knots.
if(fpms.lt.0.) go to 580
@@ -574,7 +577,8 @@
piv = h(1)
i2 = min0(iband1,ncof-irot)
if(piv.eq.0.) then
- if(i2) 720,720,690
+ if (i2.le.0) go to 720
+ go to 690
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),co,si)
@@ -631,7 +635,8 @@
piv = h(1)
i2 = min0(iband3,ncof-irot)
if(piv.eq.0.) then
- if(i2) 810,810,780
+ if (i2.le.0) go to 810
+ go to 780
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),co,si)
Modified: trunk/Lib/interpolate/fitpack/fpsurf.f
===================================================================
--- trunk/Lib/interpolate/fitpack/fpsurf.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/fpsurf.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -135,7 +135,9 @@
ty(i) = store
70 continue
n1 = n+1
- if(nx-ny) 80,120,100
+ if (nx.lt.ny) go to 80
+ if (nx.eq.ny) go to 120
+ go to 100
80 do 90 i=n1,ny
tx(i) = ty(i)
90 continue
@@ -287,7 +289,8 @@
if(iopt.lt.0) go to 820
fpms = fp-s
if(abs(fpms).le.acc) then
- if(fp) 815,815,820
+ if (fp.le.0) go to 815
+ go to 820
endif
c test whether we can accept the choice of knots.
if(fpms.lt.0.) go to 430
@@ -467,7 +470,8 @@
piv = h(1)
i2 = min0(iband1,ncof-irot)
if(piv.eq.0.) then
- if(i2) 550,550,520
+ if (i2.le.0) go to 550
+ go to 520
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),cos,sin)
@@ -509,7 +513,8 @@
piv = h(1)
i2 = min0(iband3,ncof-irot)
if(piv.eq.0.) then
- if(i2) 630,630,600
+ if (i2.le.0) go to 630
+ go to 600
endif
c calculate the parameters of the givens transformation.
call fpgivs(piv,q(irot,1),cos,sin)
@@ -654,7 +659,9 @@
ty(i) = store
870 continue
n1 = n+1
- if(nx-ny) 880,920,900
+ if (nx.lt.ny) go to 880
+ if (nx.eq.ny) go to 920
+ go to 900
880 do 890 i=n1,ny
tx(i) = ty(i)
890 continue
Modified: trunk/Lib/interpolate/fitpack/parcur.f
===================================================================
--- trunk/Lib/interpolate/fitpack/parcur.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/parcur.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -315,7 +315,8 @@
j = j-1
60 continue
call fpchec(u,m,t,n,k,ier)
- if(ier) 90,80,90
+ if (ier.eq.0) go to 80
+ go to 90
70 if(s.lt.0.) go to 90
if(s.eq.0. .and. nest.lt.(m+k1)) go to 90
ier = 0
Modified: trunk/Lib/interpolate/fitpack/parder.f
===================================================================
--- trunk/Lib/interpolate/fitpack/parder.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/parder.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -94,11 +94,15 @@
lwest = nc +(kx1-nux)*mx+(ky1-nuy)*my
if(lwrk.lt.lwest) go to 400
if(kwrk.lt.(mx+my)) go to 400
- if(mx-1) 400,30,10
+ if (mx.lt.1) go to 400
+ if (mx.eq.1) go to 30
+ go to 10
10 do 20 i=2,mx
if(x(i).lt.x(i-1)) go to 400
20 continue
- 30 if(my-1) 400,60,40
+ 30 if (my.lt.1) go to 400
+ if (my.eq.1) go to 60
+ go to 40
40 do 50 i=2,my
if(y(i).lt.y(i-1)) go to 400
50 continue
Modified: trunk/Lib/interpolate/fitpack/parsur.f
===================================================================
--- trunk/Lib/interpolate/fitpack/parsur.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/parsur.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -367,7 +367,8 @@
tv(l3) = tv(l1)+perv
90 continue
call fpchep(v,mv,tv,nv,3,ier)
- if(ier) 200,150,200
+ if (ier.eq.0) go to 150
+ go to 200
100 if(s.lt.0.) go to 200
if(s.eq.0. .and. (nuest.lt.(mu+4+2*ipar(1)) .or.
* nvest.lt.(mv+4+2*ipar(2))) )go to 200
Modified: trunk/Lib/interpolate/fitpack/percur.f
===================================================================
--- trunk/Lib/interpolate/fitpack/percur.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/percur.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -253,7 +253,8 @@
t(i1) = t(j1)+per
20 continue
call fpchep(x,m,t,n,k,ier)
- if(ier) 50,40,50
+ if (ier.eq.0) go to 40
+ go to 50
30 if(s.lt.0.) go to 50
if(s.eq.0. .and. nest.lt.(m+2*k)) go to 50
ier = 0
Modified: trunk/Lib/interpolate/fitpack/pogrid.f
===================================================================
--- trunk/Lib/interpolate/fitpack/pogrid.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/pogrid.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -442,7 +442,8 @@
135 continue
wrk(l) = ve
call fpchep(wrk(9),mv+1,tv,nv,3,ier)
- if(ier) 200,150,200
+ if (ier.eq.0) go to 150
+ go to 200
140 if(s.lt.0.) go to 200
if(s.eq.0. .and. (nuest.lt.(mu+5+iopt(2)+iopt(3)) .or.
* nvest.lt.(mv+7)) ) go to 200
Modified: trunk/Lib/interpolate/fitpack/regrid.f
===================================================================
--- trunk/Lib/interpolate/fitpack/regrid.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/regrid.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -329,7 +329,8 @@
j = j-1
40 continue
call fpchec(y,my,ty,ny,ky,ier)
- if(ier) 70,60,70
+ if (ier.eq.0) go to 60
+ go to 70
50 if(s.lt.0.) go to 70
if(s.eq.0. .and. (nxest.lt.(mx+kx1) .or. nyest.lt.(my+ky1)) )
* go to 70
Modified: trunk/Lib/interpolate/fitpack/spgrid.f
===================================================================
--- trunk/Lib/interpolate/fitpack/spgrid.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/spgrid.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -476,7 +476,8 @@
135 continue
wrk(l) = ve
call fpchep(wrk(13),mv+1,tv,nv,3,ier)
- if(ier) 200,150,200
+ if (ier.eq.0) go to 150
+ go to 200
140 if(s.lt.0.) go to 200
if(s.eq.0. .and. (nuest.lt.(mu+6+iopt(2)+iopt(3)) .or.
* nvest.lt.(mv+7)) ) go to 200
Modified: trunk/Lib/interpolate/fitpack/surev.f
===================================================================
--- trunk/Lib/interpolate/fitpack/surev.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/interpolate/fitpack/surev.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -87,11 +87,15 @@
muv = mu+mv
if(lwrk.lt.4*muv) go to 100
if(kwrk.lt.muv) go to 100
- if(mu-1) 100,30,10
+ if (mu.lt.1) go to 100
+ if (mu.eq.1) go to 30
+ go to 10
10 do 20 i=2,mu
if(u(i).lt.u(i-1)) go to 100
20 continue
- 30 if(mv-1) 100,60,40
+ 30 if (mv.lt.1) go to 100
+ if (mv.eq.1) go to 60
+ go to 40
40 do 50 i=2,mv
if(v(i).lt.v(i-1)) go to 100
50 continue
Modified: trunk/Lib/sandbox/odr/odrpack/d_lpkbls.f
===================================================================
--- trunk/Lib/sandbox/odr/odrpack/d_lpkbls.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/sandbox/odr/odrpack/d_lpkbls.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -136,7 +136,9 @@
IF(N.LE.0.OR.DA.EQ.0.D0) RETURN
- IF(INCX.EQ.INCY) IF(INCX-1) 5,20,60
+ IF (INCX.EQ.INCY) IF(INCX.lt.1) GOTO 5
+ IF (INCX.EQ.INCY) IF(INCX.eq.1) GOTO 20
+ GOTO 60
5 CONTINUE
C CODE FOR NONEQUAL OR NONPOSITIVE INCREMENTS.
@@ -481,7 +483,9 @@
IF(N.LE.0)RETURN
- IF(INCX.EQ.INCY) IF(INCX-1) 5,20,60
+ IF (INCX.EQ.INCY) IF(INCX.lt.1) GOTO 5
+ IF (INCX.EQ.INCY) IF(INCX.eq.1) GOTO 20
+ GOTO 60
5 CONTINUE
C CODE FOR UNEQUAL OR NONPOSITIVE INCREMENTS.
@@ -585,7 +589,9 @@
DDOT = 0.D0
IF(N.LE.0)RETURN
- IF(INCX.EQ.INCY) IF(INCX-1) 5,20,60
+ IF (INCX.EQ.INCY) IF(INCX.lt.1) GOTO 5
+ IF (INCX.EQ.INCY) IF(INCX.eq.1) GOTO 20
+ GOTO 60
5 CONTINUE
C CODE FOR UNEQUAL OR NONPOSITIVE INCREMENTS.
@@ -1766,7 +1772,9 @@
IF(N.LE.0)RETURN
- IF(INCX.EQ.INCY) IF(INCX-1) 5,20,60
+ IF (INCX.EQ.INCY) IF(INCX.lt.1) GOTO 5
+ IF (INCX.EQ.INCY) IF(INCX.eq.1) GOTO 20
+ GOTO 60
5 CONTINUE
C CODE FOR UNEQUAL OR NONPOSITIVE INCREMENTS.
Modified: trunk/Lib/special/cdflib/gam1.f
===================================================================
--- trunk/Lib/special/cdflib/gam1.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/special/cdflib/gam1.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -35,7 +35,9 @@
t = a
d = a - 0.5D0
IF (d.GT.0.0D0) t = d - 0.5D0
- IF (t) 40,10,20
+ IF (t.lt.0) GO TO 40
+ IF (t.eq.0) GO TO 10
+ GO TO 20
C
10 gam1 = 0.0D0
RETURN
Modified: trunk/Lib/special/cdflib/gamma_fort.f
===================================================================
--- trunk/Lib/special/cdflib/gamma_fort.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/special/cdflib/gamma_fort.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -63,7 +63,9 @@
C
C LET T BE THE PRODUCT OF A-J WHEN A .GE. 2
C
- IF (m) 40,30,10
+ IF (m.lt.0) GO TO 40
+ IF (m.eq.0) GO TO 30
+ GO TO 10
10 DO 20 j = 1,m
x = x - 1.0D0
t = x*t
Modified: trunk/Lib/special/cdflib/gratio.f
===================================================================
--- trunk/Lib/special/cdflib/gratio.f 2006-08-14 01:26:54 UTC (rev 2159)
+++ trunk/Lib/special/cdflib/gratio.f 2006-08-14 04:22:28 UTC (rev 2160)
@@ -317,7 +317,9 @@
u = 1.0D0/a
z = sqrt(z+z)
IF (l.LT.1.0D0) z = -z
- IF (iop-2) 280,290,300
+ IF (iop.lt.2) GO TO 280
+ IF (iop.eq.2) GO TO 290
+ GO TO 300
C
280 IF (abs(s).LE.1.D-3) GO TO 340
c0 = ((((((((((((d0(13)*z+d0(12))*z+d0(11))*z+d0(10))*z+d0(9))*z+
@@ -363,7 +365,9 @@
u = 1.0D0/a
z = sqrt(z+z)
IF (l.LT.1.0D0) z = -z
- IF (iop-2) 340,350,360
+ IF (iop.lt.2) GO TO 340
+ IF (iop.eq.2) GO TO 350
+ GO TO 360
C
340 c0 = ((((((d0(7)*z+d0(6))*z+d0(5))*z+d0(4))*z+d0(3))*z+d0(2))*z+
+ d0(1))*z - third
More information about the Scipy-svn
mailing list