[cig-commits] r17913 - in seismo/3D/SPECFEM3D/trunk: src/shared src/specfem3D utils/cmt_frechet

danielpeter at geodynamics.org danielpeter at geodynamics.org
Sat Feb 19 17:52:55 PST 2011


Author: danielpeter
Date: 2011-02-19 17:52:54 -0800 (Sat, 19 Feb 2011)
New Revision: 17913

Modified:
   seismo/3D/SPECFEM3D/trunk/src/shared/get_cmt.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_acoustic.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_elastic.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_acoustic.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_elastic.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/setup_sources_receivers.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/specfem3D_par.f90
   seismo/3D/SPECFEM3D/trunk/src/specfem3D/write_seismograms.f90
   seismo/3D/SPECFEM3D/trunk/utils/cmt_frechet/make_cmtsolution_files.f90
Log:
updates source variable names in SPECFEM3D/

Modified: seismo/3D/SPECFEM3D/trunk/src/shared/get_cmt.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/shared/get_cmt.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/shared/get_cmt.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -24,8 +24,8 @@
 !
 !=====================================================================
 
-  subroutine get_cmt(yr,jda,ho,mi,sec,t_cmt,hdur,lat,long,depth,moment_tensor,&
-                    DT,NSOURCES,tshift_cmt_original)
+  subroutine get_cmt(yr,jda,ho,mi,sec,tshift_cmt,hdur,lat,long,depth,moment_tensor,&
+                    DT,NSOURCES,min_tshift_cmt_original)
 
   implicit none
 
@@ -37,8 +37,8 @@
   double precision, intent(in) :: DT
 
   integer, intent(out) :: yr,jda,ho,mi
-  double precision, intent(out) :: sec,tshift_cmt_original
-  double precision, dimension(NSOURCES), intent(out) :: t_cmt,hdur,lat,long,depth
+  double precision, intent(out) :: sec,min_tshift_cmt_original
+  double precision, dimension(NSOURCES), intent(out) :: tshift_cmt,hdur,lat,long,depth
   double precision, dimension(6,NSOURCES), intent(out) :: moment_tensor
 
 !--- local variables below
@@ -53,7 +53,7 @@
   long(:) = 0.d0
   depth(:) = 0.d0
   t_shift(:) = 0.d0
-  t_cmt(:) = 0.d0
+  tshift_cmt(:) = 0.d0
   hdur(:) = 0.d0
   moment_tensor(:,:) = 0.d0
   yr = 0
@@ -88,7 +88,7 @@
 
     ! read time shift
     read(1,"(a)") string
-    !read(string(12:len_trim(string)),*) t_cmt(isource)
+    !read(string(12:len_trim(string)),*) tshift_cmt(isource)
     read(string(12:len_trim(string)),*) t_shift(isource)
 
     ! read half duration
@@ -148,13 +148,13 @@
 
   close(1)
 
-  ! Sets t_cmt to zero to initiate the simulation!
+  ! Sets tshift_cmt to zero to initiate the simulation!
   if(NSOURCES == 1)then
-      t_cmt = 0.d0
-      tshift_cmt_original = t_shift(1)
+      tshift_cmt = 0.d0
+      min_tshift_cmt_original = t_shift(1)
   else
-      t_cmt(1:NSOURCES) = t_shift(1:NSOURCES)-minval(t_shift)
-      tshift_cmt_original = minval(t_shift)
+      tshift_cmt(1:NSOURCES) = t_shift(1:NSOURCES)-minval(t_shift)
+      min_tshift_cmt_original = minval(t_shift)
   endif
 
 

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_acoustic.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_acoustic.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_acoustic.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -30,7 +30,7 @@
                                   ibool,ispec_is_inner,phase_is_inner, &
                                   NSOURCES,myrank,it,islice_selected_source,ispec_selected_source,&
                                   xi_source,eta_source,gamma_source, &
-                                  hdur,hdur_gaussian,t_cmt,dt,t0, &
+                                  hdur,hdur_gaussian,tshift_cmt,dt,t0, &
                                   sourcearrays,kappastore,ispec_is_acoustic,&
                                   SIMULATION_TYPE,NSTEP,NGLOB_ADJOINT, &
                                   nrec,islice_selected_rec,ispec_selected_rec, &
@@ -62,7 +62,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(NSOURCES) :: hdur,hdur_gaussian,t_cmt
+  double precision, dimension(NSOURCES) :: hdur,hdur_gaussian,tshift_cmt
   double precision :: dt,t0
   real(kind=CUSTOM_REAL), dimension(NSOURCES,NDIM,NGLLX,NGLLY,NGLLZ) :: sourcearrays
 
@@ -127,11 +127,11 @@
               !endif
 
               ! gaussian source time function
-              !stf_used = comp_source_time_function(dble(it-1)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              !stf_used = comp_source_time_function(dble(it-1)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! 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.
-              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(it-1)*DT-t0-t_cmt(isource),f0)
+              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(it-1)*DT-t0-tshift_cmt(isource),f0)
 
               ! beware, for acoustic medium, source is: pressure divided by Kappa of the fluid
               ! the sign is negative because pressure p = - Chi_dot_dot therefore we need
@@ -147,10 +147,10 @@
             else
 
               ! gaussian source time
-              stf = comp_source_time_function_gauss(dble(it-1)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              stf = comp_source_time_function_gauss(dble(it-1)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! quasi-heaviside
-              !stf = comp_source_time_function(dble(it-1)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              !stf = comp_source_time_function(dble(it-1)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! distinguishes between single and double precision for reals
               if(CUSTOM_REAL == SIZE_REAL) then
@@ -321,11 +321,11 @@
               !endif
 
               ! gaussian source time function
-              !stf_used = comp_source_time_function(dble(it-1)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              !stf_used = comp_source_time_function(dble(it-1)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! 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.
-              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(NSTEP-it)*DT-t0-t_cmt(isource),f0)
+              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(NSTEP-it)*DT-t0-tshift_cmt(isource),f0)
 
               ! beware, for acoustic medium, source is: pressure divided by Kappa of the fluid
               ! the sign is negative because pressure p = - Chi_dot_dot therefore we need
@@ -341,7 +341,7 @@
             else
 
               ! gaussian source time
-              stf = comp_source_time_function_gauss(dble(NSTEP-it)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              stf = comp_source_time_function_gauss(dble(NSTEP-it)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! distinguishes between single and double precision for reals
               if(CUSTOM_REAL == SIZE_REAL) then

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_elastic.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_elastic.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_add_sources_elastic.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -30,7 +30,7 @@
                         ibool,ispec_is_inner,phase_is_inner, &
                         NSOURCES,myrank,it,islice_selected_source,ispec_selected_source,&
                         xi_source,eta_source,gamma_source,nu_source, &
-                        hdur,hdur_gaussian,t_cmt,dt,t0,sourcearrays, &
+                        hdur,hdur_gaussian,tshift_cmt,dt,t0,sourcearrays, &
                         ispec_is_elastic,SIMULATION_TYPE,NSTEP,NGLOB_ADJOINT, &
                         nrec,islice_selected_rec,ispec_selected_rec, &
                         nadj_rec_local,adj_sourcearrays,b_accel, &
@@ -67,7 +67,7 @@
   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(NSOURCES) :: hdur,hdur_gaussian,t_cmt
+  double precision, dimension(NSOURCES) :: hdur,hdur_gaussian,tshift_cmt
   double precision :: dt,t0
   real(kind=CUSTOM_REAL), dimension(NSOURCES,NDIM,NGLLX,NGLLY,NGLLZ) :: sourcearrays
 
@@ -130,7 +130,7 @@
               !endif
 
               ! This is the expression of a Ricker; should be changed according maybe to the Par_file.
-              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(it-1)*DT-t0-t_cmt(isource),f0)
+              stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(it-1)*DT-t0-tshift_cmt(isource),f0)
 
               ! we use a force in a single direction along one of the components:
               !  x/y/z or E/N/Z-direction would correspond to 1/2/3 = COMPONENT_FORCE_SOURCE
@@ -140,7 +140,7 @@
 
             else
 
-               stf = comp_source_time_function(dble(it-1)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+               stf = comp_source_time_function(dble(it-1)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
                !     distinguish between single and double precision for reals
                if(CUSTOM_REAL == SIZE_REAL) then
@@ -303,7 +303,7 @@
                !endif
 
                ! This is the expression of a Ricker; should be changed according maybe to the Par_file.
-               stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(NSTEP-it)*DT-t0-t_cmt(isource),f0)
+               stf_used = FACTOR_FORCE_SOURCE * comp_source_time_function_rickr(dble(NSTEP-it)*DT-t0-tshift_cmt(isource),f0)
 
                ! e.g. we use nu_source(:,3) here if we want a source normal to the surface.
                ! note: time step is now at NSTEP-it
@@ -314,7 +314,7 @@
 
               ! see note above: time step corresponds now to NSTEP-it
               ! (also compare to it-1 for forward simulation)
-              stf = comp_source_time_function(dble(NSTEP-it)*DT-t0-t_cmt(isource),hdur_gaussian(isource))
+              stf = comp_source_time_function(dble(NSTEP-it)*DT-t0-tshift_cmt(isource),hdur_gaussian(isource))
 
               ! distinguish between single and double precision for reals
               if(CUSTOM_REAL == SIZE_REAL) then

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_acoustic.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_acoustic.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_acoustic.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -201,7 +201,7 @@
                         ibool,ispec_is_inner,phase_is_inner, &
                         NSOURCES,myrank,it,islice_selected_source,ispec_selected_source,&
                         xi_source,eta_source,gamma_source, &
-                        hdur,hdur_gaussian,t_cmt,dt,t0, &
+                        hdur,hdur_gaussian,tshift_cmt,dt,t0, &
                         sourcearrays,kappastore,ispec_is_acoustic,&
                         SIMULATION_TYPE,NSTEP,NGLOB_ADJOINT, &
                         nrec,islice_selected_rec,ispec_selected_rec, &

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_elastic.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_elastic.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/compute_forces_elastic.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -207,7 +207,7 @@
                         ibool,ispec_is_inner,phase_is_inner, &
                         NSOURCES,myrank,it,islice_selected_source,ispec_selected_source,&
                         xi_source,eta_source,gamma_source,nu_source, &
-                        hdur,hdur_gaussian,t_cmt,dt,t0,sourcearrays, &
+                        hdur,hdur_gaussian,tshift_cmt,dt,t0,sourcearrays, &
                         ispec_is_elastic,SIMULATION_TYPE,NSTEP,NGLOB_ADJOINT, &
                         nrec,islice_selected_rec,ispec_selected_rec, &
                         nadj_rec_local,adj_sourcearrays,b_accel, &

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/locate_source.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -30,7 +30,7 @@
 
   subroutine locate_source(ibool,NSOURCES,myrank,NSPEC_AB,NGLOB_AB,xstore,ystore,zstore, &
                  xigll,yigll,zigll,NPROC, &
-                 t_cmt,tshift_cmt_original,yr,jda,ho,mi,utm_x_source,utm_y_source, &
+                 tshift_cmt,min_tshift_cmt_original,yr,jda,ho,mi,utm_x_source,utm_y_source, &
                  DT,hdur,Mxx,Myy,Mzz,Mxy,Mxz,Myz, &
                  islice_selected_source,ispec_selected_source, &
                  xi_source,eta_source,gamma_source, &
@@ -62,8 +62,8 @@
 
   integer yr,jda,ho,mi
 
-  double precision t_cmt(NSOURCES)
-  double precision sec,tshift_cmt_original
+  double precision tshift_cmt(NSOURCES)
+  double precision sec,min_tshift_cmt_original
 
   integer iprocloop
 
@@ -160,8 +160,8 @@
   call get_value_string(OUTPUT_FILES, 'OUTPUT_FILES', OUTPUT_FILES_PATH(1:len_trim(OUTPUT_FILES_PATH)))
 
   ! read all the sources (note: each process reads the source file)
-  call get_cmt(yr,jda,ho,mi,sec,t_cmt,hdur,lat,long,depth,moment_tensor, &
-              DT,NSOURCES,tshift_cmt_original)
+  call get_cmt(yr,jda,ho,mi,sec,tshift_cmt,hdur,lat,long,depth,moment_tensor, &
+              DT,NSOURCES,min_tshift_cmt_original)
 
   ! define topology of the control element
   call usual_hex_nodes(iaddx,iaddy,iaddz)
@@ -798,7 +798,7 @@
           write(IMAIN,*) '  using a source of dominant frequency ',f0
           write(IMAIN,*) '  lambda_S at dominant frequency = ',3000./sqrt(3.)/f0
           write(IMAIN,*) '  lambda_S at highest significant frequency = ',3000./sqrt(3.)/(2.5*f0)
-          write(IMAIN,*) '  t0_ricker = ',t0_ricker,'t_cmt = ',t_cmt(isource)
+          write(IMAIN,*) '  t0_ricker = ',t0_ricker,'tshift_cmt = ',tshift_cmt(isource)
           write(IMAIN,*)
           write(IMAIN,*) '  half duration -> frequency: ',hdur(isource),' seconds**(-1)'
         else
@@ -814,7 +814,7 @@
           endif
           write(IMAIN,*) '  half duration: ',hdur(isource),' seconds'
         endif
-        write(IMAIN,*) '  time shift: ',t_cmt(isource),' seconds'
+        write(IMAIN,*) '  time shift: ',tshift_cmt(isource),' seconds'
         write(IMAIN,*)
         write(IMAIN,*) 'original (requested) position of the source:'
         write(IMAIN,*)

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/setup_sources_receivers.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/setup_sources_receivers.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/setup_sources_receivers.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -70,7 +70,7 @@
   use specfem_par_movie
   implicit none
 
-  double precision :: t0_ac,tshift_cmt_original
+  double precision :: t0_acoustic,min_tshift_cmt_original
   integer :: yr,jda,ho,mi
   integer :: isource,ispec
 
@@ -86,7 +86,7 @@
   allocate(xi_source(NSOURCES))
   allocate(eta_source(NSOURCES))
   allocate(gamma_source(NSOURCES))
-  allocate(t_cmt(NSOURCES))
+  allocate(tshift_cmt(NSOURCES))
   allocate(hdur(NSOURCES))
   allocate(hdur_gaussian(NSOURCES))
   allocate(utm_x_source(NSOURCES))
@@ -99,7 +99,7 @@
 !                xi_source, eta_source & gamma_source
   call locate_source(ibool,NSOURCES,myrank,NSPEC_AB,NGLOB_AB, &
           xstore,ystore,zstore,xigll,yigll,zigll,NPROC, &
-          t_cmt,tshift_cmt_original,yr,jda,ho,mi,utm_x_source,utm_y_source, &
+          tshift_cmt,min_tshift_cmt_original,yr,jda,ho,mi,utm_x_source,utm_y_source, &
           DT,hdur,Mxx,Myy,Mzz,Mxy,Mxz,Myz, &
           islice_selected_source,ispec_selected_source, &
           xi_source,eta_source,gamma_source, &
@@ -109,7 +109,7 @@
           ispec_is_acoustic,ispec_is_elastic, &
           num_free_surface_faces,free_surface_ispec,free_surface_ijk)
 
-  if(abs(minval(t_cmt)) > TINYVAL) call exit_MPI(myrank,'one t_cmt must be zero, others must be positive')
+  if(abs(minval(tshift_cmt)) > TINYVAL) call exit_MPI(myrank,'one tshift_cmt must be zero, others must be positive')
 
 ! filter source time function by Gaussian with hdur = HDUR_MOVIE when outputing movies or shakemaps
   if (MOVIE_SURFACE .or. MOVIE_VOLUME .or. CREATE_SHAKEMAP) then
@@ -127,24 +127,24 @@
   ! define t0 as the earliest start time
   ! note: an earlier start time also reduces numerical noise due to a
   !          non-zero offset at the beginning of the source time function
-  t0 = - 2.0d0 * minval(t_cmt(:) - hdur(:))   ! - 1.5d0 * minval(t_cmt-hdur)
+  t0 = - 2.0d0 * minval(tshift_cmt(:) - hdur(:))   ! - 1.5d0 * minval(tshift_cmt-hdur)
 
   ! uses an earlier start time if source is acoustic with a gaussian source time function
-  t0_ac = 0.0d0
+  t0_acoustic = 0.0d0
   do isource = 1,NSOURCES
     if( myrank == islice_selected_source(isource) ) then
       ispec = ispec_selected_source(isource)
       if( ispec_is_acoustic(ispec) ) then
         ! uses an earlier start time
-        t0_ac = - 3.0d0 * ( t_cmt(isource) - hdur(isource) )
-        if(  t0_ac > t0 ) t0 = t0_ac
+        t0_acoustic = - 3.0d0 * ( tshift_cmt(isource) - hdur(isource) )
+        if(  t0_acoustic > t0 ) t0 = t0_acoustic
       endif
     endif
   enddo
   ! passes maximum value to all processes
   ! note: t0 is defined positive and will be subtracted from simulation time (it-1)*DT
-  t0_ac = t0
-  call max_all_all_dp(t0_ac,t0)
+  t0_acoustic = t0
+  call max_all_all_dp(t0_acoustic,t0)
 
   ! point force sources will start depending on the frequency given by hdur
   if( USE_FORCE_POINT_SOURCE ) then
@@ -152,7 +152,7 @@
     !          thus the main period is 1/hdur.
     !          also, these sources use a Ricker source time function instead of a gaussian.
     !          for a Ricker source time function, a start time ~1.2 * main_period is a good choice
-    t0 = - 1.2d0 * minval(t_cmt(:) - 1.0d0/hdur(:))
+    t0 = - 1.2d0 * minval(tshift_cmt(:) - 1.0d0/hdur(:))
   endif
 
   ! checks if user set USER_T0 to fix simulation start time
@@ -165,17 +165,17 @@
     ! notifies user
     if( myrank == 0 ) then
       write(IMAIN,*) 'USER_T0: ',USER_T0
-      write(IMAIN,*) 't0: ',t0,'tshift_cmt_original: ',tshift_cmt_original
+      write(IMAIN,*) 't0: ',t0,'min_tshift_cmt_original: ',min_tshift_cmt_original
       write(IMAIN,*)
     endif
 
     ! checks if automatically set t0 is too small
-    ! note: tshift_cmt_original can be a positive or negative time shift (minimum from all tshift)
-    if( t0 <= USER_T0 + tshift_cmt_original ) then
-      ! by default, t_cmt(:) holds relative time shifts with a minimum time shift set to zero
+    ! note: min_tshift_cmt_original can be a positive or negative time shift (minimum from all tshift)
+    if( t0 <= USER_T0 + min_tshift_cmt_original ) then
+      ! by default, tshift_cmt(:) holds relative time shifts with a minimum time shift set to zero
       ! re-adds (minimum) original time shift such that sources will kick in
       ! according to their absolute time shift
-      t_cmt(:) = t_cmt(:) + tshift_cmt_original
+      tshift_cmt(:) = tshift_cmt(:) + min_tshift_cmt_original
 
       ! sets new simulation start time such that
       ! simulation starts at t = - t0 = - USER_T0
@@ -192,7 +192,7 @@
       if( myrank == 0 ) then
         write(IMAIN,*) 'error: USER_T0 is too small'
         write(IMAIN,*) '       must make one of three adjustements:'
-        write(IMAIN,*) '       - increase USER_T0 to be at least: ',t0-tshift_cmt_original
+        write(IMAIN,*) '       - increase USER_T0 to be at least: ',t0-min_tshift_cmt_original
         write(IMAIN,*) '       - decrease time shift in CMTSOLUTION file'
         write(IMAIN,*) '       - decrease hdur in CMTSOLUTION file'
       endif

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/specfem3D_par.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/specfem3D_par.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/specfem3D_par.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -92,7 +92,7 @@
   double precision, dimension(:,:,:), allocatable :: nu_source
   double precision, dimension(:), allocatable :: Mxx,Myy,Mzz,Mxy,Mxz,Myz
   double precision, dimension(:), allocatable :: xi_source,eta_source,gamma_source
-  double precision, dimension(:), allocatable :: t_cmt,hdur,hdur_gaussian
+  double precision, dimension(:), allocatable :: tshift_cmt,hdur,hdur_gaussian
   double precision, dimension(:), allocatable :: utm_x_source,utm_y_source
   double precision, external :: comp_source_time_function
   double precision :: t0

Modified: seismo/3D/SPECFEM3D/trunk/src/specfem3D/write_seismograms.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/src/specfem3D/write_seismograms.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/src/specfem3D/write_seismograms.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -129,7 +129,7 @@
                       etax(:,:,:,ispec),etay(:,:,:,ispec),etaz(:,:,:,ispec), &
                       gammax(:,:,:,ispec),gammay(:,:,:,ispec),gammaz(:,:,:,ispec))
 
-        stf = comp_source_time_function(dble(NSTEP-it)*DT-t0-t_cmt(irec),hdur_gaussian(irec))
+        stf = comp_source_time_function(dble(NSTEP-it)*DT-t0-tshift_cmt(irec),hdur_gaussian(irec))
         stf_deltat = stf * deltat
         Mxx_der(irec_local) = Mxx_der(irec_local) + eps_s(1,1) * stf_deltat
         Myy_der(irec_local) = Myy_der(irec_local) + eps_s(2,2) * stf_deltat

Modified: seismo/3D/SPECFEM3D/trunk/utils/cmt_frechet/make_cmtsolution_files.f90
===================================================================
--- seismo/3D/SPECFEM3D/trunk/utils/cmt_frechet/make_cmtsolution_files.f90	2011-02-20 01:32:29 UTC (rev 17912)
+++ seismo/3D/SPECFEM3D/trunk/utils/cmt_frechet/make_cmtsolution_files.f90	2011-02-20 01:52:54 UTC (rev 17913)
@@ -32,7 +32,7 @@
   include "cmt.h"
 
   integer yr,jda,ho,mi
-  double precision sec,t_cmt,hdur,lat,long,depth
+  double precision sec,tshift_cmt,hdur,lat,long,depth
   double precision moment_tensor(6)
   character(len=256) cmt_file
 
@@ -80,7 +80,7 @@
           write(iu,"(a)") string(1:lstr)
         enddo
       else if(string(1:10) == 'time shift') then
-        read(string(12:lstr),*) t_cmt
+        read(string(12:lstr),*) tshift_cmt
         do iu=2,10
           write(iu,"(a)") string(1:lstr)
         enddo



More information about the CIG-COMMITS mailing list