From 345097cf9f8a3fcebdba3c7828f3a3c9f3c525f9 Mon Sep 17 00:00:00 2001 From: Thomas Gastine Date: Fri, 13 Sep 2024 15:16:11 +0200 Subject: [PATCH] remove trailing white spaces --- src/blocking.f90 | 2 +- src/mpi_transpose.f90 | 6 +++--- src/outMisc.f90 | 8 ++++---- src/out_TO.f90 | 4 ++-- src/output_data.f90 | 10 +++++----- src/readCheckPoints.f90 | 10 +++++----- src/spectra.f90 | 6 +++--- 7 files changed, 23 insertions(+), 23 deletions(-) diff --git a/src/blocking.f90 b/src/blocking.f90 index 61c3cd4f..5c7d0a4f 100644 --- a/src/blocking.f90 +++ b/src/blocking.f90 @@ -157,7 +157,7 @@ subroutine initialize_blocking() & m_min,m_max,lm_balance) !--- Getting lm sub-blocks: - call get_subblocks(st_map, st_sub_map) + call get_subblocks(st_map, st_sub_map) !PRINT*," ---------------- Making the lorder subblocks ---------------- " call get_subblocks(lo_map, lo_sub_map) !PRINT*," ---------------- Making the snake order subblocks ----------- " diff --git a/src/mpi_transpose.f90 b/src/mpi_transpose.f90 index f01dc9d7..35305210 100644 --- a/src/mpi_transpose.f90 +++ b/src/mpi_transpose.f90 @@ -24,7 +24,7 @@ module mpi_transp_mod procedure(transp_r2lm_if), deferred :: transp_r2lm end type type_mpitransp - interface + interface subroutine create_if(this, n_fields) import @@ -386,7 +386,7 @@ subroutine transp_lm2r_alltoallp(this, arr_LMloc, arr_Rloc) do lm = ulm-llm+1,this%lm_loc-1 ii = ii+1 end do - end do + end do !-- Padding happens here do n_r=radial_balance(p)%n_per_rank,this%n_r_loc-1 ii=ii+1 @@ -1057,7 +1057,7 @@ subroutine r2lm_redist_start(this,arr_rloc,arr_LMloc) end do else call MPI_Irecv(arr_LMloc(llm,radial_balance(recv_pe)%nStart,1), & - & 1,this%r_transfer_type_cont(rank+1,this%n_fields), & + & 1,this%r_transfer_type_cont(rank+1,this%n_fields), & & recv_pe,transfer_tag,MPI_COMM_WORLD, & & this%r_request(irank),ierr) call MPI_Isend(arr_Rloc(lm_balance(send_pe)%nStart,nRstart,1), & diff --git a/src/outMisc.f90 b/src/outMisc.f90 index 8c7b528b..240722ff 100644 --- a/src/outMisc.f90 +++ b/src/outMisc.f90 @@ -210,12 +210,12 @@ subroutine finalize_outMisc_mod() close(n_drift_asym_file) end if end if - if ( l_hemi ) then + if ( l_hemi ) then deallocate( hemi_ekin_r, hemi_vrabs_r ) if ( l_mag ) deallocate( hemi_emag_r, hemi_brabs_r ) end if if ( l_hel ) deallocate( HelASr, Hel2ASr, HelnaASr, Helna2ASr, HelEAASr ) - + if ( l_phase_field ) then if ( l_dtphaseMovie ) deallocate( dtemp_Rloc, dtemp_Ploc, dt_rmelt_loc) deallocate( temp_Rloc, phi_Rloc, temp_Ploc, phi_Ploc, phi_balance ) @@ -237,7 +237,7 @@ end subroutine finalize_outMisc_mod !---------------------------------------------------------------------------------- subroutine outHemi(timeScaled) ! - ! This function handles the writing of outputs related to hemisphericity of + ! This function handles the writing of outputs related to hemisphericity of ! the kinetic and magnetic energy between Northern and Southern hemispheres. ! This is based on Wieland Dietrich's work (see Dietrich & Wicht, 2013). ! Outputs are stored in the time series hemi.TAG @@ -1212,7 +1212,7 @@ subroutine get_rmelt_tmelt(phase, temp, rphase, tphase, dtemp, dtphase) if ( n_r_phase == n_r_cmb ) then rphase=r_cmb tphase=temp(n_r_cmb) - else + else if ( n_r_phase == n_r_cmb+1 ) then n_r_start=n_r_phase-1 n_r_stop =n_r_phase+2 diff --git a/src/out_TO.f90 b/src/out_TO.f90 index bede43f2..e66b9970 100644 --- a/src/out_TO.f90 +++ b/src/out_TO.f90 @@ -738,7 +738,7 @@ end subroutine get_ds !------------------------------------------------------------------------------------ subroutine get_dds(arr, ddarr, cyl) ! - ! This subroutine is used to compute the 4th order accurate 2nd s-derivative + ! This subroutine is used to compute the 4th order accurate 2nd s-derivative ! on the regularly spaced grid ! ! https://bellaard.com/tools/Finite%20difference%20coefficient%20calculator/ @@ -781,7 +781,7 @@ subroutine gather_from_Rloc_to_rank0(arr_Rloc, arr) ! ! This subroutine gathers the r-distributed array ! - + !-- Input variable real(cp), intent(in) :: arr_Rloc(n_theta_max,nRstart:nRstop) diff --git a/src/output_data.f90 b/src/output_data.f90 index bac0404f..43ead21c 100644 --- a/src/output_data.f90 +++ b/src/output_data.f90 @@ -10,10 +10,10 @@ module output_data implicit none private - + !----- Identification of run: character(len=64), public :: runid - + !----- Output time control: real(cp), public :: t_graph_start,t_graph_stop,dt_graph real(cp), public :: t_rst_start,t_rst_stop,dt_rst @@ -49,7 +49,7 @@ module output_data real(cp), allocatable, public :: t_TOmovie(:) real(cp), allocatable, public :: t_pot(:) real(cp), allocatable, public :: t_probe(:) - + !----- Output radii and degrees for coeff files: integer, public :: n_coeff_r_max integer, public, allocatable :: n_coeff_r(:) @@ -60,10 +60,10 @@ module output_data integer, public :: l_max_r integer, public :: n_r_step integer, public :: m_max_modes - + !----- Output files: integer, public :: n_log_file - + character(len=55), public :: tag character(len=72), public :: log_file character(len=72), public :: lp_file diff --git a/src/readCheckPoints.f90 b/src/readCheckPoints.f90 index cf0a9981..da5c85f9 100644 --- a/src/readCheckPoints.f90 +++ b/src/readCheckPoints.f90 @@ -565,7 +565,7 @@ subroutine readStartFields_old(w,dwdt,z,dzdt,p,dpdt,s,dsdt,xi,dxidt,phi, & & djdt_ic%expl(llm:ulm,nR,2)) end do - call get_mag_ic_rhs_imp(b_ic, db_ic_LMloc, ddb_ic_LMloc, aj_ic, & + call get_mag_ic_rhs_imp(b_ic, db_ic_LMloc, ddb_ic_LMloc, aj_ic, & & dj_ic_LMloc, ddj_ic_LMloc, dbdt_ic, & & djdt_ic, 1, .true.) dbdt_ic%expl(:,:,2)=dbdt_ic%expl(:,:,2)+coex*dbdt_ic%impl(:,:,1) @@ -1604,7 +1604,7 @@ end subroutine read_map_one_field subroutine readStartFields_mpi(w,dwdt,z,dzdt,p,dpdt,s,dsdt,xi,dxidt,phi, & & dphidt,b,dbdt,aj,djdt,b_ic,dbdt_ic,aj_ic, & & djdt_ic,omega_ic,omega_ma,domega_ic_dt, & - & domega_ma_dt,time,tscheme,n_time_step) + & domega_ma_dt,time,tscheme,n_time_step) ! ! This subroutine is used to read the restart files produced ! by MagIC using MPI-IO @@ -1684,7 +1684,7 @@ subroutine readStartFields_mpi(w,dwdt,z,dzdt,p,dpdt,s,dsdt,xi,dxidt,phi, & !-- Read the header call MPI_File_Read(fh, version, 1, MPI_INTEGER, istat, ierr) - !-- Little trick if wrong-endianness is detected + !-- Little trick if wrong-endianness is detected !-- version gets crazy large, so flip back to default reader then if ( abs(version) > 100 ) then call MPI_File_close(fh, ierr) @@ -1925,7 +1925,7 @@ subroutine readStartFields_mpi(w,dwdt,z,dzdt,p,dpdt,s,dsdt,xi,dxidt,phi, & call MPI_File_Read(fh, itest, 1, MPI_INTEGER, istat, ierr) l_cond_ic_old = itest /= 0 - !-- Measure offset + !-- Measure offset call MPI_File_get_position(fh, offset, ierr) call MPI_File_get_byte_offset(fh, offset, disp, ierr) @@ -2462,7 +2462,7 @@ subroutine read_map_one_field_mpi(fh, info, datatype, tscheme, wOld, & disp = disp+size_old call MPI_File_Set_View(fh, disp, MPI_DEF_COMPLEX, datatype, "native", & & info, ierr) - if ( n_o <= tscheme%nold .and. l_map .and. & + if ( n_o <= tscheme%nold .and. l_map .and. & & tscheme%family=='MULTISTEP' ) then call mapOneField_mpi( wOld, lm_max_old, n_r_max_old, nRstart_old, & & nRstop_old, radial_balance_old, lm2lmo, & diff --git a/src/spectra.f90 b/src/spectra.f90 index 8fb63e39..aed92fc2 100644 --- a/src/spectra.f90 +++ b/src/spectra.f90 @@ -356,7 +356,7 @@ subroutine spectrum(n_spec,time,l_avg,n_time_ave,l_stop_time,time_passed, & e_mag_p_ic_m(:)=0.0_cp; e_mag_t_ic_m(:)=0.0_cp end if - !-- Extra outputs specific to magnetic spectra + !-- Extra outputs specific to magnetic spectra eCMB(:)=0.0_cp do lm=llm,ulm l=lo_map%lm2l(lm) @@ -466,7 +466,7 @@ subroutine spectrum(n_spec,time,l_avg,n_time_ave,l_stop_time,time_passed, & & ml,round_off(e_kin_p_l(ml),maxval(e_kin_p_l),cut), & & round_off(e_kin_p_m(ml),maxval(e_kin_p_m),cut), & & round_off(e_kin_t_l(ml),maxval(e_kin_t_l),cut), & - & round_off(e_kin_t_m(ml),maxval(e_kin_t_m),cut), & + & round_off(e_kin_t_m(ml),maxval(e_kin_t_m),cut), & & round_off(e_kin_nearSurf_l(ml),maxval(e_kin_nearSurf_l),cut), & & round_off(e_kin_nearSurf_m(ml),maxval(e_kin_nearSurf_m),cut), & & round_off(e_mer_l(ml),maxval(e_mer_l),cut), & @@ -836,7 +836,7 @@ subroutine spectrum_scal(scal,T_l,T_m,T_ICB_l,T_ICB_m,dscal,dT_ICB_l,dT_ICB_m) real(cp) :: T_temp, dT_temp, surf_ICB, fac, facICB real(cp) :: T_r_l(n_r_max,0:l_max),T_r_l_global(n_r_max,0:l_max) real(cp) :: T_r_m(n_r_max,0:l_max),T_r_m_global(n_r_max,0:l_max) - real(cp) :: T_ICB_l_global(0:l_max), dT_ICB_l_global(0:l_max) + real(cp) :: T_ICB_l_global(0:l_max), dT_ICB_l_global(0:l_max) real(cp) :: T_ICB_m_global(0:l_max), dT_ICB_m_global(0:l_max) if ( present(T_ICB_l) ) then