[cig-commits] r21898 - in seismo/3D/SPECFEM3D/trunk/src: generate_databases shared specfem3D

dkomati1 at geodynamics.org dkomati1 at geodynamics.org
Thu Apr 18 12:15:40 PDT 2013


Author: dkomati1
Date: 2013-04-18 12:15:40 -0700 (Thu, 18 Apr 2013)
New Revision: 21898

Modified:
   seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_mass_matrices.f90
   seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_regions_mesh.f90
   seismo/3D/SPECFEM3D/trunk/src/generate_databases/get_absorbing_boundary.f90
   seismo/3D/SPECFEM3D/trunk/src/generate_databases/save_arrays_solver.f90
   seismo/3D/SPECFEM3D/trunk/src/shared/constants.h.in
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_calling_routine.F90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_noDev.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_stacey_viscoelastic.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/detect_mesh_surfaces.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_receivers.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/pml_compute_accel_contribution.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/read_mesh_databases.f90
Log:
renamed some flags for clarity: RECVS_CAN_BE_BURIED_EXT_MESH to RECEIVERS_CAN_BE_BURIED etc.


Modified: seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_mass_matrices.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_mass_matrices.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_mass_matrices.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -42,8 +42,8 @@
 ! C-PML flag
   logical :: PML_CONDITIONS
 
-! Stacey boundary condition flag 
-  logical :: STACEY_ABSORBING_CONDITIONS 
+! Stacey boundary condition flag
+  logical :: STACEY_ABSORBING_CONDITIONS
 
 ! local parameters
   double precision :: weight
@@ -173,7 +173,7 @@
 
   ! Stacey absorbing conditions (adds C*deltat/2 contribution to the mass matrices on Stacey edges)
   if(STACEY_ABSORBING_CONDITIONS)call create_mass_matrices_Stacey(nglob,nspec,ibool)
-  
+
   ! ocean load mass matrix
   call create_mass_matrices_ocean_load(nglob,nspec,ibool)
 

Modified: seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_regions_mesh.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_regions_mesh.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/generate_databases/create_regions_mesh.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -293,25 +293,25 @@
     deallocate(xstore_dummy,ystore_dummy,zstore_dummy)
   endif
 
-  if(STACEY_ABSORBING_CONDITIONS)then 
-     if( ELASTIC_SIMULATION ) then 
-       deallocate(rmass) 
-       deallocate(rmassx,rmassy,rmassz) 
-     endif 
-     if( ACOUSTIC_SIMULATION) then 
-       deallocate(rmass_acoustic) 
-       deallocate(rmassz_acoustic) 
-     endif 
-  endif 
+  if(STACEY_ABSORBING_CONDITIONS)then
+     if( ELASTIC_SIMULATION ) then
+       deallocate(rmass)
+       deallocate(rmassx,rmassy,rmassz)
+     endif
+     if( ACOUSTIC_SIMULATION) then
+       deallocate(rmass_acoustic)
+       deallocate(rmassz_acoustic)
+     endif
+  endif
 
-  if(PML_CONDITIONS)then 
-     if( ELASTIC_SIMULATION ) then 
-       deallocate(rmass) 
-     endif 
-     if( ACOUSTIC_SIMULATION) then 
-       deallocate(rmass_acoustic) 
-     endif 
-  endif 
+  if(PML_CONDITIONS)then
+     if( ELASTIC_SIMULATION ) then
+       deallocate(rmass)
+     endif
+     if( ACOUSTIC_SIMULATION) then
+       deallocate(rmass_acoustic)
+     endif
+  endif
 
   if( POROELASTIC_SIMULATION) then
     deallocate(rmass_solid_poroelastic,rmass_fluid_poroelastic)
@@ -327,8 +327,8 @@
                         nspec2D_xmin,nspec2D_xmax,nspec2D_ymin,nspec2D_ymax, &
                         nspec2D_bottom,nspec2D_top,ANISOTROPY)
 
-  use generate_databases_par, only: STACEY_INSTEAD_OF_FREE_SURFACE,NGNOD,NGNOD2D,& 
-                                    PML_CONDITIONS,PML_INSTEAD_OF_FREE_SURFACE 
+  use generate_databases_par, only: STACEY_INSTEAD_OF_FREE_SURFACE,NGNOD,NGNOD2D,&
+                                    PML_CONDITIONS,PML_INSTEAD_OF_FREE_SURFACE
   use create_regions_mesh_ext_par
 
   implicit none

Modified: seismo/3D/SPECFEM3D/trunk/src/generate_databases/get_absorbing_boundary.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/generate_databases/get_absorbing_boundary.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/generate_databases/get_absorbing_boundary.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -448,7 +448,7 @@
          ! sets face infos
          ifree = ifree + 1
          free_surface_ispec(ifree) = ispec
-  
+
          ! gll points -- assuming NGLLX = NGLLY = NGLLZ
          igllfree = 0
          do j=1,NGLLY
@@ -501,7 +501,7 @@
          ! sets face infos
          ifree = ifree + 1
          free_surface_ispec(ifree) = ispec
-  
+
          ! gll points -- assuming NGLLX = NGLLY = NGLLZ
          igllfree = 0
          do j=1,NGLLY

Modified: seismo/3D/SPECFEM3D/trunk/src/generate_databases/save_arrays_solver.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/generate_databases/save_arrays_solver.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/generate_databases/save_arrays_solver.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -150,30 +150,30 @@
 
 ! absorbing boundary surface
   write(IOUT) num_abs_boundary_faces
-  if(PML_CONDITIONS)then 
-     if( num_abs_boundary_faces > 0 ) then 
-       write(IOUT) abs_boundary_ispec 
-       write(IOUT) abs_boundary_ijk 
-       write(IOUT) abs_boundary_jacobian2Dw 
-       write(IOUT) abs_boundary_normal 
+  if(PML_CONDITIONS)then
+     if( num_abs_boundary_faces > 0 ) then
+       write(IOUT) abs_boundary_ispec
+       write(IOUT) abs_boundary_ijk
+       write(IOUT) abs_boundary_jacobian2Dw
+       write(IOUT) abs_boundary_normal
      endif
   else
-     if( num_abs_boundary_faces > 0 ) then 
-       write(IOUT) abs_boundary_ispec 
-       write(IOUT) abs_boundary_ijk 
-       write(IOUT) abs_boundary_jacobian2Dw 
-       write(IOUT) abs_boundary_normal 
-       ! store mass matrix contributions 
-       if(ELASTIC_SIMULATION) then 
-         write(IOUT) rmassx 
-         write(IOUT) rmassy 
-         write(IOUT) rmassz 
+     if( num_abs_boundary_faces > 0 ) then
+       write(IOUT) abs_boundary_ispec
+       write(IOUT) abs_boundary_ijk
+       write(IOUT) abs_boundary_jacobian2Dw
+       write(IOUT) abs_boundary_normal
+       ! store mass matrix contributions
+       if(ELASTIC_SIMULATION) then
+         write(IOUT) rmassx
+         write(IOUT) rmassy
+         write(IOUT) rmassz
        endif
-       if(ACOUSTIC_SIMULATION) then 
-         write(IOUT) rmassz_acoustic 
-       endif 
-     endif 
-  endif 
+       if(ACOUSTIC_SIMULATION) then
+         write(IOUT) rmassz_acoustic
+       endif
+     endif
+  endif
 
   write(IOUT) nspec2D_xmin
   write(IOUT) nspec2D_xmax

Modified: seismo/3D/SPECFEM3D/trunk/src/shared/constants.h.in
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/shared/constants.h.in	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/shared/constants.h.in	2013-04-18 19:15:40 UTC (rev 21898)
@@ -216,16 +216,16 @@
   double precision, parameter :: USER_T0 = 0.0d0
 
 ! the receivers can be located inside the model
-  logical, parameter :: RECVS_CAN_BE_BURIED_EXT_MESH = .true.
-  logical, parameter :: SOURCES_CAN_BE_BURIED_EXT_MESH = .true.
+  logical, parameter :: RECEIVERS_CAN_BE_BURIED = .true.
+  logical, parameter :: SOURCES_CAN_BE_BURIED = .true.
 
 ! sources and receivers Z coordinates given directly instead of with depth
-  logical, parameter :: USE_SOURCES_RECVS_Z = .false.
+  logical, parameter :: USE_SOURCES_RECEIVERS_Z = .false.
 
 ! the seismograms are normal to surface
 ! Z record corresponds to the normal, while E and N are two tangent vectors
 ! that completes an orthonormal.
-  logical, parameter :: EXT_MESH_RECV_NORMAL = .false.
+  logical, parameter :: EXTERNAL_MESH_RECEIVERS_NORMAL = .false.
 
 
 !!-----------------------------------------------------------

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_calling_routine.F90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_calling_routine.F90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_calling_routine.F90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -467,11 +467,11 @@
              kappastore,mustore,jacobian,ibool, &
              ATTENUATION,deltat, &
              one_minus_sum_beta,factor_common, &
-             one_minus_sum_beta_kappa,factor_common_kappa, & 
+             one_minus_sum_beta_kappa,factor_common_kappa, &
              alphaval,betaval,gammaval, &
-             NSPEC_ATTENUATION_AB,NSPEC_ATTENUATION_AB_kappa, & 
-             R_trace,R_xx,R_yy,R_xy,R_xz,R_yz, & 
-             epsilondev_trace,epsilondev_xx,epsilondev_yy,epsilondev_xy, &  
+             NSPEC_ATTENUATION_AB,NSPEC_ATTENUATION_AB_kappa, &
+             R_trace,R_xx,R_yy,R_xy,R_xz,R_yz, &
+             epsilondev_trace,epsilondev_xx,epsilondev_yy,epsilondev_xy, &
              epsilondev_xz,epsilondev_yz,epsilon_trace_over_3, &
              ANISOTROPY,NSPEC_ANISO, &
              c11store,c12store,c13store,c14store,c15store,c16store,&
@@ -524,11 +524,11 @@
                   kappastore,mustore,jacobian,ibool, &
                   ATTENUATION,deltat, &
                   one_minus_sum_beta,factor_common, &
-                  one_minus_sum_beta_kappa,factor_common_kappa, & 
+                  one_minus_sum_beta_kappa,factor_common_kappa, &
                   b_alphaval,b_betaval,b_gammaval, &
-                  NSPEC_ATTENUATION_AB, NSPEC_ATTENUATION_AB_kappa, & 
-                  b_R_trace,b_R_xx,b_R_yy,b_R_xy,b_R_xz,b_R_yz, &  
-                  b_epsilondev_trace,b_epsilondev_xx,b_epsilondev_yy,b_epsilondev_xy, &  
+                  NSPEC_ATTENUATION_AB, NSPEC_ATTENUATION_AB_kappa, &
+                  b_R_trace,b_R_xx,b_R_yy,b_R_xy,b_R_xz,b_R_yz, &
+                  b_epsilondev_trace,b_epsilondev_xx,b_epsilondev_yy,b_epsilondev_xy, &
                   b_epsilondev_xz,b_epsilondev_yz,b_epsilon_trace_over_3, &
                   ANISOTROPY,NSPEC_ANISO, &
                   c11store,c12store,c13store,c14store,c15store,c16store,&

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_noDev.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_noDev.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_viscoelastic_noDev.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -31,7 +31,7 @@
                         hprimewgll_xx,hprimewgll_yy,hprimewgll_zz,&
                         wgllwgll_xy,wgllwgll_xz,wgllwgll_yz, &
                         kappastore,mustore,jacobian,ibool, &
-                        ATTENUATION,deltat,PML_CONDITIONS, & 
+                        ATTENUATION,deltat,PML_CONDITIONS, &
                         one_minus_sum_beta,factor_common, &
                         one_minus_sum_beta_kappa,factor_common_kappa, &
                         alphaval,betaval,gammaval, &
@@ -51,9 +51,9 @@
                         ispec2D_moho_top,ispec2D_moho_bot, &
                         num_phase_ispec_elastic,nspec_inner_elastic,nspec_outer_elastic, &
                         phase_ispec_inner_elastic,ispec_is_elastic,&
-                        abs_boundary_ijk,num_abs_boundary_faces,phase_is_inner,ispec_is_inner,abs_boundary_ispec) 
+                        abs_boundary_ijk,num_abs_boundary_faces,phase_is_inner,ispec_is_inner,abs_boundary_ispec)
 
-  use constants, only: NGLLX,NGLLY,NGLLZ,NDIM,N_SLS,SAVE_MOHO_MESH,ONE_THIRD,FOUR_THIRDS,IOUT,NGLLSQUARE 
+  use constants, only: NGLLX,NGLLY,NGLLZ,NDIM,N_SLS,SAVE_MOHO_MESH,ONE_THIRD,FOUR_THIRDS,IOUT,NGLLSQUARE
   use pml_par
   use fault_solver_dynamic, only : Kelvin_Voigt_eta
   use specfem_par, only : FULL_ATTENUATION_SOLID
@@ -126,7 +126,7 @@
   integer :: ispec2D_moho_top, ispec2D_moho_bot
 
 ! C-PML absorbing boundary conditions
-  logical :: PML_CONDITIONS 
+  logical :: PML_CONDITIONS
 
   logical, dimension(NSPEC_AB) :: ispec_is_elastic
 
@@ -182,15 +182,15 @@
   ! local C-PML absorbing boundary conditions parameters
   integer :: ispec_CPML
 
-! communication overlap  
-  logical, dimension(NSPEC_AB) :: ispec_is_inner  
-  logical :: phase_is_inner  
+! communication overlap
+  logical, dimension(NSPEC_AB) :: ispec_is_inner
+  logical :: phase_is_inner
 
-! outer boundary of CPML  
-  integer :: num_abs_boundary_faces  
-  integer :: abs_boundary_ijk(3,NGLLSQUARE,num_abs_boundary_faces)  
-  integer :: abs_boundary_ispec(num_abs_boundary_faces)  
-  integer :: igll,iface  
+! outer boundary of CPML
+  integer :: num_abs_boundary_faces
+  integer :: abs_boundary_ijk(3,NGLLSQUARE,num_abs_boundary_faces)
+  integer :: abs_boundary_ispec(num_abs_boundary_faces)
+  integer :: igll,iface
 
   imodulo_N_SLS = mod(N_SLS,3)
 
@@ -885,7 +885,7 @@
            ispec = abs_boundary_ispec(iface)
 
            if (ispec_is_inner(ispec) .eqv. phase_is_inner) then
-  
+
               if( ispec_is_elastic(ispec) ) then
 
                  ! reference gll points on boundary face

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_stacey_viscoelastic.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_stacey_viscoelastic.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_stacey_viscoelastic.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -88,7 +88,7 @@
 !! DK DK to this subroutine as an argument, otherwise it is allocated and deallocated every time the code
 !! DK DK enters this subroutine, thus this will be extremely slow, and also what the array contains
 !! DK DK will be lost between two calls
-!! VM VM I did it 
+!! VM VM I did it
   real(kind=CUSTOM_REAL) :: Veloc_dsm_boundary(3,Ntime_step_dsm,NGLLSQUARE,num_abs_boundary_faces)
   real(kind=CUSTOM_REAL) :: Tract_dsm_boundary(3,Ntime_step_dsm,NGLLSQUARE,num_abs_boundary_faces)
 
@@ -164,9 +164,9 @@
                  tz = rho_vp(i,j,k,ispec)*vn*nz + rho_vs(i,j,k,ispec)*(vz-vn*nz)
 
                  if (USE_VADIM) then
-                     tx = tx -Tract_dsm_boundary(1,it_dsm,igll,iface) 
-                     ty = ty -Tract_dsm_boundary(2,it_dsm,igll,iface) 
-                     tz = tz -Tract_dsm_boundary(3,it_dsm,igll,iface) 
+                     tx = tx -Tract_dsm_boundary(1,it_dsm,igll,iface)
+                     ty = ty -Tract_dsm_boundary(2,it_dsm,igll,iface)
+                     tz = tz -Tract_dsm_boundary(3,it_dsm,igll,iface)
                  endif
 
                  ! gets associated, weighted jacobian
@@ -212,9 +212,9 @@
   if (USE_VADIM) then
      if (phase_is_inner .eqv. .true.) then
         it_dsm = it_dsm + 1
-     end if
-  end if
-  
+     endif
+  endif
+
   end subroutine compute_stacey_viscoelastic
 
 !---------------------------------------------------------------------------------------
@@ -232,7 +232,7 @@
 
 !! DK DK why use 5 and not NGLLX here? (I assume 5 means 5 GLL points here?)
 !! VM VM fixed to NGLLX
-   real(kind=CUSTOM_REAL) :: dsm_boundary_tmp(3,Ntime_step_dsm,NGLLX,NGLLY)  
+   real(kind=CUSTOM_REAL) :: dsm_boundary_tmp(3,Ntime_step_dsm,NGLLX,NGLLY)
 
    it_dsm = 1
    !write(*,*) 'read dsm files',it_dsm

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/detect_mesh_surfaces.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/detect_mesh_surfaces.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/detect_mesh_surfaces.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -41,7 +41,7 @@
   if( ier /= 0 ) stop 'error allocating array for mesh surface'
 
 ! determines model surface
-  if (.not. RECVS_CAN_BE_BURIED_EXT_MESH .or. MOVIE_TYPE == 2) then
+  if (.not. RECEIVERS_CAN_BE_BURIED .or. MOVIE_TYPE == 2) then
 
     ! returns surface points/elements
     ! in ispec_is_surface_external_mesh / iglob_is_surface_external_mesh and

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_receivers.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_receivers.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_receivers.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -348,7 +348,7 @@
     y_target(irec) = stutm_y(irec)
 
     ! receiver's Z coordinate
-    if( USE_SOURCES_RECVS_Z ) then
+    if( USE_SOURCES_RECEIVERS_Z ) then
       ! alternative: burial depth is given as z value directly
       z_target(irec) = stbur(irec)
     else
@@ -389,7 +389,7 @@
 
               iglob = ibool(i,j,k,ispec)
 
-              if (.not. RECVS_CAN_BE_BURIED_EXT_MESH) then
+              if (.not. RECEIVERS_CAN_BE_BURIED) then
                 if ((.not. iglob_is_surface_external_mesh(iglob)) &
                   .or. (.not. ispec_is_surface_external_mesh(ispec))) then
                   cycle
@@ -493,7 +493,7 @@
     endif
 
     ! get normal to the face of the hexaedra if receiver is on the surface
-    if ((.not. RECVS_CAN_BE_BURIED_EXT_MESH) .and. &
+    if ((.not. RECEIVERS_CAN_BE_BURIED) .and. &
        .not. (ispec_selected_rec(irec) == 1)) then
       pt0_ix = -1
       pt0_iy = -1
@@ -612,7 +612,7 @@
       v_vector(3) = w_vector(1)*u_vector(2) - w_vector(2)*u_vector(1)
 
       ! build rotation matrice nu for seismograms
-      if (EXT_MESH_RECV_NORMAL) then
+      if (EXTERNAL_MESH_RECEIVERS_NORMAL) then
         !     East (u)
         nu(1,1,irec) = u_vector(1)
         nu(1,2,irec) = v_vector(1)
@@ -644,7 +644,7 @@
         nu(3,3,irec) = 1.d0
       endif
 
-    endif ! of if (.not. RECVS_CAN_BE_BURIED_EXT_MESH)
+    endif ! of if (.not. RECEIVERS_CAN_BE_BURIED)
 
   ! end of loop on all the stations
   enddo
@@ -842,7 +842,7 @@
         write(IMAIN,*) '     original UTM x: ',sngl(stutm_x(irec))
         write(IMAIN,*) '     original UTM y: ',sngl(stutm_y(irec))
       endif
-      if( USE_SOURCES_RECVS_Z ) then
+      if( USE_SOURCES_RECEIVERS_Z ) then
         write(IMAIN,*) '     original z: ',sngl(stbur(irec))
       else
         write(IMAIN,*) '     original depth: ',sngl(stbur(irec)),' m'
@@ -872,7 +872,7 @@
         write(IMAIN,*) '     UTM x: ',x_found(irec)
         write(IMAIN,*) '     UTM y: ',y_found(irec)
       endif
-      if( USE_SOURCES_RECVS_Z ) then
+      if( USE_SOURCES_RECEIVERS_Z ) then
         write(IMAIN,*) '     z: ',z_found(irec)
       else
         write(IMAIN,*) '     depth: ',dabs(z_found(irec) - elevation(irec)),' m'

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -187,7 +187,7 @@
       write(IMAIN,*) 'UTM projection:'
       write(IMAIN,*) '  UTM zone: ',UTM_PROJECTION_ZONE
     endif
-    if( USE_SOURCES_RECVS_Z ) then
+    if( USE_SOURCES_RECEIVERS_Z ) then
       write(IMAIN,*) '  (depth) becomes directly (z) coordinate'
     endif
   endif
@@ -255,7 +255,7 @@
     y_target_source = utm_y_source(isource)
 
     ! source Z coordinate
-    if( USE_SOURCES_RECVS_Z ) then
+    if( USE_SOURCES_RECEIVERS_Z ) then
       ! alternative: depth is given as z value directly
       z_target_source = depth(isource)
     else
@@ -302,7 +302,7 @@
 
             iglob = ibool(i,j,k,ispec)
 
-            if (.not. SOURCES_CAN_BE_BURIED_EXT_MESH) then
+            if (.not. SOURCES_CAN_BE_BURIED) then
               if ((.not. iglob_is_surface_external_mesh(iglob)) .or. (.not. ispec_is_surface_external_mesh(ispec))) then
                 cycle
               endif
@@ -359,7 +359,7 @@
     endif
 
     ! get normal to the face of the hexahedra if receiver is on the surface
-    if ((.not. SOURCES_CAN_BE_BURIED_EXT_MESH) .and. &
+    if ((.not. SOURCES_CAN_BE_BURIED) .and. &
        .not. (ispec_selected_source(isource) == 0)) then
 
       ! note: at this point, xi_source,.. are in range [1.0d0,NGLLX/Y/Z] for point sources only,
@@ -498,7 +498,7 @@
       nu_source(3,2,isource) = v_vector(3)
       nu_source(3,3,isource) = w_vector(3)
 
-    endif ! of if (.not. SOURCES_CAN_BE_BURIED_EXT_MESH)
+    endif ! of if (.not. SOURCES_CAN_BE_BURIED)
 
 ! *******************************************
 ! find the best (xi,eta,gamma) for the source
@@ -786,7 +786,7 @@
           write(IMAIN,*) '         UTM x: ',utm_x_source(isource)
           write(IMAIN,*) '         UTM y: ',utm_y_source(isource)
         endif
-        if( USE_SOURCES_RECVS_Z ) then
+        if( USE_SOURCES_RECEIVERS_Z ) then
           write(IMAIN,*) '         z: ',depth(isource),' km'
         else
           write(IMAIN,*) '         depth: ',depth(isource),' km'
@@ -803,7 +803,7 @@
           write(IMAIN,*) '         UTM x: ',x_found_source(isource)
           write(IMAIN,*) '         UTM y: ',y_found_source(isource)
         endif
-        if( USE_SOURCES_RECVS_Z ) then
+        if( USE_SOURCES_RECEIVERS_Z ) then
           write(IMAIN,*) '             z: ',z_found_source(isource)
         else
           write(IMAIN,*) '         depth: ',dabs(z_found_source(isource) - elevation(isource))/1000.,' km'

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/pml_compute_accel_contribution.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/pml_compute_accel_contribution.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/pml_compute_accel_contribution.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -447,7 +447,7 @@
                       )
 
               else if( ispec_is_acoustic(ispec) ) then
-   
+
                  potential_dot_dot_acoustic_CPML(i,j,k,ispec_CPML) =  fac4 * 1.0/kappal *jacobianl * &
                       ( A1 * potential_dot_acoustic(iglob) + A2 * potential_acoustic(iglob) + &
                       A3 * rmemory_potential_acoustic(i,j,k,ispec_CPML,1)+ &

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/read_mesh_databases.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/read_mesh_databases.f90	2013-04-18 19:09:49 UTC (rev 21897)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/read_mesh_databases.f90	2013-04-18 19:15:40 UTC (rev 21898)
@@ -189,9 +189,9 @@
             epsilondev_yz(NGLLX,NGLLY,NGLLZ,NSPEC_STRAIN_ONLY),stat=ier)
     if( ier /= 0 ) stop 'error allocating array epsilondev_xx etc.'
 
-    allocate(R_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa,N_SLS),& 
-             epsilondev_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier)  
-    if( ier /= 0 ) stop 'error allocating array R_trace etc.'  
+    allocate(R_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa,N_SLS),&
+             epsilondev_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier)
+    if( ier /= 0 ) stop 'error allocating array R_trace etc.'
 
     ! note: needed for argument of deville routine
     allocate(epsilon_trace_over_3(NGLLX,NGLLY,NGLLZ,NSPEC_ADJOINT),stat=ier)
@@ -202,9 +202,9 @@
             factor_common(N_SLS,NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB),stat=ier)
     if( ier /= 0 ) stop 'error allocating array one_minus_sum_beta etc.'
 
-    allocate(one_minus_sum_beta_kappa(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa), & 
-             factor_common_kappa(N_SLS,NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier) 
-    if( ier /= 0 ) stop 'error allocating array one_minus_sum_beta_kappa etc.'  
+    allocate(one_minus_sum_beta_kappa(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa), &
+             factor_common_kappa(N_SLS,NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier)
+    if( ier /= 0 ) stop 'error allocating array one_minus_sum_beta_kappa etc.'
 
     ! reads mass matrices
     read(27,iostat=ier) rmass
@@ -382,7 +382,7 @@
   if (USE_VADIM) then
      ! VM for new method
 !! DK DK for Vadim: these two arrays are undeclared, thus I comment them out for now otherwise the code does not compile
-!! VM VM : I already decalred these 2 array in specfem_par module 
+!! VM VM : I already decalred these 2 array in specfem_par module
      allocate(Veloc_dsm_boundary(3,Ntime_step_dsm,NGLLSQUARE,num_abs_boundary_faces))
      allocate(Tract_dsm_boundary(3,Ntime_step_dsm,NGLLSQUARE,num_abs_boundary_faces))
      open(unit=IIN_veloc_dsm,file=dsmname(1:len_trim(dsmname))//'vel.bin',status='old', &
@@ -394,30 +394,30 @@
      allocate(Tract_dsm_boundary(1,1,1,1))
   endif
 
-  if(PML_CONDITIONS)then 
-     if( num_abs_boundary_faces > 0 ) then 
-       read(27) abs_boundary_ispec 
-       read(27) abs_boundary_ijk 
-       read(27) abs_boundary_jacobian2Dw 
-       read(27) abs_boundary_normal 
+  if(PML_CONDITIONS)then
+     if( num_abs_boundary_faces > 0 ) then
+       read(27) abs_boundary_ispec
+       read(27) abs_boundary_ijk
+       read(27) abs_boundary_jacobian2Dw
+       read(27) abs_boundary_normal
      endif
   else
-     if( num_abs_boundary_faces > 0 ) then 
-       read(27) abs_boundary_ispec 
-       read(27) abs_boundary_ijk 
-       read(27) abs_boundary_jacobian2Dw 
-       read(27) abs_boundary_normal 
-       ! store mass matrix contributions 
-       if(ELASTIC_SIMULATION) then 
-         read(27) rmassx 
-         read(27) rmassy 
-         read(27) rmassz 
+     if( num_abs_boundary_faces > 0 ) then
+       read(27) abs_boundary_ispec
+       read(27) abs_boundary_ijk
+       read(27) abs_boundary_jacobian2Dw
+       read(27) abs_boundary_normal
+       ! store mass matrix contributions
+       if(ELASTIC_SIMULATION) then
+         read(27) rmassx
+         read(27) rmassy
+         read(27) rmassz
        endif
-       if(ACOUSTIC_SIMULATION) then 
-         read(27) rmassz_acoustic 
-       endif 
-     endif 
-  endif 
+       if(ACOUSTIC_SIMULATION) then
+         read(27) rmassz_acoustic
+       endif
+     endif
+  endif
 
   read(27) nspec2D_xmin
   read(27) nspec2D_xmax
@@ -800,9 +800,9 @@
     allocate(b_epsilon_trace_over_3(NGLLX,NGLLY,NGLLZ,NSPEC_ADJOINT),stat=ier)
     if( ier /= 0 ) stop 'error allocating array b_epsilon_trace_over_3'
 
-    ! allocates attenuation solids for considering kappa  
-    allocate(b_R_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa,N_SLS),&    
-             b_epsilondev_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier)    
+    ! allocates attenuation solids for considering kappa
+    allocate(b_R_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa,N_SLS),&
+             b_epsilondev_trace(NGLLX,NGLLY,NGLLZ,NSPEC_ATTENUATION_AB_kappa),stat=ier)
     if( ier /= 0 ) stop 'error allocating array b_R_trace etc.'
 
   else



More information about the CIG-COMMITS mailing list