[cig-commits] r13800 - seismo/3D/SPECFEM3D_SESAME/trunk

dkomati1 at geodynamics.org dkomati1 at geodynamics.org
Sat Dec 27 10:52:44 PST 2008


Author: dkomati1
Date: 2008-12-27 10:52:44 -0800 (Sat, 27 Dec 2008)
New Revision: 13800

Modified:
   seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_scalar.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_vector.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/compute_forces.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/create_movie_AVS_DX.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/create_regions_mesh.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/flags.guess
   seismo/3D/SPECFEM3D_SESAME/trunk/locate_receivers.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/locate_source.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/meshfem3D.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/parallel.f90
   seismo/3D/SPECFEM3D_SESAME/trunk/read_arrays_solver.f90
Log:
removed unused variables and useless white spaces;
restored -O3 instead of -fast for Intel compiler because -fast creates problems (does not compile; produces weird error messages (related to the compiler, not the code)


Modified: seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_scalar.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_scalar.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_scalar.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -273,7 +273,7 @@
            array_val(ibool_interfaces_ext_mesh(ipoin,iinterface)) + buffer_recv_scalar_ext_mesh(ipoin,iinterface)
     enddo
   enddo
-      
+
   endif
 
   end subroutine assemble_MPI_scalar_ext_mesh
@@ -355,7 +355,7 @@
            array_val(ibool_interfaces_ext_mesh(ipoin,iinterface)) + buffer_recv_scalar_ext_mesh(ipoin,iinterface)
     enddo
   enddo
-      
+
 ! wait for communications completion (send)
   do iinterface = 1, ninterfaces_ext_mesh
     call wait_req(request_send_scalar_ext_mesh(iinterface))

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_vector.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_vector.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/assemble_MPI_vector.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -278,7 +278,7 @@
   do iinterface = 1, ninterfaces_ext_mesh
     call wait_req(request_send_vector_ext_mesh(iinterface))
   enddo
-      
+
   endif
 
   end subroutine assemble_MPI_vector_ext_mesh
@@ -404,7 +404,7 @@
   do iinterface = 1, ninterfaces_ext_mesh
     call wait_req(request_send_vector_ext_mesh(iinterface))
   enddo
-      
+
   endif
 
   end subroutine assemble_MPI_vector_ext_mesh_w

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/compute_forces.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/compute_forces.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/compute_forces.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -52,7 +52,7 @@
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLY) :: wgllwgll_xy
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ) :: wgllwgll_xz
   real(kind=CUSTOM_REAL), dimension(NGLLY,NGLLZ) :: wgllwgll_yz
-  
+
 ! communication overlap
   logical, dimension(NSPEC_AB) :: ispec_is_inner
   logical :: phase_is_inner
@@ -61,7 +61,7 @@
   integer :: NSOURCES,myrank,it
   integer, dimension(NSOURCES) :: islice_selected_source,ispec_selected_source
   double precision, dimension(NSOURCES) :: xi_source,eta_source,gamma_source
-  double precision, dimension(3,3,NSOURCES) :: nu_source  
+  double precision, dimension(3,3,NSOURCES) :: nu_source
   double precision, dimension(NSOURCES) :: hdur
   double precision :: dt
 
@@ -85,12 +85,12 @@
   real(kind=CUSTOM_REAL) tempx1l,tempx2l,tempx3l
   real(kind=CUSTOM_REAL) tempy1l,tempy2l,tempy3l
   real(kind=CUSTOM_REAL) tempz1l,tempz2l,tempz3l
-  
+
   real(kind=CUSTOM_REAL) lambdal,mul,lambdalplus2mul
   real(kind=CUSTOM_REAL) kappal
 
   integer :: isource
-  double precision :: t0,f0  
+  double precision :: t0,f0
 
 
   do ispec = 1,NSPEC_AB
@@ -273,15 +273,15 @@
            nint(gamma_source(isource)), &
            ispec_selected_source(isource))
       f0 = hdur(isource) !! using hdur as a FREQUENCY just to avoid changing CMTSOLUTION file format
-      t0 = 1.2d0/f0 
+      t0 = 1.2d0/f0
 if (it == 1 .and. myrank == 0) then
-     
+
 print *,'using a source of dominant frequency ',f0
 print *,'lambda_S at dominant frequency = ',3000./sqrt(3.)/f0
 print *,'lambda_S at highest significant frequency = ',3000./sqrt(3.)/(2.5*f0)
 endif
-      
-      
+
+
       ! we use nu_source(:,3) here because we want a source normal to the surface.
       ! This is the expression of a Ricker; should be changed according maybe to the Par_file.
       !accel(:,iglob) = accel(:,iglob) + &
@@ -292,7 +292,7 @@
            exp(-PI*PI*f0*f0*(dble(it-1)*DT-t0)*(dble(it-1)*DT-t0)))
 
     endif
-  endif    
+  endif
 
   endif
 

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/create_movie_AVS_DX.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/create_movie_AVS_DX.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/create_movie_AVS_DX.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -58,9 +58,6 @@
 
   integer iproc,ipoin
 
-! GMT
-  double precision lat,long
-
 ! for sorting routine
   integer npointot,ilocnum,nglob,i,j,ielm,ieoff,ispecloc
   integer, dimension(:), allocatable :: iglob,loc,ireorder
@@ -180,8 +177,8 @@
   allocate(store_val_ux(ilocnum,0:NPROC-1))
   allocate(store_val_uy(ilocnum,0:NPROC-1))
   allocate(store_val_uz(ilocnum,0:NPROC-1))
-  
 
+
   print *,'1 = create files in OpenDX format'
   print *,'2 = create files in AVS UCD format with individual files'
   print *,'3 = create files in AVS UCD format with one time-dependent file'
@@ -384,7 +381,7 @@
                    (y(i,j) - (Y_SOURCE_EXT_MESH))**2 + &
                    (z(i,j) - (Z_SOURCE_EXT_MESH))**2)) < RADIUS_TO_MUTE) &
                    .and. MUTE_SOURCE) then
-                
+
                 display(i,j) = 0.
               else
 
@@ -473,7 +470,7 @@
                    (y(i,j) - (Y_SOURCE_EXT_MESH))**2 + &
                    (z(i,j) - (Z_SOURCE_EXT_MESH))**2)) < RADIUS_TO_MUTE) &
                    .and. MUTE_SOURCE) then
-                
+
                 display(i,j) = 0.
               else
 

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/create_regions_mesh.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/create_regions_mesh.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/create_regions_mesh.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -1158,16 +1158,12 @@
 !
 
   subroutine create_regions_mesh_ext_mesh(ibool, &
-           xstore,ystore,zstore,npx,npy,iproc_xi,iproc_eta,nspec, &
-           volume_local,area_local_bottom,area_local_top, &
-           NGLOB_AB,npointot, &
-           myrank,LOCAL_PATH, &
+           xstore,ystore,zstore,nspec,npointot,myrank,LOCAL_PATH, &
            nnodes_ext_mesh,nelmnts_ext_mesh, &
            nodes_coords_ext_mesh,elmnts_ext_mesh,mat_ext_mesh, &
            ninterface_ext_mesh,max_interface_size_ext_mesh, &
            my_neighbours_ext_mesh,my_nelmnts_neighbours_ext_mesh,my_interfaces_ext_mesh, &
-           ibool_interfaces_ext_mesh,nibool_interfaces_ext_mesh &
-           )
+           ibool_interfaces_ext_mesh,nibool_interfaces_ext_mesh)
 
 ! create the different regions of the mesh
 
@@ -1178,7 +1174,6 @@
 ! number of spectral elements in each block
   integer nspec
 
-  integer npx,npy
   integer npointot
 
   character(len=150) LOCAL_PATH
@@ -1186,12 +1181,6 @@
 ! arrays with the mesh
   double precision, dimension(NGLLX,NGLLY,NGLLZ,nspec) :: xstore,ystore,zstore
 
-  double precision xstore_local(NGLLX,NGLLY,NGLLZ)
-  double precision ystore_local(NGLLX,NGLLY,NGLLZ)
-  double precision zstore_local(NGLLX,NGLLY,NGLLZ)
-
-  double precision xmesh,ymesh,zmesh
-
   integer ibool(NGLLX,NGLLY,NGLLZ,nspec)
 
 ! data from the external mesh
@@ -1207,7 +1196,7 @@
   integer, dimension(NGLLX*NGLLX*max_interface_size_ext_mesh,ninterface_ext_mesh) :: ibool_interfaces_ext_mesh
   integer, dimension(ninterface_ext_mesh) :: nibool_interfaces_ext_mesh
 
-! for MPI buffers  
+! for MPI buffers
   integer, dimension(:), allocatable :: reorder_interface_ext_mesh,ind_ext_mesh,ninseg_ext_mesh,iwork_ext_mesh
   integer, dimension(:), allocatable :: nibool_interfaces_ext_mesh_true
   integer, dimension(:,:), allocatable :: ibool_interfaces_ext_mesh_dummy
@@ -1243,15 +1232,13 @@
 
 ! check area and volume of the final mesh
   double precision weight
-  double precision area_local_bottom,area_local_top
-  double precision volume_local
 
 ! variables for creating array ibool (some arrays also used for AVS or DX files)
   integer, dimension(:), allocatable :: iglob,locval
   logical, dimension(:), allocatable :: ifseg
   double precision, dimension(:), allocatable :: xp,yp,zp
 
-  integer nglob,NGLOB_AB
+  integer nglob
   integer ieoff,ilocnum
   integer ier
   integer iinterface
@@ -1264,15 +1251,8 @@
 ! name of the database file
   character(len=150) prname
 
-  integer i,j,k,ia,ispec,iglobnum,itype_element
-  integer iproc_xi,iproc_eta
+  integer i,j,k,ia,ispec,iglobnum
 
-  double precision rho,vp,vs
-  double precision c11,c12,c13,c14,c15,c16,c22,c23,c24,c25,c26,c33,c34,c35,c36,c44,c45,c46,c55,c56,c66
-
-! for the harvard 3D salton sea model
-  double precision :: umesh, vmesh, wmesh, vp_st, vs_st, rho_st
-
 ! mask to sort ibool
   integer, dimension(:), allocatable :: mask_ibool
   integer, dimension(:,:,:,:), allocatable :: copy_ibool_ori
@@ -1354,7 +1334,7 @@
           gammaxstore,gammaystore,gammazstore,jacobianstore, &
           xstore,ystore,zstore, &
           xelm,yelm,zelm,shape3D,dershape3D,ispec,nspec)
-     
+
   enddo
 
 ! kappastore and mustore
@@ -1431,7 +1411,7 @@
   enddo
 
   deallocate(copy_ibool_ori,stat=ier); if(ier /= 0) stop 'error in deallocate'
-  deallocate(mask_ibool,stat=ier); if(ier /= 0) stop 'error in deallocate'  
+  deallocate(mask_ibool,stat=ier); if(ier /= 0) stop 'error in deallocate'
 
   allocate(xstore_dummy(nglob))
   allocate(ystore_dummy(nglob))
@@ -1446,7 +1426,7 @@
         enddo
      enddo
   enddo
-  
+
   do ispec = 1, nspec
      do k = 1, NGLLZ
         do j = 1, NGLLY
@@ -1493,7 +1473,7 @@
       enddo
     enddo
   enddo
-  enddo  
+  enddo
 
   call prepare_assemble_MPI (nelmnts_ext_mesh,ibool, &
        elmnts_ext_mesh, ESIZE, &
@@ -1502,13 +1482,13 @@
        my_nelmnts_neighbours_ext_mesh, my_interfaces_ext_mesh, &
        ibool_interfaces_ext_mesh, &
        nibool_interfaces_ext_mesh &
-       )  
+       )
 
 ! sort ibool comm buffers lexicographically
   allocate(nibool_interfaces_ext_mesh_true(ninterface_ext_mesh))
 
   do iinterface = 1, ninterface_ext_mesh
-     
+
     allocate(xp(nibool_interfaces_ext_mesh(iinterface)))
     allocate(yp(nibool_interfaces_ext_mesh(iinterface)))
     allocate(zp(nibool_interfaces_ext_mesh(iinterface)))
@@ -1519,19 +1499,19 @@
     allocate(ind_ext_mesh(nibool_interfaces_ext_mesh(iinterface)))
     allocate(ninseg_ext_mesh(nibool_interfaces_ext_mesh(iinterface)))
     allocate(iwork_ext_mesh(nibool_interfaces_ext_mesh(iinterface)))
-    allocate(work_ext_mesh(nibool_interfaces_ext_mesh(iinterface)))  
+    allocate(work_ext_mesh(nibool_interfaces_ext_mesh(iinterface)))
 
     do ilocnum = 1, nibool_interfaces_ext_mesh(iinterface)
       xp(ilocnum) = xstore_dummy(ibool_interfaces_ext_mesh(ilocnum,iinterface))
       yp(ilocnum) = ystore_dummy(ibool_interfaces_ext_mesh(ilocnum,iinterface))
       zp(ilocnum) = zstore_dummy(ibool_interfaces_ext_mesh(ilocnum,iinterface))
-    enddo     
+    enddo
 
     call sort_array_coordinates(nibool_interfaces_ext_mesh(iinterface),xp,yp,zp, &
          ibool_interfaces_ext_mesh(1:nibool_interfaces_ext_mesh(iinterface),iinterface), &
          reorder_interface_ext_mesh,locval,ifseg,nibool_interfaces_ext_mesh_true(iinterface), &
-         ind_ext_mesh,ninseg_ext_mesh,iwork_ext_mesh,work_ext_mesh)    
-    
+         ind_ext_mesh,ninseg_ext_mesh,iwork_ext_mesh,work_ext_mesh)
+
     deallocate(xp)
     deallocate(yp)
     deallocate(zp)
@@ -1545,7 +1525,7 @@
     deallocate(work_ext_mesh)
 
   enddo
-  
+
 ! save the binary files
   call create_name_database(prname,myrank,LOCAL_PATH)
   open(unit=IOUT,file=prname(1:len_trim(prname))//'external_mesh.bin',status='unknown',action='write',form='unformatted')
@@ -1565,7 +1545,7 @@
   write(IOUT) jacobianstore
   write(IOUT) kappastore
   write(IOUT) mustore
-  
+
   write(IOUT) rmass
 
   write(IOUT) ibool
@@ -1594,7 +1574,7 @@
   double precision function materials_ext_mesh(i,j)
 
     implicit none
-    
+
     integer :: i,j
 
     select case (j)
@@ -1606,7 +1586,7 @@
             materials_ext_mesh = 3000.d0
           case (3)
             materials_ext_mesh = 1732.051d0
-          case default 
+          case default
             call stop_all()
           end select
       case (2)
@@ -1617,13 +1597,13 @@
             materials_ext_mesh = 900.d0
           case (3)
             materials_ext_mesh = 500.d0
-          case default 
+          case default
             call stop_all()
           end select
       case default
         call stop_all()
     end select
-       
+
   end function materials_ext_mesh
 
 !
@@ -1710,8 +1690,8 @@
 
      end do
      nibool_interfaces_asteroid(num_interface) = npoin_interface_asteroid
-   
-     
+
+
   end do
 
 end subroutine prepare_assemble_MPI
@@ -1730,7 +1710,7 @@
   integer, dimension(ngnode), intent(in)  :: n
   integer, intent(in)  :: type, e1, e2, e3, e4
   integer, intent(out)  :: ixmin, ixmax, iymin, iymax, izmin, izmax
-  
+
   integer, dimension(4) :: en
   integer :: valence, i
 
@@ -1840,7 +1820,7 @@
               iymax = 1
               izmax = NGLLZ
            end if
-           
+
         end if
         if ( e1 == n(3) ) then
            ixmin = NGLLX
@@ -1962,14 +1942,14 @@
               izmax = NGLLZ
            end if
         end if
-        
+
      else
         if (type == 4) then
            en(1) = e1
            en(2) = e2
            en(3) = e3
            en(4) = e4
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(1)) then
@@ -1993,7 +1973,7 @@
               iymax = NGLLY
               izmax = 1
            endif
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(1)) then
@@ -2017,7 +1997,7 @@
               iymax = 1
               izmax = NGLLZ
            endif
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(2)) then
@@ -2041,7 +2021,7 @@
               iymax = NGLLZ
               izmax = NGLLZ
            endif
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(3)) then
@@ -2065,7 +2045,7 @@
               iymax = NGLLY
               izmax = NGLLZ
            endif
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(1)) then
@@ -2089,7 +2069,7 @@
               iymax = NGLLY
               izmax = NGLLZ
            endif
-           
+
            valence = 0
            do i = 1, 4
               if ( en(i) == n(5)) then
@@ -2113,11 +2093,11 @@
               iymax = NGLLY
               izmax = NGLLZ
            endif
-           
+
         else
            stop 'ERROR get_edge'
         endif
-        
+
      end if
   end if
 

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/flags.guess
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/flags.guess	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/flags.guess	2008-12-27 18:52:44 UTC (rev 13800)
@@ -12,7 +12,7 @@
 case $FC in
     pgf90|*/pgf90)
         #
-        # Beowulf Portland pgf90
+        # Portland pgf90
         #
         if test x"$FLAGS_CHECK" = x; then
             FLAGS_CHECK="-fast -Mnobounds -Mneginfo -Mdclchk -Knoieee" # -mcmodel=medium
@@ -23,16 +23,15 @@
         ;;
     ifort|*/ifort)
         #
-        # Intel ifort Fortran90 for Linux
+        # Intel ifort Fortran90
         #
         if test x"$FLAGS_CHECK" = x; then
             FLAGS_CHECK="-O3 -vec-report0 -e03 -std03 -implicitnone -warn truncated_source -warn argument_checking -warn unused -warn declarations -warn alignments -warn ignore_loc -warn usage -check nobounds -align sequence -assume byterecl -fpe0 -ftz -traceback -ftrapuv" # -mcmodel=medium
         fi
         if test x"$FLAGS_NO_CHECK" = x; then
             # standard options (leave option -ftz, which is *critical* for performance)
-            FLAGS_NO_CHECK="-fast -vec-report0 -e03 -std03 -implicitnone -warn truncated_source -warn argument_checking -warn unused -warn declarations -warn alignments -warn ignore_loc -warn usage -check nobounds -align sequence -assume byterecl -fpe3 -ftz" # -mcmodel=medium
+            FLAGS_NO_CHECK="-O3 -xP -vec-report0 -e03 -std03 -implicitnone -warn truncated_source -warn argument_checking -warn unused -warn declarations -warn alignments -warn ignore_loc -warn usage -check nobounds -align sequence -assume byterecl -fpe3 -ftz" # -mcmodel=medium
         fi
-        #MPI_LIBS = -Vaxlib
         ;;
     gfortran|*/gfortran|f95|*/f95)
         #

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/locate_receivers.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/locate_receivers.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/locate_receivers.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -129,7 +129,7 @@
   double precision, allocatable, dimension(:) :: stlat,stlon,stele,stbur,stutm_x,stutm_y
   double precision, allocatable, dimension(:,:) :: xi_receiver_all,eta_receiver_all,gamma_receiver_all
   double precision, allocatable, dimension(:,:,:,:) :: nu_all
-  
+
   character(len=150) OUTPUT_FILES
 
 ! **************
@@ -278,12 +278,12 @@
       if (myrank == 0) write(IOVTK,*) x_target(irec), y_target(irec), z_target(irec)
 
   else
-   
+
     x_target(irec) = stutm_x(irec)
     y_target(irec) = stutm_y(irec)
     z_target(irec) = stbur(irec)
     if (myrank == 0) write(IOVTK,*) x_target(irec), y_target(irec), z_target(irec)
- 
+
   endif ! of if (.not. USE_EXTERNAL_MESH)
 
 ! examine top of the elements only (receivers always at the surface)
@@ -322,7 +322,7 @@
           do i = imin,imax
 
             iglob = ibool(i,j,k,ispec)
-            
+
             if (USE_EXTERNAL_MESH .and. (.not. RECVS_CAN_BE_BURIED_EXT_MESH)) then
               if ((.not. iglob_is_surface_external_mesh(iglob)) .or. (.not. ispec_is_surface_external_mesh(ispec))) then
                 cycle
@@ -478,7 +478,7 @@
 ! normalize vector w
     w_vector(:) = w_vector(:)/sqrt(w_vector(1)**2+w_vector(2)**2+w_vector(3)**2)
 
-! build the two other vectors for a direct base : we normalize u, and v=w^u    
+! build the two other vectors for a direct base: we normalize u, and v=w^u
     u_vector(:) = u_vector(:)/sqrt(u_vector(1)**2+u_vector(2)**2+u_vector(3)**2)
     v_vector(1) = w_vector(2)*u_vector(3) - w_vector(3)*u_vector(2)
     v_vector(2) = w_vector(3)*u_vector(1) - w_vector(1)*u_vector(3)
@@ -713,7 +713,7 @@
       write(IMAIN,*) 'nu3 = ',nu(3,:,irec)
     else
       write(IMAIN,*) ' at xi,eta,gamma coordinates = ',xi_receiver(irec),eta_receiver(irec),gamma_receiver(irec)
-    endif 
+    endif
 
 ! add warning if estimate is poor
 ! (usually means receiver outside the mesh given by the user)

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/locate_source.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/locate_source.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/locate_source.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -211,7 +211,7 @@
 !     Vertical
       nu_source(3,1,isource) = 0.d0
       nu_source(3,2,isource) = 0.d0
-      nu_source(3,3,isource) = 1.d0  
+      nu_source(3,3,isource) = 1.d0
 
   if (.not. USE_EXTERNAL_MESH) then
 
@@ -261,7 +261,7 @@
   if(myrank == 0) write(IOVTK,*) x_target_source,y_target_source,z_target_source
 
   else
-   
+
     x_target_source = utm_x_source(isource)
     y_target_source = utm_y_source(isource)
     z_target_source = depth(isource)
@@ -306,7 +306,7 @@
           do i = imin,imax
 
             iglob = ibool(i,j,k,ispec)
-            
+
             if (USE_EXTERNAL_MESH .and. (.not. SOURCES_CAN_BE_BURIED_EXT_MESH)) then
               if ((.not. iglob_is_surface_external_mesh(iglob)) .or. (.not. ispec_is_surface_external_mesh(ispec))) then
                 cycle
@@ -462,7 +462,7 @@
 ! normalize vector w
     w_vector(:) = w_vector(:)/sqrt(w_vector(1)**2+w_vector(2)**2+w_vector(3)**2)
 
-! build the two other vectors for a disourcet base : we normalize u, and v=w^u    
+! build the two other vectors for a direct base: we normalize u, and v=w^u
     u_vector(:) = u_vector(:)/sqrt(u_vector(1)**2+u_vector(2)**2+u_vector(3)**2)
     v_vector(1) = w_vector(2)*u_vector(3) - w_vector(3)*u_vector(2)
     v_vector(2) = w_vector(3)*u_vector(1) - w_vector(1)*u_vector(3)

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/meshfem3D.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/meshfem3D.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/meshfem3D.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -240,8 +240,6 @@
   integer, dimension(:), allocatable  :: my_nelmnts_neighbours_ext_mesh
   integer, dimension(:,:,:), allocatable  :: my_interfaces_ext_mesh
   integer, dimension(:,:), allocatable  :: ibool_interfaces_ext_mesh
-  integer, dimension(:,:), allocatable  :: ibool_interfaces_ext_mesh_dummy
-  integer, dimension(:), allocatable  :: ibool_interface_ext_mesh_dummy
   integer, dimension(:), allocatable  :: nibool_interfaces_ext_mesh
   double precision, dimension(:,:), allocatable :: nodes_coords_ext_mesh
   integer, dimension(:,:), allocatable :: elmnts_ext_mesh
@@ -356,7 +354,7 @@
       write(IMAIN,'(a1)',advance='yes') ' '
     enddo
   endif
-  
+
   endif ! end of (.not. USE_EXTERNAL_MESH)
 
   if(myrank == 0) then
@@ -530,7 +528,7 @@
   endif
 
   if (.not. USE_EXTERNAL_MESH) then
-  
+
 ! get addressing for this process
   iproc_xi = iproc_xi_slice(myrank)
   iproc_eta = iproc_eta_slice(myrank)
@@ -723,14 +721,14 @@
 ! read databases about external mesh simulation
 ! nlegoff --
   if (USE_EXTERNAL_MESH) then
-    call create_name_database(prname,myrank,LOCAL_PATH)    
+    call create_name_database(prname,myrank,LOCAL_PATH)
     open(unit=IIN,file=prname(1:len_trim(prname))//'Database',status='old',action='read',form='formatted')
     read(IIN,*) nnodes_ext_mesh
     allocate(nodes_coords_ext_mesh(NDIM,nnodes_ext_mesh))
     do inode = 1, nnodes_ext_mesh
       read(IIN,*) dummy_node, nodes_coords_ext_mesh(1,inode), nodes_coords_ext_mesh(2,inode), nodes_coords_ext_mesh(3,inode)
     enddo
-    
+
     read(IIN,*) nelmnts_ext_mesh
     allocate(elmnts_ext_mesh(esize,nelmnts_ext_mesh))
     allocate(mat_ext_mesh(nelmnts_ext_mesh))
@@ -782,16 +780,13 @@
 ! create all the regions of the mesh
   if (USE_EXTERNAL_MESH) then
   call create_regions_mesh_ext_mesh(ibool, &
-           xstore,ystore,zstore,npx,npy,iproc_xi,iproc_eta,nspec, &
-           volume_local,area_local_bottom,area_local_top, &
-           NGLOB_AB,npointot, &
-           myrank,LOCAL_PATH, &
+           xstore,ystore,zstore,nspec, &
+           npointot,myrank,LOCAL_PATH, &
            nnodes_ext_mesh,nelmnts_ext_mesh, &
            nodes_coords_ext_mesh,elmnts_ext_mesh,mat_ext_mesh, &
            ninterface_ext_mesh,max_interface_size_ext_mesh, &
            my_neighbours_ext_mesh,my_nelmnts_neighbours_ext_mesh,my_interfaces_ext_mesh, &
-           ibool_interfaces_ext_mesh,nibool_interfaces_ext_mesh &
-           )
+           ibool_interfaces_ext_mesh,nibool_interfaces_ext_mesh)
 
   else
   call create_regions_mesh(xgrid,ygrid,zgrid,ibool,idoubling, &

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/parallel.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/parallel.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/parallel.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -446,9 +446,6 @@
   integer sendcount, dest, sendtag, req
   real(kind=CUSTOM_REAL), dimension(sendcount) :: sendbuf
 
-! MPI status of messages to be received
-  integer msg_status(MPI_STATUS_SIZE)
-
   integer ier
 
   call MPI_ISSEND(sendbuf(1),sendcount,CUSTOM_MPI_TYPE,dest,sendtag, &
@@ -473,9 +470,6 @@
   integer recvcount, dest, recvtag, req
   real(kind=CUSTOM_REAL), dimension(recvcount) :: recvbuf
 
-! MPI status of messages to be received
-  integer msg_status(MPI_STATUS_SIZE)
-
   integer ier
 
   call MPI_IRECV(recvbuf(1),recvcount,CUSTOM_MPI_TYPE,dest,recvtag, &
@@ -500,9 +494,6 @@
   integer sendcount, dest, sendtag, req
   integer, dimension(sendcount) :: sendbuf
 
-! MPI status of messages to be received
-  integer msg_status(MPI_STATUS_SIZE)
-
   integer ier
 
   call MPI_ISSEND(sendbuf(1),sendcount,MPI_INTEGER,dest,sendtag, &
@@ -527,9 +518,6 @@
   integer recvcount, dest, recvtag, req
   integer, dimension(recvcount) :: recvbuf
 
-! MPI status of messages to be received
-  integer msg_status(MPI_STATUS_SIZE)
-
   integer ier
 
   call MPI_IRECV(recvbuf(1),recvcount,MPI_INTEGER,dest,recvtag, &
@@ -555,5 +543,5 @@
   integer :: ier
 
   call mpi_wait(req,req_mpi_status,ier)
-  
+
   end subroutine wait_req

Modified: seismo/3D/SPECFEM3D_SESAME/trunk/read_arrays_solver.f90
===================================================================
--- seismo/3D/SPECFEM3D_SESAME/trunk/read_arrays_solver.f90	2008-12-27 17:06:50 UTC (rev 13799)
+++ seismo/3D/SPECFEM3D_SESAME/trunk/read_arrays_solver.f90	2008-12-27 18:52:44 UTC (rev 13800)
@@ -43,7 +43,7 @@
 
   integer NSPEC_AB
   integer NGLOB_AB
-  
+
   logical OCEANS
 
   character(len=150) LOCAL_PATH



More information about the CIG-COMMITS mailing list