[Scipy-svn] r4930 - trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC

scipy-svn at scipy.org scipy-svn at scipy.org
Sun Nov 2 20:28:03 EST 2008


Author: cdavid
Date: 2008-11-02 19:26:58 -0600 (Sun, 02 Nov 2008)
New Revision: 4930

Modified:
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f
   trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f
Log:
Use wrapped dot functions instead of direct BLAS calls.

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -94,7 +94,7 @@
 c     clarnv  LAPACK routine for generating a random vector. 
 c     cgemv   Level 2 BLAS routine for matrix vector multiplication.
 c     ccopy   Level 1 BLAS that copies one vector to another.
-c     cdotc   Level 1 BLAS that computes the scalar product of two vectors.
+c     wcdotc   Level 1 BLAS that computes the scalar product of two vectors.
 c     scnrm2  Level 1 BLAS that computes the norm of a vector. 
 c
 c\Author
@@ -177,8 +177,8 @@
       Real 
      &           scnrm2, slapy2
       Complex
-     &           cdotc
-      external   cdotc, scnrm2, slapy2
+     &           wcdotc
+      external   wcdotc, scnrm2, slapy2
 c
 c     %-----------------%
 c     | Data Statements |
@@ -291,7 +291,7 @@
 c 
       first = .FALSE.
       if (bmat .eq. 'G') then
-          cnorm  = cdotc (n, resid, 1, workd, 1)
+          cnorm  = wcdotc (n, resid, 1, workd, 1)
           rnorm0 = sqrt(slapy2(real(cnorm),aimag(cnorm)))
       else if (bmat .eq. 'I') then
            rnorm0 = scnrm2(n, resid, 1)
@@ -348,7 +348,7 @@
       end if
 c 
       if (bmat .eq. 'G') then
-         cnorm = cdotc (n, resid, 1, workd, 1)
+         cnorm = wcdotc (n, resid, 1, workd, 1)
          rnorm = sqrt(slapy2(real(cnorm),aimag(cnorm)))
       else if (bmat .eq. 'I') then
          rnorm = scnrm2(n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -143,7 +143,7 @@
 c     cgemv   Level 2 BLAS routine for matrix vector multiplication.
 c     caxpy   Level 1 BLAS that computes a vector triad.
 c     ccopy   Level 1 BLAS that copies one vector to another .
-c     cdotc   Level 1 BLAS that computes the scalar product of two vectors. 
+c     wcdotc   Level 1 BLAS that computes the scalar product of two vectors. 
 c     cscal   Level 1 BLAS that scales a vector.
 c     csscal  Level 1 BLAS that scales a complex vector by a real number. 
 c     scnrm2  Level 1 BLAS that computes the norm of a vector.
@@ -280,10 +280,10 @@
 c     %--------------------%
 c
       Complex
-     &           cdotc 
+     &           wcdotc 
       Real            
      &           slamch,  scnrm2, clanhs, slapy2
-      external   cdotc, scnrm2, clanhs, slamch, slapy2
+      external   wcdotc, scnrm2, clanhs, slamch, slapy2
 c
 c     %---------------------%
 c     | Intrinsic Functions |
@@ -550,7 +550,7 @@
 c        %-------------------------------------%
 c
          if (bmat .eq. 'G') then  
-             cnorm = cdotc (n, resid, 1, workd(ipj), 1)
+             cnorm = wcdotc (n, resid, 1, workd(ipj), 1)
              wnorm = sqrt( slapy2(real(cnorm),aimag(cnorm)) )
          else if (bmat .eq. 'I') then
              wnorm = scnrm2(n, resid, 1)
@@ -622,7 +622,7 @@
 c        %------------------------------%
 c
          if (bmat .eq. 'G') then         
-            cnorm = cdotc (n, resid, 1, workd(ipj), 1)
+            cnorm = wcdotc (n, resid, 1, workd(ipj), 1)
             rnorm = sqrt( slapy2(real(cnorm),aimag(cnorm)) )
          else if (bmat .eq. 'I') then
             rnorm = scnrm2(n, resid, 1)
@@ -722,7 +722,7 @@
 c        %-----------------------------------------------------%
 c 
          if (bmat .eq. 'G') then         
-             cnorm  = cdotc (n, resid, 1, workd(ipj), 1)
+             cnorm  = wcdotc (n, resid, 1, workd(ipj), 1)
              rnorm1 = sqrt( slapy2(real(cnorm),aimag(cnorm)) )
          else if (bmat .eq. 'I') then
              rnorm1 = scnrm2(n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -142,7 +142,7 @@
 c     slamch  LAPACK routine that determines machine constants.
 c     slapy2  LAPACK routine to compute sqrt(x**2+y**2) carefully.
 c     ccopy   Level 1 BLAS that copies one vector to another .
-c     cdotc   Level 1 BLAS that computes the scalar product of two vectors. 
+c     wcdotc   Level 1 BLAS that computes the scalar product of two vectors. 
 c     cswap   Level 1 BLAS that swaps two vectors.
 c     scnrm2  Level 1 BLAS that computes the norm of a vector.
 c
@@ -247,10 +247,10 @@
 c     %--------------------%
 c
       Complex 
-     &           cdotc
+     &           wcdotc
       Real   
      &           scnrm2, slamch, slapy2
-      external   cdotc, scnrm2, slamch, slapy2
+      external   wcdotc, scnrm2, slamch, slapy2
 c
 c     %---------------------%
 c     | Intrinsic Functions |
@@ -754,7 +754,7 @@
          end if
 c 
          if (bmat .eq. 'G') then         
-            cmpnorm = cdotc (n, resid, 1, workd, 1)
+            cmpnorm = wcdotc (n, resid, 1, workd, 1)
             rnorm = sqrt(slapy2(real (cmpnorm),aimag(cmpnorm)))
          else if (bmat .eq. 'I') then
             rnorm = scnrm2(n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -325,8 +325,8 @@
       external   scnrm2, slamch, slapy2
 c
       Complex
-     &           cdotc
-      external   cdotc
+     &           wcdotc
+      external   wcdotc
 c
 c     %-----------------------%
 c     | Executable Statements |
@@ -727,7 +727,7 @@
 c                 | inner product can be set to j.           |
 c                 %------------------------------------------%
 c 
-                  workev(j) = cdotc(j, workl(ihbds), 1,
+                  workev(j) = wcdotc(j, workl(ihbds), 1,
      &                        workl(invsub+(j-1)*ldq), 1)
  40         continue
 c

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -94,7 +94,7 @@
 c     zlarnv  LAPACK routine for generating a random vector. 
 c     zgemv   Level 2 BLAS routine for matrix vector multiplication.
 c     zcopy   Level 1 BLAS that copies one vector to another.
-c     zdotc   Level 1 BLAS that computes the scalar product of two vectors.
+c     wzdotc   Level 1 BLAS that computes the scalar product of two vectors.
 c     dznrm2  Level 1 BLAS that computes the norm of a vector. 
 c
 c\Author
@@ -177,8 +177,8 @@
       Double precision 
      &           dznrm2, dlapy2
       Complex*16
-     &           zdotc
-      external   zdotc, dznrm2, dlapy2
+     &           wzdotc
+      external   wzdotc, dznrm2, dlapy2
 c
 c     %-----------------%
 c     | Data Statements |
@@ -291,7 +291,7 @@
 c 
       first = .FALSE.
       if (bmat .eq. 'G') then
-          cnorm  = zdotc (n, resid, 1, workd, 1)
+          cnorm  = wzdotc (n, resid, 1, workd, 1)
           rnorm0 = sqrt(dlapy2(dble(cnorm),dimag(cnorm)))
       else if (bmat .eq. 'I') then
            rnorm0 = dznrm2(n, resid, 1)
@@ -348,7 +348,7 @@
       end if
 c 
       if (bmat .eq. 'G') then
-         cnorm = zdotc (n, resid, 1, workd, 1)
+         cnorm = wzdotc (n, resid, 1, workd, 1)
          rnorm = sqrt(dlapy2(dble(cnorm),dimag(cnorm)))
       else if (bmat .eq. 'I') then
          rnorm = dznrm2(n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -143,7 +143,7 @@
 c     zgemv   Level 2 BLAS routine for matrix vector multiplication.
 c     zaxpy   Level 1 BLAS that computes a vector triad.
 c     zcopy   Level 1 BLAS that copies one vector to another .
-c     zdotc   Level 1 BLAS that computes the scalar product of two vectors. 
+c     wzdotc   Level 1 BLAS that computes the scalar product of two vectors. 
 c     zscal   Level 1 BLAS that scales a vector.
 c     zdscal  Level 1 BLAS that scales a complex vector by a real number. 
 c     dznrm2  Level 1 BLAS that computes the norm of a vector.
@@ -280,10 +280,10 @@
 c     %--------------------%
 c
       Complex*16
-     &           zdotc 
+     &           wzdotc 
       Double precision            
      &           dlamch,  dznrm2, zlanhs, dlapy2
-      external   zdotc, dznrm2, zlanhs, dlamch, dlapy2
+      external   wzdotc, dznrm2, zlanhs, dlamch, dlapy2
 c
 c     %---------------------%
 c     | Intrinsic Functions |
@@ -550,7 +550,7 @@
 c        %-------------------------------------%
 c
          if (bmat .eq. 'G') then  
-             cnorm = zdotc (n, resid, 1, workd(ipj), 1)
+             cnorm = wzdotc (n, resid, 1, workd(ipj), 1)
              wnorm = sqrt( dlapy2(dble(cnorm),dimag(cnorm)) )
          else if (bmat .eq. 'I') then
              wnorm = dznrm2(n, resid, 1)
@@ -622,7 +622,7 @@
 c        %------------------------------%
 c
          if (bmat .eq. 'G') then         
-            cnorm = zdotc (n, resid, 1, workd(ipj), 1)
+            cnorm = wzdotc (n, resid, 1, workd(ipj), 1)
             rnorm = sqrt( dlapy2(dble(cnorm),dimag(cnorm)) )
          else if (bmat .eq. 'I') then
             rnorm = dznrm2(n, resid, 1)
@@ -722,7 +722,7 @@
 c        %-----------------------------------------------------%
 c 
          if (bmat .eq. 'G') then         
-             cnorm  = zdotc (n, resid, 1, workd(ipj), 1)
+             cnorm  = wzdotc (n, resid, 1, workd(ipj), 1)
              rnorm1 = sqrt( dlapy2(dble(cnorm),dimag(cnorm)) )
          else if (bmat .eq. 'I') then
              rnorm1 = dznrm2(n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -142,7 +142,7 @@
 c     dlamch   LAPACK routine that determines machine constants.
 c     dlapy2   LAPACK routine to compute sqrt(x**2+y**2) carefully.
 c     zcopy    Level 1 BLAS that copies one vector to another .
-c     zdotc    Level 1 BLAS that computes the scalar product of two vectors. 
+c     wzdotc    Level 1 BLAS that computes the scalar product of two vectors. 
 c     zswap    Level 1 BLAS that swaps two vectors.
 c     dznrm2   Level 1 BLAS that computes the norm of a vector.
 c
@@ -247,10 +247,10 @@
 c     %--------------------%
 c
       Complex*16 
-     &           zdotc 
+     &           wzdotc 
       Double precision   
      &           dznrm2 , dlamch , dlapy2 
-      external   zdotc , dznrm2 , dlamch , dlapy2 
+      external   wzdotc , dznrm2 , dlamch , dlapy2 
 c
 c     %---------------------%
 c     | Intrinsic Functions |
@@ -754,7 +754,7 @@
          end if
 c 
          if (bmat .eq. 'G') then         
-            cmpnorm = zdotc  (n, resid, 1, workd, 1)
+            cmpnorm = wzdotc  (n, resid, 1, workd, 1)
             rnorm = sqrt(dlapy2 (dble (cmpnorm),dimag (cmpnorm)))
          else if (bmat .eq. 'I') then
             rnorm = dznrm2 (n, resid, 1)

Modified: trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f
===================================================================
--- trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f	2008-11-03 01:25:53 UTC (rev 4929)
+++ trunk/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f	2008-11-03 01:26:58 UTC (rev 4930)
@@ -325,8 +325,8 @@
       external   dznrm2, dlamch, dlapy2
 c
       Complex*16
-     &           zdotc
-      external   zdotc
+     &           wzdotc
+      external   wzdotc
 c
 c     %-----------------------%
 c     | Executable Statements |
@@ -727,7 +727,7 @@
 c                 | inner product can be set to j.           |
 c                 %------------------------------------------%
 c 
-                  workev(j) = zdotc(j, workl(ihbds), 1,
+                  workev(j) = wzdotc(j, workl(ihbds), 1,
      &                        workl(invsub+(j-1)*ldq), 1)
  40         continue
 c




More information about the Scipy-svn mailing list