[cig-commits] [commit] devel, master: removed useless white spaces using a script (af7e4b9)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Thu Nov 6 08:32:26 PST 2014


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

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

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

commit af7e4b915a5bc5bae1f6ab6c66dfc9d316b44745
Author: Dimitri Komatitsch <komatitsch at lma.cnrs-mrs.fr>
Date:   Sun Oct 5 14:56:07 2014 +0200

    removed useless white spaces using a script


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

af7e4b915a5bc5bae1f6ab6c66dfc9d316b44745
 DATA/s362ani/old_src_f77/mod.h                     | 74 +++++++++++-----------
 DATA/s362ani/src_f90/evradker.f90                  |  2 +-
 DATA/s362ani/src_f90/gt3dmodl.f90                  |  2 +-
 DATA/s362ani/src_f90/read_model_s362ani.f90        |  6 +-
 .../global_long/adj_traveltime_filter.f90          | 44 ++++++-------
 .../global_short/adj_traveltime_filter.f90         | 44 ++++++-------
 .../regional/adj_traveltime_filter.f90             | 44 ++++++-------
 .../test_global/adj_traveltime_filter.f90          | 44 ++++++-------
 .../test_regional/adj_traveltime_filter.f90        | 44 ++++++-------
 .../adj_traveltime_filter.f90                      | 44 ++++++-------
 .../crust_mantle_impl_kernel_adjoint.cu            |  0
 .../crust_mantle_impl_kernel_forward.cu            |  0
 .../kernels.gen/inner_core_impl_kernel_adjoint.cu  |  0
 .../kernels.gen/inner_core_impl_kernel_forward.cu  |  0
 src/gpu/kernels.gen/kernel_proto.cu.h              |  0
 src/specfem3D/read_write_netcdf.f90                | 14 ++--
 src/specfem3D/save_kernels.F90                     |  0
 src/tomography/add_model_iso.f90                   |  0
 src/tomography/add_model_tiso_cg.f90               |  0
 src/tomography/add_model_tiso_iso.f90              |  0
 src/tomography/convert_model_file_adios.f90        |  2 +-
 src/tomography/interpolate_model.F90               |  0
 src/tomography/interpolate_model_kdtree.f90        |  4 +-
 src/tomography/sum_kernels.f90                     |  0
 src/tomography/sum_preconditioned_kernels.f90      |  0
 .../gpuTrace/gpu_helper_py.c                       |  0
 .../gpuTrace/instr-cuda.c                          |  4 +-
 .../gpuTrace/instr-ocl.c                           |  0
 .../gpuTrace/ldChecker.c                           |  0
 .../gpuTrace/ldChecker.h                           |  0
 .../gpuTrace/ldPreloader.c                         |  0
 .../VTK_ParaView/create_slice_VTK.f90              |  0
 .../opendx_AVS/convert_palette_GMT_OpenDX.f90      | 10 +--
 .../amplitude/create_adjsrc_amplitude.f90          |  0
 .../traveltime/create_adjsrc_traveltime.f90        |  0
 utils/check_cuda_device.cu                         |  0
 utils/check_opencl_device.c                        |  0
 .../create_superbrick_duplicates.f90               |  8 +--
 utils/doubling_brick/extract_unique_points.f90     |  8 +--
 .../routines_SEM_Bernhard_diff_lagrange.f90        | 10 +--
 utils/lib/convolve_stf.c                           |  2 +-
 utils/lib/rw_ascfile_c.c                           |  8 +--
 utils/lib/rw_fortran_wrapper.c                     |  0
 43 files changed, 209 insertions(+), 209 deletions(-)

diff --git a/DATA/s362ani/old_src_f77/mod.h b/DATA/s362ani/old_src_f77/mod.h
index 23c5803..d8befab 100644
--- a/DATA/s362ani/old_src_f77/mod.h
+++ b/DATA/s362ani/old_src_f77/mod.h
@@ -1,46 +1,46 @@
-	integer maxl
-	integer maxcoe
-	integer maxhpa
-	integer maxker
-	integer maxver
+  integer maxl
+  integer maxcoe
+  integer maxhpa
+  integer maxker
+  integer maxver
 
-	parameter (maxker=200)		
-	parameter (maxl=72)		
-	parameter (maxcoe=2000)		
-	parameter (maxver=1000)		
-	parameter (maxhpa=2)		
+  parameter (maxker=200)
+  parameter (maxl=72)
+  parameter (maxcoe=2000)
+  parameter (maxver=1000)
+  parameter (maxhpa=2)
 
-	integer numker
-	integer numhpa,numcof
-	integer ihpa,lmax,nylm
-	integer lmxhpa(maxhpa)
-	integer itypehpa(maxhpa)
-	integer ihpakern(maxker)
-	integer numcoe(maxhpa)
-	integer ivarkern(maxker)
-	integer itpspl(maxcoe,maxhpa)
+  integer numker
+  integer numhpa,numcof
+  integer ihpa,lmax,nylm
+  integer lmxhpa(maxhpa)
+  integer itypehpa(maxhpa)
+  integer ihpakern(maxker)
+  integer numcoe(maxhpa)
+  integer ivarkern(maxker)
+  integer itpspl(maxcoe,maxhpa)
 
-	integer nconpt(maxhpa),iver
-	integer iconpt(maxver,maxhpa)
-	real*4 conpt(maxver,maxhpa)	
+  integer nconpt(maxhpa),iver
+  integer iconpt(maxver,maxhpa)
+  real*4 conpt(maxver,maxhpa)
 
-	real*4 xlaspl(maxcoe,maxhpa)
-	real*4 xlospl(maxcoe,maxhpa)
-	real*4 radspl(maxcoe,maxhpa)
-	real*4 coe(maxcoe,maxker)
-	character*80 hsplfl(maxhpa)
-	character*40 dskker(maxker)
-	real*4 vercof(maxker)		 
-	real*4 vercofd(maxker)
+  real*4 xlaspl(maxcoe,maxhpa)
+  real*4 xlospl(maxcoe,maxhpa)
+  real*4 radspl(maxcoe,maxhpa)
+  real*4 coe(maxcoe,maxker)
+  character*80 hsplfl(maxhpa)
+  character*40 dskker(maxker)
+  real*4 vercof(maxker)
+  real*4 vercofd(maxker)
 
-	real*4 ylmcof((maxl+1)**2,maxhpa)
-	real*4 wk1(maxl+1)
-	real*4 wk2(maxl+1)
-	real*4 wk3(maxl+1)
+  real*4 ylmcof((maxl+1)**2,maxhpa)
+  real*4 wk1(maxl+1)
+  real*4 wk2(maxl+1)
+  real*4 wk3(maxl+1)
 
-	character*80 kerstr
-	character*80 refmdl		
-	character*40 varstr(maxker)
+  character*80 kerstr
+  character*80 refmdl
+  character*40 varstr(maxker)
 c
         common /mod/ numker,numhpa,numcof,ihpa,lmax,nylm,
      #  lmxhpa,itypehpa,ihpakern,numcoe,ivarkern,itpspl,
diff --git a/DATA/s362ani/src_f90/evradker.f90 b/DATA/s362ani/src_f90/evradker.f90
index bbd6d18..0da14b4 100644
--- a/DATA/s362ani/src_f90/evradker.f90
+++ b/DATA/s362ani/src_f90/evradker.f90
@@ -134,7 +134,7 @@
   vercof(1)=1.
 !        vercof(16)=1.
 !        vercof(17)=1.
-!      else if(string(1:21).eq.'WDC+ANI_362_U6L8_TOPO') then
+!      else if(string(1:21)=='WDC+ANI_362_U6L8_TOPO') then
 !        if(upper) then
 !         nspl=6
 !         splpts(1)=24.4
diff --git a/DATA/s362ani/src_f90/gt3dmodl.f90 b/DATA/s362ani/src_f90/gt3dmodl.f90
index fc9adca..3c782ee 100644
--- a/DATA/s362ani/src_f90/gt3dmodl.f90
+++ b/DATA/s362ani/src_f90/gt3dmodl.f90
@@ -56,7 +56,7 @@
   dskker(i)=desckern(i)
   do j=1,ncoefhor(ihpakern(i))
     coe(j,i)=coef(j,i)
-!          if(j.eq.1) then
+!          if(j==1) then
 !            write(6,"(e12.4)") coe(j,i)
 !          endif
   enddo
diff --git a/DATA/s362ani/src_f90/read_model_s362ani.f90 b/DATA/s362ani/src_f90/read_model_s362ani.f90
index ee6dee1..da1084a 100644
--- a/DATA/s362ani/src_f90/read_model_s362ani.f90
+++ b/DATA/s362ani/src_f90/read_model_s362ani.f90
@@ -22,11 +22,11 @@
   lu=1                    ! --- log unit: input 3-D model
   if(THREE_D_MODEL  ==  THREE_D_MODEL_S362ANI) then
     modeldef='DATA/s362ani/S362ANI'
-  elseif(THREE_D_MODEL  ==  THREE_D_MODEL_S362WMANI) then
+  else if(THREE_D_MODEL  ==  THREE_D_MODEL_S362WMANI) then
     modeldef='DATA/s362ani/S362WMANI'
-  elseif(THREE_D_MODEL  ==  THREE_D_MODEL_S362ANI_PREM) then
+  else if(THREE_D_MODEL  ==  THREE_D_MODEL_S362ANI_PREM) then
     modeldef='DATA/s362ani/S362ANI_PREM'
-  elseif(THREE_D_MODEL  ==  THREE_D_MODEL_S29EA) then
+  else if(THREE_D_MODEL  ==  THREE_D_MODEL_S29EA) then
     modeldef='DATA/s362ani/S2.9EA'
   else
     stop 'unknown 3D model in read_model_s362ani'
diff --git a/EXAMPLES/noise_examples/global_long/adj_traveltime_filter.f90 b/EXAMPLES/noise_examples/global_long/adj_traveltime_filter.f90
index a6031b1..6a48b78 100644
--- a/EXAMPLES/noise_examples/global_long/adj_traveltime_filter.f90
+++ b/EXAMPLES/noise_examples/global_long/adj_traveltime_filter.f90
@@ -62,20 +62,20 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -85,22 +85,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -118,7 +118,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -129,7 +129,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -145,8 +145,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -162,7 +162,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj'
@@ -170,14 +170,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -185,13 +185,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -285,7 +285,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -330,7 +330,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -369,7 +369,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/EXAMPLES/noise_examples/global_short/adj_traveltime_filter.f90 b/EXAMPLES/noise_examples/global_short/adj_traveltime_filter.f90
index 8935bc2..193e1bd 100644
--- a/EXAMPLES/noise_examples/global_short/adj_traveltime_filter.f90
+++ b/EXAMPLES/noise_examples/global_short/adj_traveltime_filter.f90
@@ -62,20 +62,20 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -85,22 +85,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -118,7 +118,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -129,7 +129,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -145,8 +145,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -162,7 +162,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj'
@@ -170,14 +170,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -185,13 +185,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -285,7 +285,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -330,7 +330,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -369,7 +369,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/EXAMPLES/noise_examples/regional/adj_traveltime_filter.f90 b/EXAMPLES/noise_examples/regional/adj_traveltime_filter.f90
index 8935bc2..193e1bd 100644
--- a/EXAMPLES/noise_examples/regional/adj_traveltime_filter.f90
+++ b/EXAMPLES/noise_examples/regional/adj_traveltime_filter.f90
@@ -62,20 +62,20 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -85,22 +85,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -118,7 +118,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -129,7 +129,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -145,8 +145,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -162,7 +162,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj'
@@ -170,14 +170,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -185,13 +185,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -285,7 +285,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -330,7 +330,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -369,7 +369,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/EXAMPLES/noise_examples/test_global/adj_traveltime_filter.f90 b/EXAMPLES/noise_examples/test_global/adj_traveltime_filter.f90
index 8311a53..603aaae 100644
--- a/EXAMPLES/noise_examples/test_global/adj_traveltime_filter.f90
+++ b/EXAMPLES/noise_examples/test_global/adj_traveltime_filter.f90
@@ -62,20 +62,20 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -85,22 +85,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -118,7 +118,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -129,7 +129,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -145,8 +145,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -162,7 +162,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj'
@@ -170,14 +170,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -185,13 +185,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -285,7 +285,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -330,7 +330,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -369,7 +369,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/EXAMPLES/noise_examples/test_regional/adj_traveltime_filter.f90 b/EXAMPLES/noise_examples/test_regional/adj_traveltime_filter.f90
index 8311a53..603aaae 100644
--- a/EXAMPLES/noise_examples/test_regional/adj_traveltime_filter.f90
+++ b/EXAMPLES/noise_examples/test_regional/adj_traveltime_filter.f90
@@ -62,20 +62,20 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -85,22 +85,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -118,7 +118,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -129,7 +129,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -145,8 +145,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -162,7 +162,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj'
@@ -170,14 +170,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -185,13 +185,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/A7.II.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -285,7 +285,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -330,7 +330,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -369,7 +369,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/EXAMPLES/regional_Greece_noise_small/adj_traveltime_filter.f90 b/EXAMPLES/regional_Greece_noise_small/adj_traveltime_filter.f90
index 709ccf6..89947c5 100644
--- a/EXAMPLES/regional_Greece_noise_small/adj_traveltime_filter.f90
+++ b/EXAMPLES/regional_Greece_noise_small/adj_traveltime_filter.f90
@@ -75,21 +75,21 @@ do irec = 1,nrec
    do itime = 1,nstep
            !read(1001,*) t(itime),data_origin(itime,irec)          ! original
            read(1001,*) t(itime),data_origin(nstep-itime+1,irec)  ! reversed
-   end do
+   enddo
    close(1001)
 
    data_temp(1)=0.0
    data_temp(nstep)=0.0
    do itime = 2,nstep-1
       data_temp(itime)=( data_origin(itime+1,irec) - data_origin(itime-1,irec) )/(2*dt)
-   end do
+   enddo
    data_origin(:,irec)=data_temp
    trace_data_max(irec)=maxval(abs(data_temp))
-end do
+enddo
 
 do itime = 1,nstep
    t(itime) = t(itime)-t(1)
-end do
+enddo
 data_max=maxval(trace_data_max)
 
 !!!! taper !!!!
@@ -99,22 +99,22 @@ allocate(adj_temp(length_window)); adj_temp(:)=0.0d0
 allocate(corre(2*length_window-1)); corre(:)=0.0d0
 allocate(data_trace_temp(length_window)); data_trace_temp(:)=0.0d0
 allocate(syn_trace_temp(length_window)); syn_trace_temp(:)=0.0d0
-if (taper_type .eq. 1) then  ! cosine taper, otherwise using a constant (1.0) instead
+if (taper_type == 1) then  ! cosine taper, otherwise using a constant (1.0) instead
    do l=1,length_window
       taper(l) = (1.0-cos(pi*2.0*(l-1)/(length_window-1)))/2.0
-   end do
-end if
+   enddo
+endif
 
 !!!! computing adj sources !!!!
-                  if (filter_flag .eq. 0)   then
+                  if (filter_flag == 0)   then
                       nfreq=1
-                  end if
+                  endif
 do irec = 1,nrec
    do ifreq = 1,nfreq
                   data_filtered(:,irec)=data_origin(:,irec)
                    syn_filtered(:,irec)= syn_origin(:,irec)
                   !!!!!!!!!!!!!!!!!! to be implemented !!!!!!!!!!!!!!!!!
-                  if (filter_flag .eq. 1) then
+                  if (filter_flag == 1) then
                   ! THIS SECTION CALCULATES THE FILTER AND MUST BE CALLED BEFORE
                   ! FILTER IS CALLED
                       F1=freq_low(ifreq)
@@ -132,7 +132,7 @@ do irec = 1,nrec
                   !     G = FILTER GAIN
                   !     IG = 1  one pass
                   !     ig = 2  two passes
-                  end if
+                  endif
 
 
 
@@ -143,7 +143,7 @@ do irec = 1,nrec
    data_trace=data_filtered(:,irec)
     syn_trace= syn_filtered(:,irec)
 !   if ( ( trace_data_max(irec) > (factor*data_max) ) .and. (trace_syn_max(irec) > (factor*syn_max)) ) then
-   if (1 .eq. 1) then
+   if (1 == 1) then
       !!!! cross-correlation !!!!
       do i_start_window = (nstep+1)/2, (nstep+1)/2                                 !the positive branch
 !      do i_start_window = (nstep+1)/2 - length_window, (nstep+1)/2 - length_window  !the negative branch
@@ -159,8 +159,8 @@ do irec = 1,nrec
 
          w(:)=0.0
          w(i_start_window : i_end_window)=taper
-      end do
-   end if
+      enddo
+   endif
    data_trace=data_trace*w
    data_filtered(:,irec)=data_trace
    !!!! normal adjoint sources !!!!
@@ -176,7 +176,7 @@ do irec = 1,nrec
          misfit_traveltime = misfit_traveltime + traveltime_delay * traveltime_delay / 2.0
          write(1111,*) traveltime_delay
 
-   end do  !do ifreq=1,nfreq
+   enddo  !do ifreq=1,nfreq
 
    !!!! output !!!!
    file_adj_BHZ      = './SEM/'//trim(station)//'.'//trim(network)//'.MXZ.adj'
@@ -184,14 +184,14 @@ do irec = 1,nrec
    do itime = 1,nstep
       write(1002,*) t(itime), adj(nstep-itime+1,irec)
 !      write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/'//trim(station)//'.'//trim(network)//'.MXZ.adj_reversed'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
 !      write(1002,*) t(itime), adj(nstep-itime+1,irec)
       write(1002,*) t(itime), adj(itime,irec)
-   end do
+   enddo
    close(1002)
 
 
@@ -199,13 +199,13 @@ do irec = 1,nrec
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
    file_adj_BHZ      = './SEM/'//trim(station)//'.'//trim(network)//'.MXN.adj'
    open(unit=1002,file=trim(file_adj_BHZ),status='unknown')
    do itime = 1,nstep
       write(1002,*) t(itime), 0.0
-   end do
+   enddo
    close(1002)
 
 enddo
@@ -291,7 +291,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
 !     IG = 1  one pass
 !     ig = 2  two passes
 
-      IF (ISW.EQ.1) GO TO 31                                            
+      IF (ISW==1) GO TO 31
       WRITE (6,6)
     6 FORMAT ('1BNDPAS MUST BE CALLED BEFORE FILTER')
       return
@@ -336,7 +336,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
    39 X(I)=XE(M)-XE(M2)-D(7)*X(I-1)-D(8)*X(I-2)
 !
 !
-      if(ig.eq.1) goto 3333                                             
+      if(ig==1) goto 3333
       XM2=X(N)
       XM1=X(N-1)
       XM=X(N-2)
@@ -375,7 +375,7 @@ SUBROUTINE BNDPAS(F1,F2,DELT,D,G,N)
       XE(M)=XD(M)-XD(M2)-D(5)*XE(M1)-D(6)*XE(M2)
    49 X(J)=XE(M)-XE(M2)-D(7)*X(J+1)-D(8)*X(J+2)
  3333 continue
-      if (ig.eq.1) then
+      if (ig==1) then
         gg=sqrt(g)   ! if only pass once, modify gain
       else
         gg=g
diff --git a/src/specfem3D/read_write_netcdf.f90 b/src/specfem3D/read_write_netcdf.f90
index ef5a445..9fe371e 100644
--- a/src/specfem3D/read_write_netcdf.f90
+++ b/src/specfem3D/read_write_netcdf.f90
@@ -2,7 +2,7 @@ subroutine write_coordinates_netcdf (fName)
 
   ! This writes the corresponding kernel coordinates.
 
-  use :: mpi
+  use mpi
   use :: netcdf
   use :: specfem_par
   use :: specfem_par_crustmantle
@@ -59,7 +59,7 @@ subroutine write_kernel_netcdf (fName, param)
 
   ! This guy converts the kernels to global numbering, and writes to a NetCDF file in parallel.
 
-  use :: mpi
+  use mpi
   use :: netcdf
   use :: specfem_par
   use :: specfem_par_crustmantle
@@ -97,10 +97,10 @@ subroutine write_kernel_netcdf (fName, param)
           iglob                 = ibool_crust_mantle (i, j, k, ispec)
           paramUnpacked (iglob) = param (i, j, k, ispec)
 
-        end do
-      end do
-    end do
-  end do
+        enddo
+      enddo
+    enddo
+  enddo
 
   ! Create the parallel NetCDF file.
   call checkNC (nf90_create (fName, IOR(NF90_NETCDF4, NF90_MPIIO), ncid, &
@@ -149,6 +149,6 @@ subroutine checkNC (status)
   if (status /= nf90_noerr) then
     print *, trim (nf90_strerror (status))
     stop 'Netcdf error.'
-  end if
+  endif
 
 end subroutine checkNC
diff --git a/src/tomography/convert_model_file_adios.f90 b/src/tomography/convert_model_file_adios.f90
index 389eb53..a271dd5 100644
--- a/src/tomography/convert_model_file_adios.f90
+++ b/src/tomography/convert_model_file_adios.f90
@@ -373,7 +373,7 @@ program convert_model_file_adios
     if (myrank==0) print *, 'done writing the model in binary format'
 
 !--------------------------------------------
-  elseif (convert_format == 2) then ! from binaries to adios
+  else if (convert_format == 2) then ! from binaries to adios
 !--------------------------------------------
 
 ! READ THE MODEL IN OLD BINARY FORMAT
diff --git a/src/tomography/interpolate_model_kdtree.f90 b/src/tomography/interpolate_model_kdtree.f90
index c865e21..b51a330 100644
--- a/src/tomography/interpolate_model_kdtree.f90
+++ b/src/tomography/interpolate_model_kdtree.f90
@@ -543,13 +543,13 @@ contains
   if (associated(node%left)) then
      call delete_node(node%left)
      nullify (node%left)
-  end if
+  endif
 
   ! deletes right hemisphere
   if (associated(node%right)) then
      call delete_node(node%right)
      nullify (node%right)
-  end if
+  endif
 
   deallocate(node)
 
diff --git a/utils/BOAST_framework_to_develop_the_CUDA_and_OpenCL_routines_of_SPECFEM/gpuTrace/instr-cuda.c b/utils/BOAST_framework_to_develop_the_CUDA_and_OpenCL_routines_of_SPECFEM/gpuTrace/instr-cuda.c
index 655bfdb..3196a81 100644
--- a/utils/BOAST_framework_to_develop_the_CUDA_and_OpenCL_routines_of_SPECFEM/gpuTrace/instr-cuda.c
+++ b/utils/BOAST_framework_to_develop_the_CUDA_and_OpenCL_routines_of_SPECFEM/gpuTrace/instr-cuda.c
@@ -6,8 +6,8 @@
 #include "ldChecker.h"
 
 cudaError_t (*real_cudaGetDeviceCount)(int *count);
-cudaError_t (*real_cudaMalloc) 	(void **devPtr, size_t size);
-cudaError_t (*real_cudaMemcpy) 	(void *dst, const void *src,
+cudaError_t (*real_cudaMalloc)  (void **devPtr, size_t size);
+cudaError_t (*real_cudaMemcpy)  (void *dst, const void *src,
                                  size_t count, enum cudaMemcpyKind kind);
 cudaError_t (*real_cudaMemcpyToSymbol)(const void *symbol, const void *src,
                                        size_t count, size_t offset,
diff --git a/utils/Visualization/opendx_AVS/convert_palette_GMT_OpenDX.f90 b/utils/Visualization/opendx_AVS/convert_palette_GMT_OpenDX.f90
index 92a6548..7907b88 100644
--- a/utils/Visualization/opendx_AVS/convert_palette_GMT_OpenDX.f90
+++ b/utils/Visualization/opendx_AVS/convert_palette_GMT_OpenDX.f90
@@ -168,7 +168,7 @@ subroutine rgb_to_hsv ( r, g, b, h, s, v )
     s = ( rgbmax - rgbmin ) / rgbmax
   else
     s = 0.0E+00
-  end if
+  endif
 !
 !  Compute the hue.
 !
@@ -188,7 +188,7 @@ subroutine rgb_to_hsv ( r, g, b, h, s, v )
       h = 2.0E+00 + rc - bc
     else
       h = 4.0E+00 + gc - rc
-    end if
+    endif
 
     h = h * 60.0E+00
 !
@@ -196,7 +196,7 @@ subroutine rgb_to_hsv ( r, g, b, h, s, v )
 !
     h = r_modp ( h, 360.0E+00 )
 
-  end if
+  endif
 
 end
 
@@ -264,13 +264,13 @@ function r_modp ( x, y )
     write ( *, '(a)' ) 'R_MODP - Fatal error!'
     write ( *, '(a,g14.6)' ) '  R_MODP ( X, Y ) called with Y = ', y
     stop
-  end if
+  endif
 
   r_modp = mod ( x, y )
 
   if ( r_modp < 0.0E+00 ) then
     r_modp = r_modp + abs ( y )
-  end if
+  endif
 
 end
 
diff --git a/utils/doubling_brick/create_superbrick_duplicates.f90 b/utils/doubling_brick/create_superbrick_duplicates.f90
index 7d34336..edf4106 100644
--- a/utils/doubling_brick/create_superbrick_duplicates.f90
+++ b/utils/doubling_brick/create_superbrick_duplicates.f90
@@ -298,23 +298,23 @@
          ind(1)=indx
          return
       endif
-   ENDIF
+   endif
    i=l
    j=l+l
   200    CONTINUE
    IF (J <= IR) THEN
       IF (J<IR) THEN
          IF ( A(IND(j))<A(IND(j+1)) ) j=j+1
-      ENDIF
+      endif
       IF (q<A(IND(j))) THEN
          IND(I)=IND(J)
          I=J
          J=J+J
       ELSE
          J=IR+1
-      ENDIF
+      endif
    goto 200
-   ENDIF
+   endif
    IND(I)=INDX
   goto 100
   end subroutine rank
diff --git a/utils/doubling_brick/extract_unique_points.f90 b/utils/doubling_brick/extract_unique_points.f90
index 8711b23..cdf1cb9 100644
--- a/utils/doubling_brick/extract_unique_points.f90
+++ b/utils/doubling_brick/extract_unique_points.f90
@@ -256,23 +256,23 @@
          ind(1)=indx
          return
       endif
-   ENDIF
+   endif
    i=l
    j=l+l
   200    CONTINUE
    IF (J <= IR) THEN
       IF (J<IR) THEN
          IF ( A(IND(j))<A(IND(j+1)) ) j=j+1
-      ENDIF
+      endif
       IF (q<A(IND(j))) THEN
          IND(I)=IND(J)
          I=J
          J=J+J
       ELSE
          J=IR+1
-      ENDIF
+      endif
    goto 200
-   ENDIF
+   endif
    IND(I)=INDX
   goto 100
   end subroutine rank
diff --git a/utils/funaro_routines_bernhard/routines_SEM_Bernhard_diff_lagrange.f90 b/utils/funaro_routines_bernhard/routines_SEM_Bernhard_diff_lagrange.f90
index 9933973..8840217 100644
--- a/utils/funaro_routines_bernhard/routines_SEM_Bernhard_diff_lagrange.f90
+++ b/utils/funaro_routines_bernhard/routines_SEM_Bernhard_diff_lagrange.f90
@@ -46,13 +46,13 @@ X=-1+REAL(j)/1000.*2
 !CALL VALEPO(N,X,Y,DY,D2Y)
 CALL ZELEGL(N,ET,VN)
 !WRITE(5,*)X,Y,DY,D2Y
-ENDDO
+enddo
 DO j=0,N
 
   xi(j)=ET(j)
 
 !WRITE(6,*)ET(j),VN(j)
-ENDDO
+enddo
 !CLOSE(5)
 !CLOSE(6)
 
@@ -105,7 +105,7 @@ END SUBROUTINE main_pol
          D2YM = D2Y
          D2Y  = (C2*X*D2Y-C4*D2YP+2.D0*C2*DYP)/C1
          D2YP = D2YM
-       ENDDO
+       enddo
 
       RETURN
 
@@ -153,12 +153,12 @@ END SUBROUTINE VALEPO
         DO IT=1,8
          CALL VALEPO(N,ETX,Y,DY,D2Y)
          ETX = ETX-DY/D2Y
-        ENDDO
+        enddo
         ET(I) = -ETX
         ET(N-I) = ETX
         VN(I) = Y*SN
         VN(N-I) = Y
-      ENDDO
+      enddo
 
       RETURN
       END SUBROUTINE ZELEGL
diff --git a/utils/lib/convolve_stf.c b/utils/lib/convolve_stf.c
index 1809e8c..223819b 100644
--- a/utils/lib/convolve_stf.c
+++ b/utils/lib/convolve_stf.c
@@ -185,7 +185,7 @@ main(int argc, char *argv[])
         getfhv("o", &origin, &nerr, strlen("o"));
         if(nerr) {
             /* Assuming origin time is 0, per convention of SPECFEM */
-	    fprintf(stderr, " Ignoring the error, assuming origin time is 0\n");
+      fprintf(stderr, " Ignoring the error, assuming origin time is 0\n");
             origin = 0.0;
             setfhv("o", &origin, &nerr, strlen("o"));
         }
diff --git a/utils/lib/rw_ascfile_c.c b/utils/lib/rw_ascfile_c.c
index 253fbb4..3428075 100644
--- a/utils/lib/rw_ascfile_c.c
+++ b/utils/lib/rw_ascfile_c.c
@@ -5,8 +5,8 @@
 
 
 void dread_ascfile_c_(const char *ascfile,
-		   double *t0, double *dt, int *n,
-		   double *data) 
+       double *t0, double *dt, int *n,
+       double *data)
 
 {
   FILE *fd;
@@ -33,8 +33,8 @@ void dread_ascfile_c_(const char *ascfile,
 }
 
 void dwrite_ascfile_c_(const char *ascfile,
-		    double *t0, double *dt, int *n,
-		    const double *data) 
+        double *t0, double *dt, int *n,
+        const double *data)
 
 {
   FILE *fd;



More information about the CIG-COMMITS mailing list