Skip to content

Commit

Permalink
remove trailing white spaces
Browse files Browse the repository at this point in the history
  • Loading branch information
tgastine committed Sep 13, 2024
1 parent 345097c commit 84175ef
Show file tree
Hide file tree
Showing 12 changed files with 95 additions and 95 deletions.
8 changes: 4 additions & 4 deletions src/LMmapping.f90
Original file line number Diff line number Diff line change
Expand Up @@ -6,15 +6,15 @@ module LMmapping
use parallel_mod, only: load

implicit none

private

type, public :: mappings
integer :: l_max, m_max, lm_max ,m_min
integer, allocatable :: lm2(:,:),lm2l(:),lm2m(:)
integer, allocatable :: lm2lmS(:), lm2lmA(:)
end type mappings

type, public :: subblocks_mappings
integer :: nLMBs,l_max,m_max,sizeLMB2max,m_min
integer, allocatable :: nLMBs2(:)
Expand All @@ -23,7 +23,7 @@ module LMmapping
integer, allocatable :: lm22l(:,:,:)
integer, allocatable :: lm22m(:,:,:)
end type subblocks_mappings

public :: allocate_mappings, deallocate_mappings, &
& allocate_subblocks_mappings, deallocate_subblocks_mappings

Expand Down
16 changes: 8 additions & 8 deletions src/Makefile
Original file line number Diff line number Diff line change
Expand Up @@ -76,12 +76,12 @@ ifeq ($(COMPILER),intel)
else
COMP_MPFC = mpiifort
COMP_MPCC = mpiicc
endif
endif

FFLAG_MKL_LIBS = -L$(MKLROOT)/lib/intel64 -lmkl_intel_lp64 \
-lmkl_lapack95_lp64\
-lmkl_sequential -lmkl_core -lpthread -lm \
-Wl,-rpath,$(MKLROOT)/lib/intel64
-Wl,-rpath,$(MKLROOT)/lib/intel64

endif
ifeq ($(COMPILER),gnu)
Expand All @@ -94,7 +94,7 @@ ifeq ($(COMPILER),gnu)
FFLAG_PREPROCESSOR = -cpp
FFLAG_WARN_ALL = -Wall -Wno-maybe-uninitialized
FFLAG_CHECK_ALL = -fcheck=all
FFLAG_FPE = -ffpe-trap=invalid,zero,overflow
FFLAG_FPE = -ffpe-trap=invalid,zero,overflow
COMP_FC = gfortran
COMP_CC = gcc
COMP_MPFC = mpif90
Expand Down Expand Up @@ -212,7 +212,7 @@ ifeq ($(PRODRUN),yes)
DEBUG=no
OPT += -O3 $(FFLAG_ARCH_OPT)
else
OPT += -O
OPT += -O
endif
ifeq ($(USE_OMP),yes)
FFLAGS += $(FFLAG_OPENMP)
Expand All @@ -238,7 +238,7 @@ endif

INCPATHS += -I.

FFLAGS += $(FFLAG_CONVERT)
FFLAGS += $(FFLAG_CONVERT)
FFLAGS += $(FFLAG_PREPROCESSOR) $(OPT)
LDFLAGS =

Expand Down Expand Up @@ -296,7 +296,7 @@ endif
OBJS := $(addsuffix .o, $(basename $(RED_SOURCES)))
OBJS += truncation.o

.SUFFIXES:
.SUFFIXES:

#ifeq ($(COMPILER),gnu)
#ifeq ($(USE_MPI),yes)
Expand Down Expand Up @@ -513,7 +513,7 @@ preCalculations.o : truncation.o phys_param.o num_param.o constants.o\
useful.o integration.o parallel.o special.o
RMS_helpers.o : truncation.o blocking.o radial.o constants.o\
horizontal.o useful.o integration.o\
LMmapping.o
LMmapping.o
kinetic_energy.o : truncation.o blocking.o num_param.o radial.o\
horizontal.o output_data.o logic.o constants.o\
phys_param.o useful.o integration.o\
Expand All @@ -539,7 +539,7 @@ RMS.o : truncation.o blocking.o mem_alloc.o
init_fields.o : truncation.o blocking.o radial.o horizontal.o\
constants.o logic.o $(FFT_OBJS) $(SHT_OBJS)\
useful.o phys_param.o mpi_transpose.o\
$(DCT_OBJS) mem_alloc.o parallel.o
$(DCT_OBJS) mem_alloc.o parallel.o
mean_sd.o : precision_mod.o mem_alloc.o matrices.o communications.o
movie.o : truncation.o parallel.o radial_data.o\
output_data.o logic.o radial.o mem_alloc.o\
Expand Down
4 changes: 2 additions & 2 deletions src/README.md
Original file line number Diff line number Diff line change
Expand Up @@ -5,7 +5,7 @@
Set a suitable compiler in the first line of the Makefile: `COMPILER = <compiler_phrase>`. The options are `intel`, `gnu` or `portland` - depending on your available compilers.

**Table** : List of default compilers

| Compiler Option | Normal | With MPI |
|:---------------:|:-------------:|:----------------:|
| intel | ifort, icc | mpiifort, mpiicc |
Expand All @@ -17,7 +17,7 @@ Set a suitable compiler in the first line of the Makefile: `COMPILER = <compiler
* `PRODRUN` Set it to `yes` for production run, `no` for debugging.
* `PRECISION` Set it to 'dble' for double-precision calculations or to 'sngl' for single-precision calculations
* `OUT_PREC` Set it to 'dble' for double-precision in binary outputs or to 'sngl' for single precision
* `DEBUG` Set to `yes` to run in debugging mode. *While running in debugging mode, set* `PRODRUN` *to* `no`. The debug mode with intel compilers uses `marmot90`.
* `DEBUG` Set to `yes` to run in debugging mode. *While running in debugging mode, set* `PRODRUN` *to* `no`. The debug mode with intel compilers uses `marmot90`.
* `USE_MPI` Set to `yes` to use MPI
* `USE_OMP` Set to `yes` to use openmp (cannot work without MPI)
* `USE_PRECOND` Set to `yes` to perform some pre-conditioning of the matrices
Expand Down
2 changes: 1 addition & 1 deletion src/dirk_schemes.f90
Original file line number Diff line number Diff line change
Expand Up @@ -784,7 +784,7 @@ subroutine set_weights(this, lMatNext)

this%butcher_ass_imp(:) = this%dt(1)*this%butcher_ass_imp(:)
this%butcher_ass_exp(:) = this%dt(1)*this%butcher_ass_exp(:)

end subroutine set_weights
!------------------------------------------------------------------------------
subroutine set_dt_array(this, dt_new, dt_min, time, n_log_file, &
Expand Down
2 changes: 1 addition & 1 deletion src/dt_fieldsLast.f90
Original file line number Diff line number Diff line change
Expand Up @@ -151,7 +151,7 @@ subroutine initialize_fieldsLast(nold, nexp, nimp)
dVSrLM_Rloc(:,:) =zero
dVxBhLM_Rloc(:,:)=zero
bytes_allocated = bytes_allocated+ &
& 6*lm_max*(nRstop-nRstart+1)*SIZEOF_DEF_COMPLEX+&
& 6*lm_max*(nRstop-nRstart+1)*SIZEOF_DEF_COMPLEX+&
& 3*lm_maxMag*(nRstopMag-nRstartMag+1)*SIZEOF_DEF_COMPLEX
else
if ( l_double_curl ) then
Expand Down
6 changes: 3 additions & 3 deletions src/multistep_schemes.f90
Original file line number Diff line number Diff line change
Expand Up @@ -190,13 +190,13 @@ subroutine set_weights(this, lMatNext)
!-- Local variables
real(cp) :: delta, delta_n, delta_n_1, delta_n_2
real(cp) :: a0, a1, a2, a3, a4, b0, b1, b2, b3, c0, c1, c2, c3
real(cp) :: gam, theta, c
real(cp) :: gam, theta, c
real(cp) :: wimp_old

wimp_old = this%wimp_lin(1)

select case ( this%time_scheme )
case ('CNAB2')
case ('CNAB2')
this%wimp(1) =one
this%wimp_lin(1)=alpha*this%dt(1)
this%wimp_lin(2)=(1-alpha)*this%dt(1)
Expand All @@ -213,7 +213,7 @@ subroutine set_weights(this, lMatNext)

this%wexp(1)=(one+delta)*this%dt(1)
this%wexp(2)=0.0_cp
case ('MODCNAB')
case ('MODCNAB')
delta = this%dt(1)/this%dt(2)
this%wimp(1) =one
this%wimp(2) =0.0_cp
Expand Down
2 changes: 1 addition & 1 deletion src/nonlinear_bcs.f90
Original file line number Diff line number Diff line change
Expand Up @@ -90,7 +90,7 @@ subroutine get_b_nl_bcs(bc,br_vt_lm,br_vp_lm,b_nl_bc,aj_nl_bc)

if ( bc == 'CMB' ) then

b_nl_bc(1) =zero
b_nl_bc(1) =zero
aj_nl_bc(1)=zero
fac=conductance_ma*prmag
!$omp parallel do default(shared)
Expand Down
6 changes: 3 additions & 3 deletions src/parallel_solver.f90
Original file line number Diff line number Diff line change
Expand Up @@ -17,10 +17,10 @@ module parallel_solvers

private

type, public :: type_tri_par
type, public :: type_tri_par
integer :: nRMin
integer :: nRMax
integer :: lMin
integer :: lMin
integer :: lMax
real(cp), allocatable :: low(:,:)
real(cp), allocatable :: diag(:,:)
Expand Down Expand Up @@ -578,7 +578,7 @@ subroutine solver_finish_3(this, x, lms_block, nlm_block, nRstart, nRstop, tag,
integer, intent(inout) :: array_req(:)
complex(cp), intent(inout) :: x(1:lm_max, nRstart-1:nRstop+1)
integer, intent(inout) :: req

!-- Local variables
integer :: lmb, lmu

Expand Down
10 changes: 5 additions & 5 deletions src/radial_data.f90
Original file line number Diff line number Diff line change
Expand Up @@ -6,16 +6,16 @@ module radial_data
use iso_fortran_env, only: output_unit
use parallel_mod, only: rank, n_procs, nR_per_rank, load, getBlocks
use logic, only: l_mag, lVerbose, l_finite_diff

implicit none

private

type(load), public, allocatable :: radial_balance(:)

integer, protected, public :: nRstart,nRstop,nRstartMag,nRstopMag
integer, protected, public :: n_r_cmb,n_r_icb

public :: initialize_radial_data, finalize_radial_data

contains
Expand All @@ -31,7 +31,7 @@ subroutine initialize_radial_data(n_r_max)
n_r_icb=n_r_max

allocate(radial_balance(0:n_procs-1))
call getBlocks(radial_balance, n_r_max, n_procs)
call getBlocks(radial_balance, n_r_max, n_procs)

nRstart = radial_balance(rank)%nStart
nRstop = radial_balance(rank)%nStop
Expand Down
Loading

0 comments on commit 84175ef

Please sign in to comment.