[cig-commits] [commit] devel: small code beautify (75e98c5)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Mon Dec 22 05:55:57 PST 2014


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

On branch  : devel
Link       : https://github.com/geodynamics/specfem3d/compare/5482435a44c766976b16ef4139e5b545834a7300...8409ff46e1df08c2033322539a2dbb07ba86390c

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

commit 75e98c56c7f1e9093f794e932f92df1ade27372e
Author: daniel peter <peterda at ethz.ch>
Date:   Mon Dec 22 13:22:31 2014 +0100

    small code beautify


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

75e98c56c7f1e9093f794e932f92df1ade27372e
 src/generate_databases/get_coupling_surfaces.f90   |   4 +-
 src/generate_databases/model_1d_prem.f90           |  22 ++---
 .../pml_set_local_dampingcoeff.f90                 |  40 ++++-----
 .../save_arrays_solver_adios.F90                   |   2 +-
 src/shared/get_cmt.f90                             |   2 +-
 src/shared/get_force.f90                           |   2 +-
 src/specfem3D/pml_compute_accel_contribution.f90   |  10 +--
 src/specfem3D/pml_compute_memory_variables.f90     | 100 ++++++++++-----------
 src/specfem3D/prepare_timerun.F90                  |   4 +-
 src/specfem3D/read_mesh_databases_adios.F90        |   2 +-
 src/specfem3D/update_displacement_scheme.f90       |  16 ++--
 src/specfem3D/write_output_ASCII_or_binary.f90     |   2 +-
 12 files changed, 103 insertions(+), 103 deletions(-)

diff --git a/src/generate_databases/get_coupling_surfaces.f90 b/src/generate_databases/get_coupling_surfaces.f90
index a76e813..046a67e 100644
--- a/src/generate_databases/get_coupling_surfaces.f90
+++ b/src/generate_databases/get_coupling_surfaces.f90
@@ -640,7 +640,7 @@
           ! note: this assumes that both, elastic and poroelastic element, are in the same
           !          partition; check with decomposition that this is valid for this mesh partitioning
           do ispec_el=1,nspec
-            if (ispec_is_elastic(ispec_el))then
+            if (ispec_is_elastic(ispec_el)) then
               do iface_el=6,1,-1
                 ! takes indices of corners of reference face
                 do icorner = 1,NGNOD2D_FOUR_CORNERS
@@ -703,7 +703,7 @@
                 endif ! if
 
               enddo ! do iface_ref_el=1,6
-            endif ! if (ispec_is_elastic(ispec_el))then
+            endif ! if (ispec_is_elastic(ispec_el)) then
           enddo ! do ispec_el=1,nspec
         endif ! elastic_flag
       enddo ! iface_ref
diff --git a/src/generate_databases/model_1d_prem.f90 b/src/generate_databases/model_1d_prem.f90
index fb937ee..9167a22 100644
--- a/src/generate_databases/model_1d_prem.f90
+++ b/src/generate_databases/model_1d_prem.f90
@@ -307,47 +307,47 @@
   r=r0/1000.
 
   x_prem=r/6371.     ! Radius (normalized to x(surface)=1)
-  if (idom==1)then        ! upper crustal layer
+  if (idom==1) then        ! upper crustal layer
      ro_prem=2.6
      vp_prem=5.8
      vs_prem=3.2
-  else if (idom==2)then
+  else if (idom==2) then
      ro_prem=2.9                       ! lower crustal layer
      vp_prem=6.8
      vs_prem=3.9
-  else if (idom==3)then
+  else if (idom==3) then
      ro_prem=2.691+.6924*x_prem             ! upper mantle
      vp_prem=4.1875+3.9382*x_prem
      vs_prem=2.1519+2.3481*x_prem
-  else if (idom==4)then
+  else if (idom==4) then
      ro_prem=7.1089-3.8045*x_prem
      vp_prem=20.3926-12.2569*x_prem
      vs_prem=8.9496-4.4597*x_prem
-  else if (idom==5)then
+  else if (idom==5) then
      ro_prem=11.2494-8.0298*x_prem
      vp_prem=39.7027-32.6166*x_prem
      vs_prem=22.3512-18.5856*x_prem
-  else if (idom==6)then
+  else if (idom==6) then
      ro_prem=5.3197-1.4836*x_prem
      vp_prem=19.0957-9.8672*x_prem
      vs_prem=9.9839-4.9324*x_prem
-  else if (idom==7)then   !lower mantle
+  else if (idom==7) then   !lower mantle
      ro_prem=7.9565-6.4761*x_prem+5.5283*x_prem**2-3.0807*x_prem**3
      vp_prem=29.2766-23.6027*x_prem+5.5242*x_prem**2-2.5514*x_prem**3
      vs_prem=22.3459-17.2473*x_prem-2.0834*x_prem**2+0.9783*x_prem**3
-  else if (idom==8)then
+  else if (idom==8) then
      ro_prem=7.9565-6.4761*x_prem+5.5283*x_prem**2-3.0807*x_prem**3
      vp_prem=24.9520-40.4673*x_prem+51.4832*x_prem**2-26.6419*x_prem**3
      vs_prem=11.1671-13.7818*x_prem+17.4575*x_prem**2-9.2777*x_prem**3
-  else if (idom==9)then
+  else if (idom==9) then
      ro_prem=7.9565-6.4761*x_prem+5.5283*x_prem**2-3.0807*x_prem**3
      vp_prem=15.3891-5.3181*x_prem+5.5242*x_prem**2-2.5514*x_prem**3
      vs_prem=6.9254+1.4672*x_prem-2.0834*x_prem**2+.9783*x_prem**3
-  else if (idom==10)then  ! outer core
+  else if (idom==10) then  ! outer core
      ro_prem=12.5815-1.2638*x_prem-3.6426*x_prem**2-5.5281*x_prem**3
      vp_prem=11.0487-4.0362*x_prem+4.8023*x_prem**2-13.5732*x_prem**3
      vs_prem=0.00
-  else if (idom==11)then                        ! inner core
+  else if (idom==11) then                        ! inner core
      ro_prem=13.0885-8.8381*x_prem**2
      vp_prem=11.2622-6.3640*x_prem**2
      vs_prem=3.6678-4.4475*x_prem**2
diff --git a/src/generate_databases/pml_set_local_dampingcoeff.f90 b/src/generate_databases/pml_set_local_dampingcoeff.f90
index 61f7961..c6977e2 100644
--- a/src/generate_databases/pml_set_local_dampingcoeff.f90
+++ b/src/generate_databases/pml_set_local_dampingcoeff.f90
@@ -183,12 +183,12 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
         iglob = ibool(i,j,k,ispec)
         if (CPML_regions(ispec_CPML) == CPML_X_ONLY .or. CPML_regions(ispec_CPML) == CPML_XY_ONLY .or. &
            CPML_regions(ispec_CPML) == CPML_XZ_ONLY .or.  CPML_regions(ispec_CPML) == CPML_XYZ) then
-           if (xstore(iglob) - x_origin > 0._CUSTOM_REAL)then
-              if (xstore(iglob) - x_origin <= CPML_x_right - x_origin)then
+           if (xstore(iglob) - x_origin > 0._CUSTOM_REAL) then
+              if (xstore(iglob) - x_origin <= CPML_x_right - x_origin) then
                  CPML_x_right = xstore(iglob)
               endif
            else
-              if (abs(xstore(iglob) - x_origin) <= abs(CPML_x_left-x_origin))then
+              if (abs(xstore(iglob) - x_origin) <= abs(CPML_x_left-x_origin)) then
                  CPML_x_left = xstore(iglob)
               endif
            endif
@@ -196,12 +196,12 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
 
         if (CPML_regions(ispec_CPML) == CPML_Y_ONLY .or. CPML_regions(ispec_CPML) == CPML_XY_ONLY .or. &
            CPML_regions(ispec_CPML) == CPML_YZ_ONLY .or.  CPML_regions(ispec_CPML) == CPML_XYZ) then
-           if (ystore(iglob) - y_origin > 0._CUSTOM_REAL)then
-              if (ystore(iglob) - y_origin <= CPML_y_front - y_origin)then
+           if (ystore(iglob) - y_origin > 0._CUSTOM_REAL) then
+              if (ystore(iglob) - y_origin <= CPML_y_front - y_origin) then
                  CPML_y_front = ystore(iglob)
               endif
            else
-              if (abs(ystore(iglob) - y_origin) <= abs(CPML_y_back-y_origin))then
+              if (abs(ystore(iglob) - y_origin) <= abs(CPML_y_back-y_origin)) then
                  CPML_y_back = ystore(iglob)
               endif
            endif
@@ -209,12 +209,12 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
 
         if (CPML_regions(ispec_CPML) == CPML_Z_ONLY .or. CPML_regions(ispec_CPML) == CPML_YZ_ONLY .or. &
            CPML_regions(ispec_CPML) == CPML_XZ_ONLY .or.  CPML_regions(ispec_CPML) == CPML_XYZ) then
-           if (zstore(iglob) - z_origin > 0._CUSTOM_REAL)then
-              if (zstore(iglob) - z_origin <= CPML_z_top - z_origin)then
+           if (zstore(iglob) - z_origin > 0._CUSTOM_REAL) then
+              if (zstore(iglob) - z_origin <= CPML_z_top - z_origin) then
                  CPML_z_top = zstore(iglob)
               endif
            else
-              if (abs(zstore(iglob) - z_origin) <= abs(CPML_z_bottom-z_origin))then
+              if (abs(zstore(iglob) - z_origin) <= abs(CPML_z_bottom-z_origin)) then
                  CPML_z_bottom = zstore(iglob)
               endif
            endif
@@ -256,7 +256,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
      ispec = CPML_to_spec(ispec_CPML)
      do k=1,NGLLZ; do j=1,NGLLY; do i=1,NGLLX
         vp = rho_vp(i,j,k,ispec)/rhostore(i,j,k,ispec)
-        if (vp >= vp_max)then
+        if (vp >= vp_max) then
            vp_max = vp
         endif
      enddo; enddo; enddo
@@ -621,7 +621,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
 
                  !! DK DK define an alias for y and z variable names (which are the same)
                  !  stores damping profiles and auxiliary coefficients at the C-PML element's GLL points
-                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_y < 0._CUSTOM_REAL)then
+                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_y < 0._CUSTOM_REAL) then
                    stop "there is error in mesh of CPML-layer xy"
                  endif
 
@@ -775,7 +775,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
 
                  !! DK DK define an alias for y and z variable names (which are the same)
                  !  stores damping profiles and auxiliary coefficients at the C-PML element's GLL points
-                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL)then
+                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL) then
                     stop "there is error in mesh of CPML-layer xz"
                  endif
 
@@ -929,7 +929,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
                  endif
 
                  !! DK DK define an alias for y and z variable names (which are the same)
-                 if (alpha_y < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL)then
+                 if (alpha_y < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL) then
                     stop "there is error in mesh of CPML-layer yz"
                  endif
                  K_store_x(i,j,k,ispec_CPML) = 1._CUSTOM_REAL
@@ -1349,7 +1349,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
                  endif
 
                  !! DK DK define an alias for y and z variable names (which are the same)
-                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_y < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL)then
+                 if (alpha_x < 0._CUSTOM_REAL .or. alpha_y < 0._CUSTOM_REAL .or. alpha_z < 0._CUSTOM_REAL) then
                     stop "there is error in mesh of CPML-layer xyz"
                  endif
 
@@ -1401,14 +1401,14 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
       do ispec=1,nspec
         if (ispec_is_acoustic(ispec) .and. is_CPML(ispec)) then
           do k=1,NGLLZ; do j=1,NGLLY; do i=1,NGLLX
-            if (mask_ibool_interior_domain(ibool(i,j,k,ispec)))then
+            if (mask_ibool_interior_domain(ibool(i,j,k,ispec))) then
               nglob_interface_PML_acoustic = nglob_interface_PML_acoustic + 1
             endif
           enddo; enddo; enddo
         endif
       enddo
 
-      if (nglob_interface_PML_acoustic > 0)then
+      if (nglob_interface_PML_acoustic > 0) then
         allocate(points_interface_PML_acoustic(nglob_interface_PML_acoustic),stat=ier)
         if (ier /= 0) stop 'error allocating array points_interface_PML_acoustic'
         points_interface_PML_acoustic = 0
@@ -1416,7 +1416,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
         do ispec=1,nspec
           if (ispec_is_acoustic(ispec) .and. is_CPML(ispec)) then
             do k=1,NGLLZ; do j=1,NGLLY; do i=1,NGLLX
-              if (mask_ibool_interior_domain(ibool(i,j,k,ispec)))then
+              if (mask_ibool_interior_domain(ibool(i,j,k,ispec))) then
                 nglob_interface_PML_acoustic = nglob_interface_PML_acoustic + 1
                 points_interface_PML_acoustic(nglob_interface_PML_acoustic) = ibool(i,j,k,ispec)
               endif
@@ -1440,14 +1440,14 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
       do ispec=1,nspec
         if (ispec_is_elastic(ispec) .and. is_CPML(ispec)) then
           do k=1,NGLLZ; do j=1,NGLLY; do i=1,NGLLX
-            if (mask_ibool_interior_domain(ibool(i,j,k,ispec)))then
+            if (mask_ibool_interior_domain(ibool(i,j,k,ispec))) then
               nglob_interface_PML_elastic = nglob_interface_PML_elastic + 1
             endif
           enddo; enddo; enddo
         endif
       enddo
 
-      if (nglob_interface_PML_elastic > 0)then
+      if (nglob_interface_PML_elastic > 0) then
         allocate(points_interface_PML_elastic(nglob_interface_PML_elastic),stat=ier)
         if (ier /= 0) stop 'error allocating array points_interface_PML_elastic'
         points_interface_PML_elastic = 0
@@ -1455,7 +1455,7 @@ subroutine pml_set_local_dampingcoeff(myrank,xstore,ystore,zstore)
         do ispec=1,nspec
           if (ispec_is_elastic(ispec) .and. is_CPML(ispec)) then
             do k=1,NGLLZ; do j=1,NGLLY; do i=1,NGLLX
-              if (mask_ibool_interior_domain(ibool(i,j,k,ispec)))then
+              if (mask_ibool_interior_domain(ibool(i,j,k,ispec))) then
                 nglob_interface_PML_elastic = nglob_interface_PML_elastic + 1
                 points_interface_PML_elastic(nglob_interface_PML_elastic) = ibool(i,j,k,ispec)
               endif
diff --git a/src/generate_databases/save_arrays_solver_adios.F90 b/src/generate_databases/save_arrays_solver_adios.F90
index 0b0609f..0d94ff3 100644
--- a/src/generate_databases/save_arrays_solver_adios.F90
+++ b/src/generate_databases/save_arrays_solver_adios.F90
@@ -920,7 +920,7 @@ subroutine save_arrays_solver_ext_mesh_adios(nspec, nglob,                   &
 
   ! absorbing boundary surface
   call adios_write(handle, STRINGIFY_VAR(num_abs_boundary_faces), ier)
-  if (PML_CONDITIONS)then
+  if (PML_CONDITIONS) then
     if (num_abs_boundary_faces > 0) then
       local_dim = num_abs_boundary_faces_wmax
       call write_adios_global_1d_array(handle, myrank, sizeprocs, &
diff --git a/src/shared/get_cmt.f90 b/src/shared/get_cmt.f90
index 506eb39..980822e 100644
--- a/src/shared/get_cmt.f90
+++ b/src/shared/get_cmt.f90
@@ -319,7 +319,7 @@
   close(IIN)
 
   ! Sets tshift_cmt to zero to initiate the simulation!
-  if (NSOURCES == 1)then
+  if (NSOURCES == 1) then
       tshift_cmt = 0.d0
       min_tshift_cmt_original = t_shift(1)
   else
diff --git a/src/shared/get_force.f90 b/src/shared/get_force.f90
index 49f586a..f86efc4 100644
--- a/src/shared/get_force.f90
+++ b/src/shared/get_force.f90
@@ -135,7 +135,7 @@
   close(IIN)
 
   ! Sets tshift_force to zero to initiate the simulation!
-  if (NSOURCES == 1)then
+  if (NSOURCES == 1) then
     tshift_force = 0.d0
     min_tshift_force_original = t_shift(1)
   else
diff --git a/src/specfem3D/pml_compute_accel_contribution.f90 b/src/specfem3D/pml_compute_accel_contribution.f90
index 20db342..d4ca547 100644
--- a/src/specfem3D/pml_compute_accel_contribution.f90
+++ b/src/specfem3D/pml_compute_accel_contribution.f90
@@ -525,7 +525,7 @@ subroutine l_parameter_computation( &
 
      else if (abs( alpha_x - alpha_y ) >= 1.e-5_CUSTOM_REAL .AND. &
               abs( alpha_x - alpha_z ) < 1.e-5_CUSTOM_REAL  .AND. &
-              abs( alpha_y - alpha_z ) >= 1.e-5_CUSTOM_REAL)then
+              abs( alpha_y - alpha_z ) >= 1.e-5_CUSTOM_REAL) then
 
        alpha_0 = max(alpha_x,alpha_z)
 
@@ -574,7 +574,7 @@ subroutine l_parameter_computation( &
 
      else if (abs( alpha_x - alpha_y ) >= 1.e-5_CUSTOM_REAL .AND. &
               abs( alpha_x - alpha_z ) >= 1.e-5_CUSTOM_REAL .AND. &
-              abs( alpha_y - alpha_z ) < 1.e-5_CUSTOM_REAL)then
+              abs( alpha_y - alpha_z ) < 1.e-5_CUSTOM_REAL) then
 
        alpha_0 = max(alpha_y,alpha_z)
 
@@ -1063,7 +1063,7 @@ Subroutine compute_convolution_coef(bb, deltat, coef0, coef1, coef2, singularity
   ! calculates coefficients
   coef0 = exp(-prod1)
 
-  if (singularity_type == 0)then
+  if (singularity_type == 0) then
     if (abs(bb) >= 1.e-5_CUSTOM_REAL) then
       if (FIRST_ORDER_CONVOLUTION) then
          coef1 = (1._CUSTOM_REAL - exp(-prod1) ) / bb
@@ -1087,7 +1087,7 @@ Subroutine compute_convolution_coef(bb, deltat, coef0, coef1, coef2, singularity
                   5._CUSTOM_REAL*deltatpow4*bbpow3*ONE_OVER_128))
       endif
     endif
-  else if (singularity_type == 1)then
+  else if (singularity_type == 1) then
     if (abs(bb) >= 1.e-5_CUSTOM_REAL) then
       coef1 = (1._CUSTOM_REAL - exp(-prod1_half) ) / bb
       coef1 = time_nplus1 * coef1 + (deltat_half*exp(-prod1_half) - coef1) / bb
@@ -1105,7 +1105,7 @@ Subroutine compute_convolution_coef(bb, deltat, coef0, coef1, coef2, singularity
                                     (7._CUSTOM_REAL*deltatpow3*bbpow2*ONE_OVER_48 - &
                                      5._CUSTOM_REAL*deltatpow4*bbpow3*ONE_OVER_128)))
      endif
-  else if (singularity_type == 2)then
+  else if (singularity_type == 2) then
     if (abs(bb) >= 1.e-5_CUSTOM_REAL) then
       coef1 = (1._CUSTOM_REAL - exp(-prod1_half) ) / bb
       coef1 = time_nplus1**2 * coef1 + (time_nplus1*(-2._CUSTOM_REAL/bb*coef1 + deltat/bb*exp(-prod1_half)) + &
diff --git a/src/specfem3D/pml_compute_memory_variables.f90 b/src/specfem3D/pml_compute_memory_variables.f90
index c6c0247..047fece 100644
--- a/src/specfem3D/pml_compute_memory_variables.f90
+++ b/src/specfem3D/pml_compute_memory_variables.f90
@@ -694,7 +694,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
 
   logical,parameter :: FIRST_ORDER_CONVOLUTION = .false.
 
-  if (index_ijk == 123)then
+  if (index_ijk == 123) then
     CPML_X_ONLY_TEMP = CPML_X_ONLY
     CPML_Y_ONLY_TEMP = CPML_Y_ONLY
     CPML_Z_ONLY_TEMP = CPML_Z_ONLY
@@ -702,7 +702,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     CPML_XZ_ONLY_TEMP = CPML_XZ_ONLY
     CPML_YZ_ONLY_TEMP = CPML_YZ_ONLY
     CPML_XYZ_TEMP = CPML_XYZ
-  else if (index_ijk == 132)then
+  else if (index_ijk == 132) then
     CPML_X_ONLY_TEMP = CPML_X_ONLY
     CPML_Y_ONLY_TEMP = CPML_Z_ONLY
     CPML_Z_ONLY_TEMP = CPML_Y_ONLY
@@ -710,7 +710,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     CPML_XZ_ONLY_TEMP = CPML_XY_ONLY
     CPML_YZ_ONLY_TEMP = CPML_YZ_ONLY
     CPML_XYZ_TEMP = CPML_XYZ
-  else if (index_ijk == 231)then
+  else if (index_ijk == 231) then
     CPML_X_ONLY_TEMP = CPML_Z_ONLY
     CPML_Y_ONLY_TEMP = CPML_Y_ONLY
     CPML_Z_ONLY_TEMP = CPML_X_ONLY
@@ -730,13 +730,13 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
   beta_z = alpha_z + d_z / kappa_z
 
 
-  if (CPML_region_local == CPML_XYZ_TEMP)then
+  if (CPML_region_local == CPML_XYZ_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x * kappa_y / kappa_z
     A_0 = bar_A_0
 
     if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL .and. abs(alpha_x-beta_z) >= 1.e-5_CUSTOM_REAL &
-       .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL)then
+       .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       bar_A_1 = - bar_A_0 * (alpha_x - alpha_z) * (alpha_x - beta_x) * (alpha_x - beta_y) / &
                 ((alpha_x-alpha_y) * (alpha_x-beta_z))
@@ -757,7 +757,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
     else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL .and. abs(alpha_x-beta_z) >= 1.e-5_CUSTOM_REAL &
-          .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL)then
+          .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_x,alpha_y)
 
@@ -790,7 +790,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
     else if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL .and. abs(alpha_x-beta_z) < 1.e-5_CUSTOM_REAL &
-          .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL)then
+          .and. abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_x,beta_z)
 
@@ -822,7 +822,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
     else if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL .and. abs(alpha_x-beta_z) >= 1.e-5_CUSTOM_REAL &
-          .and. abs(alpha_y-beta_z) < 1.e-5_CUSTOM_REAL)then
+          .and. abs(alpha_y-beta_z) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_y,beta_z)
 
@@ -893,12 +893,12 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     else
       stop 'error in lijk_parameter_computation'
     endif
-  else if (CPML_region_local == CPML_YZ_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_YZ_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_y / kappa_z
     A_0 = bar_A_0
 
-    if (abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL)then
+    if (abs(alpha_y-beta_z) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
 
       beta_x = alpha_x + d_x / kappa_x
@@ -922,7 +922,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
-    else if (abs(alpha_y-beta_z) < 1.e-5_CUSTOM_REAL)then
+    else if (abs(alpha_y-beta_z) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_y,beta_z)
 
@@ -950,12 +950,12 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     else
       stop 'error in lijk_parameter_computation'
     endif
-  else if (CPML_region_local == CPML_XZ_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_XZ_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x / kappa_z
     A_0 = bar_A_0
 
-    if (abs(alpha_x-beta_z) >= 1.e-5_CUSTOM_REAL)then
+    if (abs(alpha_x-beta_z) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
 
       beta_x = alpha_x + d_x / kappa_x
@@ -979,7 +979,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
-    else if (abs(alpha_x-beta_z) < 1.e-5_CUSTOM_REAL)then
+    else if (abs(alpha_x-beta_z) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_x,beta_z)
 
@@ -1008,12 +1008,12 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       stop 'error in lijk_parameter_computation'
     endif
 
-  else if (CPML_region_local == CPML_XY_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_XY_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x * kappa_y
     A_0 = bar_A_0
 
-    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL)then
+    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
 
       beta_x = alpha_x + d_x / kappa_x
@@ -1037,7 +1037,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
       call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
       call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
-    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL)then
+    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_x,alpha_y)
 
@@ -1066,7 +1066,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     else
       stop 'error in lijk_parameter_computation'
     endif
-  else if (CPML_region_local == CPML_X_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_X_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x
     A_0 = bar_A_0
@@ -1086,7 +1086,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
     call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
-  else if (CPML_region_local == CPML_Y_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_Y_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_y
     A_0 = bar_A_0
@@ -1106,7 +1106,7 @@ subroutine lijk_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_x,kappa_y
     call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
     call compute_convolution_coef(beta_z, deltat, coef0_3, coef1_3, coef2_3, singularity_type_3, time_nplus1,time_n)
 
-  else if (CPML_region_local == CPML_Z_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_Z_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = 1._CUSTOM_REAL / kappa_z
     A_0 = bar_A_0
@@ -1155,43 +1155,43 @@ subroutine lx_parameter_computation(deltat,kappa_x,d_x,alpha_x, &
 
   beta_x = alpha_x + d_x / kappa_x
 
-  if (CPML_region_local == CPML_XYZ)then
+  if (CPML_region_local == CPML_XYZ) then
   !----------------A0-------------------------
     A_0 = kappa_x
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_x - beta_x)
 
-  else if (CPML_region_local == CPML_YZ_ONLY)then
+  else if (CPML_region_local == CPML_YZ_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_XZ_ONLY)then
+  else if (CPML_region_local == CPML_XZ_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_x
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_x - beta_x)
 
-  else if (CPML_region_local == CPML_XY_ONLY)then
+  else if (CPML_region_local == CPML_XY_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_x
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_x - beta_x)
 
-  else if (CPML_region_local == CPML_X_ONLY)then
+  else if (CPML_region_local == CPML_X_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_x
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_x - beta_x)
 
-  else if (CPML_region_local == CPML_Y_ONLY)then
+  else if (CPML_region_local == CPML_Y_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_Z_ONLY)then
+  else if (CPML_region_local == CPML_Z_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
@@ -1226,43 +1226,43 @@ subroutine ly_parameter_computation(deltat,kappa_y,d_y,alpha_y, &
 
   beta_y = alpha_y + d_y / kappa_y
 
-  if (CPML_region_local == CPML_XYZ)then
+  if (CPML_region_local == CPML_XYZ) then
   !----------------A0-------------------------
     A_0 = kappa_y
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_y - beta_y)
 
-  else if (CPML_region_local == CPML_YZ_ONLY)then
+  else if (CPML_region_local == CPML_YZ_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_y
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_y - beta_y)
 
-  else if (CPML_region_local == CPML_XZ_ONLY)then
+  else if (CPML_region_local == CPML_XZ_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_XY_ONLY)then
+  else if (CPML_region_local == CPML_XY_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_y
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_y - beta_y)
 
-  else if (CPML_region_local == CPML_X_ONLY)then
+  else if (CPML_region_local == CPML_X_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_Y_ONLY)then
+  else if (CPML_region_local == CPML_Y_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_y
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_y - beta_y)
 
-  else if (CPML_region_local == CPML_Z_ONLY)then
+  else if (CPML_region_local == CPML_Z_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
@@ -1301,43 +1301,43 @@ subroutine lz_parameter_computation(deltat,kappa_z,d_z,alpha_z, &
 
   beta_z = alpha_z + d_z / kappa_z
 
-  if (CPML_region_local == CPML_XYZ)then
+  if (CPML_region_local == CPML_XYZ) then
   !----------------A0-------------------------
     A_0 = kappa_z
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_z - beta_z)
 
-  else if (CPML_region_local == CPML_YZ_ONLY)then
+  else if (CPML_region_local == CPML_YZ_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_z
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_z - beta_z)
 
-  else if (CPML_region_local == CPML_XZ_ONLY)then
+  else if (CPML_region_local == CPML_XZ_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_z
   !----------------A1-------------------------
     A_1 = - A_0 * (alpha_z - beta_z)
 
-  else if (CPML_region_local == CPML_XY_ONLY)then
+  else if (CPML_region_local == CPML_XY_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_X_ONLY)then
+  else if (CPML_region_local == CPML_X_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_Y_ONLY)then
+  else if (CPML_region_local == CPML_Y_ONLY) then
   !----------------A0-------------------------
     A_0 = 1._CUSTOM_REAL
   !----------------A1-------------------------
     A_1 = 0._CUSTOM_REAL
 
-  else if (CPML_region_local == CPML_Z_ONLY)then
+  else if (CPML_region_local == CPML_Z_ONLY) then
   !----------------A0-------------------------
     A_0 = kappa_z
   !----------------A1-------------------------
@@ -1379,7 +1379,7 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
 
   logical,parameter :: FIRST_ORDER_CONVOLUTION = .false.
 
-  if (index_ijk == 12)then
+  if (index_ijk == 12) then
     CPML_X_ONLY_TEMP = CPML_X_ONLY
     CPML_Y_ONLY_TEMP = CPML_Y_ONLY
     CPML_Z_ONLY_TEMP = CPML_Z_ONLY
@@ -1396,12 +1396,12 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
   beta_x = alpha_x + d_x / kappa_x
   beta_y = alpha_y + d_y / kappa_y
 
-  if (CPML_region_local == CPML_XYZ_TEMP)then
+  if (CPML_region_local == CPML_XYZ_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x * kappa_y
     A_0 = bar_A_0
 
-    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL)then
+    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2-------------------------
 
       bar_A_1 = - bar_A_0 * (alpha_x - beta_x) * (alpha_x - beta_y) / &
@@ -1417,7 +1417,7 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
       call compute_convolution_coef(alpha_x, deltat, coef0_1, coef1_1, coef2_1, 0, time_nplus1,time_n)
       call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
 
-    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL)then
+    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2-------------------------
       alpha_0 = max(alpha_x,alpha_y)
 
@@ -1442,7 +1442,7 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
       stop 'error in lxy_interface_parameter_computation'
     endif
 
-  else if (CPML_region_local == CPML_YZ_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_YZ_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_y
     A_0 = bar_A_0
@@ -1458,7 +1458,7 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
     call compute_convolution_coef(alpha_x, deltat, coef0_1, coef1_1, coef2_1, 0, time_nplus1,time_n)
     call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
 
-  else if (CPML_region_local == CPML_XZ_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_XZ_ONLY_TEMP) then
 
   !----------------A0-------------------------
     bar_A_0 = kappa_x
@@ -1475,12 +1475,12 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
     call compute_convolution_coef(alpha_x, deltat, coef0_1, coef1_1, coef2_1, 0, time_nplus1,time_n)
     call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
 
-  else if (CPML_region_local == CPML_XY_ONLY_TEMP)then
+  else if (CPML_region_local == CPML_XY_ONLY_TEMP) then
   !----------------A0-------------------------
     bar_A_0 = kappa_x * kappa_y
     A_0 = bar_A_0
 
-    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL)then
+    if (abs(alpha_x-alpha_y) >= 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
 
       bar_A_1 = - bar_A_0 * (alpha_x - beta_x) * (alpha_x - beta_y) / &
@@ -1496,7 +1496,7 @@ subroutine lxy_interface_parameter_computation(timeval,deltat,kappa_x,d_x,alpha_
       call compute_convolution_coef(alpha_x, deltat, coef0_1, coef1_1, coef2_1, 0, time_nplus1,time_n)
       call compute_convolution_coef(alpha_y, deltat, coef0_2, coef1_2, coef2_2, singularity_type_2, time_nplus1,time_n)
 
-    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL)then
+    else if (abs(alpha_x-alpha_y) < 1.e-5_CUSTOM_REAL) then
       !----------------A1,2,3-------------------------
       alpha_0 = max(alpha_x,alpha_y)
 
diff --git a/src/specfem3D/prepare_timerun.F90 b/src/specfem3D/prepare_timerun.F90
index 3b5d3d1..aaf3e0a 100644
--- a/src/specfem3D/prepare_timerun.F90
+++ b/src/specfem3D/prepare_timerun.F90
@@ -508,7 +508,7 @@
     read(27) factor_common
     read(27) scale_factor
 
-    if (FULL_ATTENUATION_SOLID)then
+    if (FULL_ATTENUATION_SOLID) then
       read(27) one_minus_sum_beta_kappa
       read(27) factor_common_kappa
       read(27) scale_factor_kappa
@@ -546,7 +546,7 @@
             scale_factorl = scale_factor(i,j,k,ispec)
             mustore(i,j,k,ispec) = mustore(i,j,k,ispec) * scale_factorl
 
-            if (FULL_ATTENUATION_SOLID)then
+            if (FULL_ATTENUATION_SOLID) then
               ! scales kappa moduli
               scale_factorl = scale_factor_kappa(i,j,k,ispec)
               kappastore(i,j,k,ispec) = kappastore(i,j,k,ispec) * scale_factorl
diff --git a/src/specfem3D/read_mesh_databases_adios.F90 b/src/specfem3D/read_mesh_databases_adios.F90
index 4bf5d04..b0682e6 100644
--- a/src/specfem3D/read_mesh_databases_adios.F90
+++ b/src/specfem3D/read_mesh_databases_adios.F90
@@ -441,7 +441,7 @@ subroutine read_mesh_databases_adios()
     endif
   endif
 
-  if (PML_CONDITIONS)then
+  if (PML_CONDITIONS) then
     if (num_abs_boundary_faces > 0) then
       call adios_get_scalar(handle, "abs_boundary_ispec/local_dim",&
                             local_dim_abs_boundary_ispec,ier)
diff --git a/src/specfem3D/update_displacement_scheme.f90 b/src/specfem3D/update_displacement_scheme.f90
index 244b8d1..d52969f 100644
--- a/src/specfem3D/update_displacement_scheme.f90
+++ b/src/specfem3D/update_displacement_scheme.f90
@@ -103,7 +103,7 @@
   if (.not. GPU_MODE) then
     ! wavefields on CPU
     ! updates (forward) acoustic potentials
-    if (PML_CONDITIONS .and. NSPEC_CPML > 0)then
+    if (PML_CONDITIONS .and. NSPEC_CPML > 0) then
       potential_acoustic_old(:) = potential_acoustic(:) &
                                   + deltatover2 * (1._CUSTOM_REAL - 2.0_CUSTOM_REAL*theta) * potential_dot_acoustic(:) &
                                   + deltatsqover2 * (1._CUSTOM_REAL - theta) * potential_dot_dot_acoustic(:)
@@ -115,7 +115,7 @@
                                 + deltatover2 * potential_dot_dot_acoustic(:)
     potential_dot_dot_acoustic(:) = 0._CUSTOM_REAL
 
-    if (PML_CONDITIONS .and. NSPEC_CPML > 0)then
+    if (PML_CONDITIONS .and. NSPEC_CPML > 0) then
       potential_acoustic_new(:) = potential_acoustic(:) &
                                   + deltatover2 * (1._CUSTOM_REAL - 2.0_CUSTOM_REAL*theta) * potential_dot_acoustic(:)
     endif
@@ -124,7 +124,7 @@
     if (SIMULATION_TYPE == 3) then
       ! updates acoustic backward/reconstructed fields
       if (PML_CONDITIONS) then
-        if (nglob_interface_PML_acoustic > 0)then
+        if (nglob_interface_PML_acoustic > 0) then
           call read_potential_on_pml_interface(b_potential_dot_dot_acoustic,b_potential_dot_acoustic,b_potential_acoustic,&
                                                nglob_interface_PML_acoustic,b_PML_potential,b_reclen_PML_potential)
         endif
@@ -174,7 +174,7 @@
     ! wavefields on CPU
 
     ! updates elastic displacement and velocity
-    if (PML_CONDITIONS .and. NSPEC_CPML > 0)then
+    if (PML_CONDITIONS .and. NSPEC_CPML > 0) then
       displ_old(:,:) = displ(:,:) &
                        + deltatover2 * (1._CUSTOM_REAL - 2.0_CUSTOM_REAL*theta) * veloc(:,:) &
                        + deltatsqover2 * (1._CUSTOM_REAL - theta) * accel(:,:)
@@ -183,7 +183,7 @@
     veloc(:,:) = veloc(:,:) + deltatover2*accel(:,:)
     if (SIMULATION_TYPE /= 1) accel_adj_coupling(:,:) = accel(:,:)
     accel(:,:) = 0._CUSTOM_REAL
-    if (PML_CONDITIONS .and. NSPEC_CPML > 0)then
+    if (PML_CONDITIONS .and. NSPEC_CPML > 0) then
       displ_new(:,:) = displ(:,:) &
                        + deltatover2 * (1._CUSTOM_REAL - theta) * veloc(:,:)
     endif
@@ -191,8 +191,8 @@
     ! adjoint simulations
     if (SIMULATION_TYPE == 3) then
       ! elastic backward fields
-      if (PML_CONDITIONS)then
-        if (nglob_interface_PML_elastic > 0)then
+      if (PML_CONDITIONS) then
+        if (nglob_interface_PML_elastic > 0) then
           call read_field_on_pml_interface(b_accel,b_veloc,b_displ,nglob_interface_PML_elastic,&
                                            b_PML_field,b_reclen_PML_field)
         endif
@@ -208,7 +208,7 @@
     ! check
     if (SIMULATION_TYPE == 3) then
       if (PML_CONDITIONS) then
-        if (nglob_interface_PML_elastic > 0)then
+        if (nglob_interface_PML_elastic > 0) then
           call exit_MPI(myrank,'elastic time marching scheme with PML_CONDITIONS on GPU not implemented yet...')
         endif
       endif
diff --git a/src/specfem3D/write_output_ASCII_or_binary.f90 b/src/specfem3D/write_output_ASCII_or_binary.f90
index 84a2960..602ba95 100644
--- a/src/specfem3D/write_output_ASCII_or_binary.f90
+++ b/src/specfem3D/write_output_ASCII_or_binary.f90
@@ -58,7 +58,7 @@
   real(kind=CUSTOM_REAL) :: time_t
 
   ! opens seismogram file
-  if (USE_BINARY_FOR_SEISMOGRAMS)then
+  if (USE_BINARY_FOR_SEISMOGRAMS) then
     ! allocate trace
     nt_s = min(it,NSTEP)
     allocate(tr(nt_s),stat=ier)



More information about the CIG-COMMITS mailing list