[cig-commits] [commit] devel,master: added Roland_Sylvain integrals; also fixed a few typos in comments (9e5dcc4)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Thu Nov 6 08:13:01 PST 2014


Repository : https://github.com/geodynamics/specfem3d_globe

On branches: devel,master
Link       : https://github.com/geodynamics/specfem3d_globe/compare/bc58e579b3b0838a0968725a076f5904845437ca...be63f20cbb6f462104e949894dbe205d2398cd7f

>---------------------------------------------------------------

commit 9e5dcc418781fb9ade919e1f42cbbcf9e3eb6089
Author: Dimitri Komatitsch <komatitsch at lma.cnrs-mrs.fr>
Date:   Thu May 1 11:11:03 2014 +0200

    added Roland_Sylvain integrals; also fixed a few typos in comments


>---------------------------------------------------------------

9e5dcc418781fb9ade919e1f42cbbcf9e3eb6089
 setup/constants.h.in                        |   7 ++
 src/cuda/save_and_compare_cpu_vs_gpu.c      |   4 +-
 src/meshfem3D/compute_volumes_and_areas.f90 | 164 ++++++++++++++++++++++++++++
 src/meshfem3D/create_MPI_interfaces.f90     |   2 -
 src/meshfem3D/create_meshes.f90             |   3 +-
 src/meshfem3D/create_regions_mesh.F90       |  11 +-
 src/meshfem3D/finalize_mesher.f90           |  29 ++++-
 src/meshfem3D/get_MPI_interfaces.f90        |   1 -
 src/meshfem3D/meshfem3D_models.f90          |   2 +-
 src/meshfem3D/meshfem3D_par.f90             |   3 +
 src/meshfem3D/model_1dref.f90               |   2 +-
 src/meshfem3D/model_atten3D_QRFSI12.f90     |   2 +-
 src/meshfem3D/model_attenuation.f90         |   5 +-
 src/meshfem3D/model_crust_1_0.f90           |   2 +-
 src/meshfem3D/model_crustmaps.f90           |   2 +-
 src/shared/shared_par.f90                   |   2 +-
 16 files changed, 222 insertions(+), 19 deletions(-)

diff --git a/setup/constants.h.in b/setup/constants.h.in
index d7a0bad..655f912 100644
--- a/setup/constants.h.in
+++ b/setup/constants.h.in
@@ -107,6 +107,7 @@
 !! pathname of the topography file
 !  character (len=*), parameter :: PATHNAME_TOPO_FILE = 'DATA/topo_bathy/topo_bathy_etopo5_smoothed_Harvard.dat'
 
+!! DK DK for Roland_Sylvain this below could be changed if needed (i.e. using a non-smoothed version for instance)
 !---  ETOPO4 4-minute model created by subsampling and smoothing etopo-2
 ! size of topography and bathymetry file
   integer, parameter :: NX_BATHY = 5400,NY_BATHY = 2700
@@ -463,6 +464,12 @@
 ! to be constistent with the D80 discontinuity, we impose the crust only above it
   double precision, parameter :: R_DEEPEST_CRUST = (R_EARTH - 80000.d0) / R_EARTH
 
+! definition of an Eotvos compared to S.I. units.
+! The unit of gravity gradient is the Eotvos, which is equivalent to 1e-9 s-2 (or 1e-4 mGal/m).
+! A person walking at a distance of 2 meters provides a gravity gradient signal of approximately one Eotvos.
+! Mountains can create signals of several hundred Eotvos.
+  double precision, parameter :: SI_UNITS_TO_EOTVOS = 1.d+9
+
 ! maximum number of chunks (full sphere)
   integer, parameter :: NCHUNKS_MAX = 6
 
diff --git a/src/cuda/save_and_compare_cpu_vs_gpu.c b/src/cuda/save_and_compare_cpu_vs_gpu.c
index 96abac7..19a65d8 100644
--- a/src/cuda/save_and_compare_cpu_vs_gpu.c
+++ b/src/cuda/save_and_compare_cpu_vs_gpu.c
@@ -265,7 +265,7 @@ void compare_fvector_(float* vector, int* size, int* id, int* cpu_or_gpu) {
   size_t res;
 
   float* compare_vector = (float*)malloc(*size*sizeof(float));
-  if(*cpu_or_gpu == 0) { //swap GPU/CPU for compare
+  if(*cpu_or_gpu == 0) { //swap GPU/CPU to compare
     sprintf(cmp_filename, "debug_output_gpu_%d.dat",*id);
   }
   else {
@@ -313,7 +313,7 @@ void compare_ivector_(int* vector, int* size, int* id, int* cpu_or_gpu) {
   size_t res;
 
   int* compare_vector = (int*)malloc(*size*sizeof(int));
-  if(*cpu_or_gpu == 0) { //swap GPU/CPU for compare
+  if(*cpu_or_gpu == 0) { //swap GPU/CPU to compare
     sprintf(cmp_filename, "debug_output_gpu_%d.dat",*id);
   }
   else {
diff --git a/src/meshfem3D/compute_volumes_and_areas.f90 b/src/meshfem3D/compute_volumes_and_areas.f90
index 2bbd45a..adcf05b 100644
--- a/src/meshfem3D/compute_volumes_and_areas.f90
+++ b/src/meshfem3D/compute_volumes_and_areas.f90
@@ -255,3 +255,167 @@
 
   end subroutine compute_Earth_mass
 
+!=====================================================================
+
+  ! compute Roland_Sylvain integrals of that part of the slice, and then total integrals for the whole Earth
+
+  subroutine compute_Roland_Sylvain_integr(myrank,Roland_Sylvain_integr_total, &
+                            nspec,wxgll,wygll,wzgll,xstore,ystore,zstore,xixstore,xiystore,xizstore, &
+                            etaxstore,etaystore,etazstore,gammaxstore,gammaystore,gammazstore,rhostore,idoubling)
+
+  use constants
+
+  implicit none
+
+  double precision, dimension(9) :: Roland_Sylvain_integr_total
+
+  integer :: myrank
+  integer :: nspec
+  double precision :: wxgll(NGLLX),wygll(NGLLY),wzgll(NGLLZ)
+
+  integer,dimension(nspec) :: idoubling
+
+  double precision,dimension(NGLLX,NGLLY,NGLLZ,nspec) :: xstore,ystore,zstore
+
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLY,NGLLZ,nspec) :: &
+    xixstore,xiystore,xizstore,etaxstore,etaystore,etazstore,gammaxstore,gammaystore,gammazstore
+
+  real(kind=CUSTOM_REAL),dimension(NGLLX,NGLLY,NGLLZ,nspec) :: rhostore
+
+  ! local parameters
+  double precision :: weight
+  real(kind=CUSTOM_REAL) :: xixl,xiyl,xizl,etaxl,etayl,etazl,gammaxl,gammayl,gammazl
+  double precision :: jacobianl
+  integer :: i,j,k,ispec
+  double precision :: xval,yval,zval
+  double precision :: distance,distance_squared,distance_cubed,distance_fifth_power, &
+                      one_over_distance_squared,one_over_distance_cubed,one_over_distance_fifth_power
+
+  double precision, dimension(9) :: Roland_Sylvain_int_local,Roland_Sylvain_int_total_region,elemental_contribution
+
+  ! take into account the fact that the density and the radius of the Earth have previously been non-dimensionalized
+  double precision, parameter :: non_dimensionalizing_factor = RHOAV*R_EARTH**3
+
+!! DK DK position of the observation point in non-dimensional value
+  double precision, parameter :: altitude_of_observation_point = 255.d0 ! in km
+
+  double precision, parameter :: SQUARE_ROOT_OF_THREE = 1.732050808d0
+
+!! DK DK along X only
+! double precision, parameter :: xobs = (R_EARTH_KM + altitude_of_observation_point) / R_EARTH_KM
+! double precision, parameter :: yobs = 0.d0
+! double precision, parameter :: zobs = 0.d0
+
+!! DK DK along diagonal
+  double precision, parameter :: xobs = (R_EARTH_KM + altitude_of_observation_point) / R_EARTH_KM / SQUARE_ROOT_OF_THREE
+  double precision, parameter :: yobs = xobs
+  double precision, parameter :: zobs = xobs
+
+!! DK DK point randomly chosen in space, not at the right elevation we want
+! double precision, parameter :: xobs = (R_EARTH_KM + altitude_of_observation_point) / R_EARTH_KM / SQUARE_ROOT_OF_THREE
+! double precision, parameter :: yobs = xobs * 1.12d0
+! double precision, parameter :: zobs = xobs * 1.38d0
+
+  ! initializes
+  Roland_Sylvain_int_local(:) = ZERO
+
+  ! calculates volume of all elements in mesh
+  do ispec = 1,nspec
+
+    ! suppress fictitious elements in central cube
+    if(idoubling(ispec) == IFLAG_IN_FICTITIOUS_CUBE) cycle
+
+    do k = 1,NGLLZ
+      do j = 1,NGLLY
+        do i = 1,NGLLX
+
+          weight = wxgll(i)*wygll(j)*wzgll(k)
+
+          ! compute the jacobian
+          xixl = xixstore(i,j,k,ispec)
+          xiyl = xiystore(i,j,k,ispec)
+          xizl = xizstore(i,j,k,ispec)
+          etaxl = etaxstore(i,j,k,ispec)
+          etayl = etaystore(i,j,k,ispec)
+          etazl = etazstore(i,j,k,ispec)
+          gammaxl = gammaxstore(i,j,k,ispec)
+          gammayl = gammaystore(i,j,k,ispec)
+          gammazl = gammazstore(i,j,k,ispec)
+
+!! DK DK do this in double precision for accuracy
+          jacobianl = 1.d0 / dble(xixl*(etayl*gammazl-etazl*gammayl) &
+                        - xiyl*(etaxl*gammazl-etazl*gammaxl) &
+                        + xizl*(etaxl*gammayl-etayl*gammaxl))
+
+    xval = xstore(i,j,k,ispec) - xobs
+    yval = ystore(i,j,k,ispec) - yobs
+    zval = zstore(i,j,k,ispec) - zobs
+
+!! DK DK see later if the non-dimensional values are correctly handled here (I will check more carefully)
+    distance_squared = xval**2 + yval**2 + zval**2
+    distance = sqrt(distance_squared)
+    distance_cubed = distance_squared*distance
+    distance_fifth_power = distance_squared*distance_cubed
+
+    one_over_distance_squared = 1.d0 / distance_squared
+    one_over_distance_cubed = 1.d0 / distance_cubed
+!!!!!!!!!!!!!    one_over_distance_fifth_power = 1.d0 / distance_fifth_power
+!! DK DK this will be faster
+    one_over_distance_fifth_power = one_over_distance_squared * one_over_distance_cubed
+
+! g_x
+    elemental_contribution(1) = xval * one_over_distance_cubed
+
+! g_y
+    elemental_contribution(2) = yval * one_over_distance_cubed
+
+! g_z
+    elemental_contribution(3) = zval * one_over_distance_cubed
+
+! G_xx
+    elemental_contribution(4) = (3.d0 * xval**2 * one_over_distance_squared - 1.d0) * one_over_distance_cubed
+
+! G_yy
+    elemental_contribution(5) = (3.d0 * yval**2 * one_over_distance_squared - 1.d0) * one_over_distance_cubed
+
+! G_zz
+    elemental_contribution(6) = (3.d0 * zval**2 * one_over_distance_squared - 1.d0) * one_over_distance_cubed
+
+! G_xy
+    elemental_contribution(7) = 3.d0 * xval*yval * one_over_distance_fifth_power
+
+! G_xz
+    elemental_contribution(8) = 3.d0 * xval*zval * one_over_distance_fifth_power
+
+! G_yz
+    elemental_contribution(9) = 3.d0 * yval*zval * one_over_distance_fifth_power
+
+    Roland_Sylvain_int_local(:) = Roland_Sylvain_int_local(:) + jacobianl*weight*rhostore(i,j,k,ispec)*elemental_contribution(:)
+
+        enddo
+      enddo
+    enddo
+  enddo
+
+  ! multiply by the gravitational constant in S.I. units i.e. in m3 kg-1 s-2
+  ! and also take into account the fact that the density and the radius of the Earth have previously been non-dimensionalized
+  Roland_Sylvain_int_local(:) = Roland_Sylvain_int_local(:) * GRAV * non_dimensionalizing_factor
+
+  ! use an MPI reduction to compute the total value of the integral
+  Roland_Sylvain_int_total_region(:) = ZERO
+!! DK DK could use a single MPI call for the nine values
+  call sum_all_dp(Roland_Sylvain_int_local(1),Roland_Sylvain_int_total_region(1))
+  call sum_all_dp(Roland_Sylvain_int_local(2),Roland_Sylvain_int_total_region(2))
+  call sum_all_dp(Roland_Sylvain_int_local(3),Roland_Sylvain_int_total_region(3))
+  call sum_all_dp(Roland_Sylvain_int_local(4),Roland_Sylvain_int_total_region(4))
+  call sum_all_dp(Roland_Sylvain_int_local(5),Roland_Sylvain_int_total_region(5))
+  call sum_all_dp(Roland_Sylvain_int_local(6),Roland_Sylvain_int_total_region(6))
+  call sum_all_dp(Roland_Sylvain_int_local(7),Roland_Sylvain_int_total_region(7))
+  call sum_all_dp(Roland_Sylvain_int_local(8),Roland_Sylvain_int_total_region(8))
+  call sum_all_dp(Roland_Sylvain_int_local(9),Roland_Sylvain_int_total_region(9))
+
+  !   sum volume over all the regions
+  if(myrank == 0) Roland_Sylvain_integr_total(:) = Roland_Sylvain_integr_total(:) + Roland_Sylvain_int_total_region(:)
+
+  end subroutine compute_Roland_Sylvain_integr
+
diff --git a/src/meshfem3D/create_MPI_interfaces.f90 b/src/meshfem3D/create_MPI_interfaces.f90
index f789391..6e6d12d 100644
--- a/src/meshfem3D/create_MPI_interfaces.f90
+++ b/src/meshfem3D/create_MPI_interfaces.f90
@@ -25,8 +25,6 @@
 !
 !=====================================================================
 
-
-
   subroutine create_MPI_interfaces(iregion_code)
 
   implicit none
diff --git a/src/meshfem3D/create_meshes.f90 b/src/meshfem3D/create_meshes.f90
index 11665ce..c159c96 100644
--- a/src/meshfem3D/create_meshes.f90
+++ b/src/meshfem3D/create_meshes.f90
@@ -25,7 +25,6 @@
 !
 !=====================================================================
 
-
   subroutine create_meshes()
 
   use meshfem3D_par
@@ -41,8 +40,10 @@
   iproc_eta = iproc_eta_slice(myrank)
 
   ! volume of the final mesh, and Earth mass computed in the final mesh
+  ! and Roland_Sylvain integrals
   volume_total = ZERO
   Earth_mass_total = ZERO
+  Roland_Sylvain_integr_total(:) = ZERO
 
   ! make sure everybody is synchronized
   call synchronize_all()
diff --git a/src/meshfem3D/create_regions_mesh.F90 b/src/meshfem3D/create_regions_mesh.F90
index c1f298b..9d3a613 100644
--- a/src/meshfem3D/create_regions_mesh.F90
+++ b/src/meshfem3D/create_regions_mesh.F90
@@ -47,7 +47,7 @@
 
   use meshfem3D_par,only: &
     ibool,idoubling,xstore,ystore,zstore, &
-    IMAIN,volume_total,Earth_mass_total,myrank,LOCAL_PATH, &
+    IMAIN,volume_total,Earth_mass_total,Roland_Sylvain_integr_total,myrank,LOCAL_PATH, &
     IREGION_CRUST_MANTLE,IREGION_OUTER_CORE,IREGION_INNER_CORE, &
     IFLAG_IN_FICTITIOUS_CUBE, &
     NCHUNKS,SAVE_MESH_FILES,ABSORBING_CONDITIONS, &
@@ -382,7 +382,8 @@
     deallocate(rmass_ocean_load)
 
     ! saves MPI interface info
-    call save_arrays_solver_MPI(iregion_code)
+!! DK DK for Roland_Sylvain
+    if(.not. ROLAND_SYLVAIN) call save_arrays_solver_MPI(iregion_code)
 
     ! frees MPI arrays memory
     call crm_free_MPI_arrays(iregion_code)
@@ -425,6 +426,12 @@
         write(IMAIN,*) '  ...computing Roland_Sylvain integrals'
         call flush_IMAIN()
       endif
+
+      ! compute Roland_Sylvain integrals of that part of the slice, and then total integrals for the whole Earth
+      call compute_Roland_Sylvain_integr(myrank,Roland_Sylvain_integr_total, &
+          nspec,wxgll,wygll,wzgll,xstore,ystore,zstore,xixstore,xiystore,xizstore, &
+          etaxstore,etaystore,etazstore,gammaxstore,gammaystore,gammazstore,rhostore,idoubling)
+
     endif
 
     ! create AVS or DX mesh data for the slices
diff --git a/src/meshfem3D/finalize_mesher.f90 b/src/meshfem3D/finalize_mesher.f90
index 481afbf..f499aaa 100644
--- a/src/meshfem3D/finalize_mesher.f90
+++ b/src/meshfem3D/finalize_mesher.f90
@@ -57,7 +57,34 @@
       write(IMAIN,*) '   (should be not too far from 5514 kg/m3)'
     endif
 
-    ! info output
+!! DK DK for Roland_Sylvain
+    ! Roland_Sylvain integrals
+    if(ROLAND_SYLVAIN) then
+      write(IMAIN,*)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 1 g_x  = ',Roland_Sylvain_integr_total(1)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 2 g_y  = ',Roland_Sylvain_integr_total(2)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 3 g_z  = ',Roland_Sylvain_integr_total(3)
+      write(IMAIN,*)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 4 G_xx = ',Roland_Sylvain_integr_total(4)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 5 G_yy = ',Roland_Sylvain_integr_total(5)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 6 G_zz = ',Roland_Sylvain_integr_total(6)
+      write(IMAIN,*)
+      write(IMAIN,*) 'G tensor should be traceless, G_xx + G_yy + G_zz = 0'
+      write(IMAIN,*) 'actual sum obtained = ', &
+            Roland_Sylvain_integr_total(4) + Roland_Sylvain_integr_total(5) + Roland_Sylvain_integr_total(6)
+      if(max(abs(Roland_Sylvain_integr_total(4)),abs(Roland_Sylvain_integr_total(5)),&
+            abs(Roland_Sylvain_integr_total(6))) > TINYVAL) &
+        write(IMAIN,*) ' i.e., ',sngl(100.d0*(Roland_Sylvain_integr_total(4) + Roland_Sylvain_integr_total(5) + &
+            Roland_Sylvain_integr_total(6)) / max(abs(Roland_Sylvain_integr_total(4)),abs(Roland_Sylvain_integr_total(5)),&
+            abs(Roland_Sylvain_integr_total(6)))),'% of max(abs(Gxx),abs(Gyy),abs(Gzz))'
+      write(IMAIN,*)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 7 G_xy = ',Roland_Sylvain_integr_total(7)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 8 G_xz = ',Roland_Sylvain_integr_total(8)
+      write(IMAIN,*) 'computed total Roland_Sylvain integral 9 G_yz = ',Roland_Sylvain_integr_total(9)
+
+    endif
+
+    ! infos output
     numelem_crust_mantle = NSPEC(IREGION_CRUST_MANTLE)
     numelem_outer_core = NSPEC(IREGION_OUTER_CORE)
     numelem_inner_core = NSPEC(IREGION_INNER_CORE)
diff --git a/src/meshfem3D/get_MPI_interfaces.f90 b/src/meshfem3D/get_MPI_interfaces.f90
index ef3b6e9..d22aa72 100644
--- a/src/meshfem3D/get_MPI_interfaces.f90
+++ b/src/meshfem3D/get_MPI_interfaces.f90
@@ -25,7 +25,6 @@
 !
 !=====================================================================
 
-
   subroutine get_MPI_interfaces(myrank,NGLOB,NSPEC, &
                                     test_flag,my_neighbours,nibool_neighbours,ibool_neighbours, &
                                     num_interfaces,max_nibool_interfaces, &
diff --git a/src/meshfem3D/meshfem3D_models.f90 b/src/meshfem3D/meshfem3D_models.f90
index d5b51ea..250b0ed 100644
--- a/src/meshfem3D/meshfem3D_models.f90
+++ b/src/meshfem3D/meshfem3D_models.f90
@@ -397,7 +397,7 @@
 
   ! gets parameters for isotropic 3D mantle model
   !
-  ! note: there can be transverse isotropy in the mantle, but only Lamé parameters
+  ! note: there can be transverse isotropy in the mantle, but only Lam'e parameters
   !           like kappav,kappah,muv,muh and eta_aniso are used for these simulations
   !
   ! note: in general, models here make use of perturbation values with respect to their
diff --git a/src/meshfem3D/meshfem3D_par.f90 b/src/meshfem3D/meshfem3D_par.f90
index 3b3a4cc..7bf097c 100644
--- a/src/meshfem3D/meshfem3D_par.f90
+++ b/src/meshfem3D/meshfem3D_par.f90
@@ -159,6 +159,9 @@
   ! check Earth mass computed in the final mesh
   double precision :: Earth_mass_total
 
+  ! compute Roland_Sylvain integrals in the final mesh
+  double precision, dimension(9) :: Roland_Sylvain_integr_total
+
   ! for loop on all the slices
   integer :: iregion_code
   integer :: iproc_xi,iproc_eta,ichunk
diff --git a/src/meshfem3D/model_1dref.f90 b/src/meshfem3D/model_1dref.f90
index a758901..69c88fc 100644
--- a/src/meshfem3D/model_1dref.f90
+++ b/src/meshfem3D/model_1dref.f90
@@ -35,7 +35,7 @@
 ! model for the 3D models s362ani, s362wmani, s362ani_prem, and s29ea.
 !
 ! see chapter 3, in:
-! Kustowski, B, Ekström, G., and A. M. Dziewonski, 2008,
+! Kustowski, B, Ekstr"om, G., and A. M. Dziewonski, 2008,
 ! Anisotropic shear-wave velocity structure of the Earth's mantle: A global model,
 ! J. Geophys. Res., 113, B06306, doi:10.1029/2007JB005169.
 !
diff --git a/src/meshfem3D/model_atten3D_QRFSI12.f90 b/src/meshfem3D/model_atten3D_QRFSI12.f90
index badb1f1..2933b27 100644
--- a/src/meshfem3D/model_atten3D_QRFSI12.f90
+++ b/src/meshfem3D/model_atten3D_QRFSI12.f90
@@ -28,7 +28,7 @@
 !--------------------------------------------------------------------------------------------------
 !
 !   This file contains subroutines to read in and get values for
-!   3-D attenuation model QRFSI12 (Dalton, Ekström, & Dziewonski, 2008)
+!   3-D attenuation model QRFSI12 (Dalton, Ekstr"om, & Dziewonski, 2008)
 !
 ! C.A. Dalton, G. Ekstr\"om and A.M. Dziewonski, 2008.
 ! The global attenuation structure of the upper mantle,
diff --git a/src/meshfem3D/model_attenuation.f90 b/src/meshfem3D/model_attenuation.f90
index 8f24fca..3111b69 100644
--- a/src/meshfem3D/model_attenuation.f90
+++ b/src/meshfem3D/model_attenuation.f90
@@ -473,9 +473,6 @@
   endif
   ! Generate index for Storage Array
   ! and Recast Qmu using this index
-  ! According to Brian, use float
-  !Qtmp = Qmu * Q_resolution
-  !Qmu = Qtmp / Q_resolution;
 
   ! by default: resolution is Q_resolution = 10
   ! converts Qmu to an array integer index:
@@ -1219,7 +1216,7 @@ subroutine attenuation_simplex_setup(nf_in,nsls_in,f_in,Q_in,tau_s_in,AS_V)
 !      n = Input
 !         Length of X
 !      I = Output
-!         Sorted Indices of vecotr X
+!         Sorted Indices of vector X
 !
 !      Example:
 !         X = [ 4 3 1 2 ] on Input
diff --git a/src/meshfem3D/model_crust_1_0.f90 b/src/meshfem3D/model_crust_1_0.f90
index 3a8285d..bd59928 100644
--- a/src/meshfem3D/model_crust_1_0.f90
+++ b/src/meshfem3D/model_crust_1_0.f90
@@ -325,7 +325,7 @@
   ! frees memory
   deallocate(bnd)
 
-  ! additional info:
+  ! additional info
   if( DEBUG_FILE_OUTPUT ) then
     ! allocates temporary arrays
     allocate(thc(CRUST1_NLA,CRUST1_NLO), &
diff --git a/src/meshfem3D/model_crustmaps.f90 b/src/meshfem3D/model_crustmaps.f90
index 5df9d2a..cb81c5f 100644
--- a/src/meshfem3D/model_crustmaps.f90
+++ b/src/meshfem3D/model_crustmaps.f90
@@ -156,7 +156,7 @@
   velocsnp(:) = ZERO
   velocssp(:) = ZERO
 
-  !compute average values for North and South pole
+  ! compute average values for North and South pole
   do l=1,NLAYERS_CRUSTMAP
     do i=1,360*CRUSTMAP_RESOLUTION
       thicknessnp(l) =  thicknessnp(l)+thickness(1,i,l)
diff --git a/src/shared/shared_par.f90 b/src/shared/shared_par.f90
index 1d1eabd..0a45b22 100644
--- a/src/shared/shared_par.f90
+++ b/src/shared/shared_par.f90
@@ -85,7 +85,7 @@
   logical :: UNDO_ATTENUATION,PARTIAL_PHYS_DISPERSION_ONLY,ATTENUATION_1D_WITH_3D_STORAGE
   integer :: NT_DUMP_ATTENUATION
 
-  ! ldd Runge-Kutta time scheme
+  ! LDD Runge-Kutta time scheme
   logical :: USE_LDDRK,INCREASE_CFL_FOR_LDDRK
   double precision :: RATIO_BY_WHICH_TO_INCREASE_IT
 



More information about the CIG-COMMITS mailing list