Merge branch 'master' into reconnection

This commit is contained in:
Grzegorz Kowal 2014-08-04 10:28:16 -03:00
commit 29743f732d
14 changed files with 123 additions and 124 deletions

View File

@ -401,8 +401,8 @@ module boundaries
use coordinates , only : ib, ie, ibl use coordinates , only : ib, ie, ibl
use coordinates , only : jb, je, jbl use coordinates , only : jb, je, jbl
use coordinates , only : kb, ke, kbl use coordinates , only : kb, ke, kbl
#ifdef MPI
use equations , only : nv use equations , only : nv
#ifdef MPI
use mpitools , only : nprocs, nproc, npmax use mpitools , only : nprocs, nproc, npmax
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
#endif /* MPI */ #endif /* MPI */
@ -1073,7 +1073,7 @@ module boundaries
! local variables ! local variables
! !
integer :: i, j, k, n integer :: i, j, k, n, m
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1114,6 +1114,11 @@ module boundaries
! !
if (.not. periodic(n)) then if (.not. periodic(n)) then
! calculate the edge direction (in 2D we don't have face neighbors, so we have
! to use edge neighbors)
!
m = 3 - n
! iterate over all corners ! iterate over all corners
! !
do j = 1, nsides do j = 1, nsides
@ -1121,8 +1126,8 @@ module boundaries
! if the face neighbor is not associated, apply specific boundaries ! if the face neighbor is not associated, apply specific boundaries
! !
if (.not. associated(pmeta%edges(i,j,n)%ptr)) & if (.not. associated(pmeta%edges(i,j,m)%ptr)) &
call block_boundary_specific(i, j, k, 3 - n & call block_boundary_specific(i, j, k, n &
, pmeta%data%q(1:nv,1:im,1:jm,1:km)) , pmeta%data%q(1:nv,1:im,1:jm,1:km))
end do ! i = 1, sides end do ! i = 1, sides
@ -1223,9 +1228,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -1773,9 +1776,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -2323,9 +2324,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -2900,9 +2899,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -3479,9 +3476,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -4058,9 +4053,7 @@ module boundaries
use coordinates , only : ie , je , ke use coordinates , only : ie , je , ke
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -4648,9 +4641,7 @@ module boundaries
use coordinates , only : im , jm , km use coordinates , only : im , jm , km
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -5109,9 +5100,7 @@ module boundaries
use coordinates , only : im , jm , km use coordinates , only : im , jm , km
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array
@ -5569,9 +5558,7 @@ module boundaries
use coordinates , only : im , jm , km use coordinates , only : im , jm , km
use coordinates , only : ibl, jbl, kbl use coordinates , only : ibl, jbl, kbl
use coordinates , only : ieu, jeu, keu use coordinates , only : ieu, jeu, keu
#ifdef MPI
use equations , only : nv use equations , only : nv
#endif /* MPI */
use mpitools , only : nproc, nprocs, npmax use mpitools , only : nproc, nprocs, npmax
#ifdef MPI #ifdef MPI
use mpitools , only : send_real_array, receive_real_array use mpitools , only : send_real_array, receive_real_array

View File

@ -153,8 +153,8 @@ module domains
! local variables ! local variables
! !
integer :: i, j, k, n, p, ic, jc, kc integer :: i, j, k, n, p, ic, jc, kc
real :: xl, xmn, xmx, yl, ymn, ymx, zl, zmn, zmx real(kind=8) :: xl, xmn, xmx, yl, ymn, ymx, zl, zmn, zmx
! local arrays ! local arrays
! !

View File

@ -85,7 +85,7 @@ program amun
integer, dimension(3) :: div = 1 integer, dimension(3) :: div = 1
logical, dimension(3) :: per = .true. logical, dimension(3) :: per = .true.
integer :: nmax = huge(1), ndat = 1 integer :: nmax = huge(1), ndat = 1
real :: tmax = 0.0d+00, trun = 9.999d+03, tsav = 3.0d+01 real(kind=8) :: tmax = 0.0d+00, trun = 9.999d+03, tsav = 3.0d+01
real(kind=8) :: dtnext = 0.0d+00 real(kind=8) :: dtnext = 0.0d+00
! flag to adjust time precisely to the snapshots ! flag to adjust time precisely to the snapshots
@ -118,7 +118,7 @@ program amun
integer :: nsteps = 1 integer :: nsteps = 1
character(len=80) :: fmt, tmp character(len=80) :: fmt, tmp
real :: tbeg, thrs real(kind=8) :: tbeg, thrs
real(kind=8) :: tm_curr, tm_exec, tm_conv real(kind=8) :: tm_curr, tm_exec, tm_conv
#ifdef INTEL #ifdef INTEL
@ -593,7 +593,7 @@ program amun
! calculate days, hours, seconds ! calculate days, hours, seconds
! !
ec = int(tm_curr * (tmax - time) / max(1.0e-8, time - tbeg), kind = 4) ec = int(tm_curr * (tmax - time) / max(1.0d-08, time - tbeg), kind = 4)
es = max(0, int(mod(ec, 60))) es = max(0, int(mod(ec, 60)))
em = int(mod(ec / 60, 60)) em = int(mod(ec / 60, 60))
eh = int(ec / 3600) eh = int(ec / 3600)

View File

@ -1144,8 +1144,8 @@ module equations
! local variables ! local variables
! !
integer :: i integer :: i
real :: ek, ei real(kind=8) :: ek, ei
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1209,8 +1209,8 @@ module equations
! local variables ! local variables
! !
integer :: i integer :: i
real :: ek, ei real(kind=8) :: ek, ei
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !

View File

@ -41,19 +41,19 @@ module evolution
! evolution parameters ! evolution parameters
! !
real , save :: cfl = 0.5d+00 real(kind=8), save :: cfl = 0.5d+00
! coefficient controlling the decay of scalar potential ѱ ! coefficient controlling the decay of scalar potential ѱ
! !
real , save :: alpha = 2.0d+00 real(kind=8), save :: alpha = 2.0d+00
real , save :: decay = 1.0d+00 real(kind=8), save :: decay = 1.0d+00
! time variables ! time variables
! !
integer, save :: step = 0 integer , save :: step = 0
real , save :: time = 0.0d+00 real(kind=8), save :: time = 0.0d+00
real , save :: dt = 1.0d+00 real(kind=8), save :: dt = 1.0d+00
real , save :: dtn = 1.0d+00 real(kind=8), save :: dtn = 1.0d+00
! by default everything is private ! by default everything is private
! !
@ -225,7 +225,7 @@ module evolution
! input variables ! input variables
! !
real, intent(in) :: dtnext real(kind=8), intent(in) :: dtnext
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -309,7 +309,7 @@ module evolution
! input variables ! input variables
! !
real, intent(in) :: dtnext real(kind=8), intent(in) :: dtnext
! local pointers ! local pointers
! !
@ -319,11 +319,11 @@ module evolution
! !
integer :: iret integer :: iret
integer(kind=4) :: lev integer(kind=4) :: lev
real :: cm, dx_min real(kind=8) :: cm, dx_min
! local parameters ! local parameters
! !
real, parameter :: eps = tiny(cmax) real(kind=8), parameter :: eps = tiny(cmax)
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -432,7 +432,7 @@ module evolution
! local arrays ! local arrays
! !
real, dimension(nv,im,jm,km) :: du real(kind=8), dimension(nv,im,jm,km) :: du
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -517,7 +517,7 @@ module evolution
! local arrays ! local arrays
! !
real, dimension(nv,im,jm,km) :: du real(kind=8), dimension(nv,im,jm,km) :: du
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -638,15 +638,15 @@ module evolution
! local pointers ! local pointers
! !
type(block_data), pointer :: pblock type(block_data), pointer :: pblock
! local vectors ! local vectors
! !
real, dimension(3) :: dx real(kind=8), dimension(3) :: dx
! local variables ! local variables
! !
integer :: n integer :: n
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !

View File

@ -10,25 +10,29 @@
# compiler and linker setup # compiler and linker setup
# #
ifeq ($(MPI),Y) ifeq ($(MPI),Y)
FC = mpif90 FC = mpif90
else else
FC = gfortran FC = gfortran
endif endif
LD = $(FC) LD = $(FC)
# preprocessor prefix (used by IBM Fortran, e.g.)
#
CPPPREFIX =
# compiler and linker flags # compiler and linker flags
# #
ifeq ($(DEBUG),Y) ifeq ($(DEBUG),Y)
FFLAGS = -g -O2 -DDEBUG FFLAGS = -g -O2 $(CPPPREFIX)-DDEBUG
else else
FFLAGS = -O2 FFLAGS = -O2
endif endif
LDFLAGS = $(FFLAGS) LDFLAGS = $(FFLAGS)
# libraries # libraries
# #
LIBS = LIBS =
#------------------------------------------------------------------------------- #-------------------------------------------------------------------------------
# #
@ -37,13 +41,11 @@ LDFLAGS += -static
endif endif
ifeq ($(SIGNALS),Y) ifeq ($(SIGNALS),Y)
FFLAGS += -DSIGNALS FFLAGS += $(CPPPREFIX)-DSIGNALS
endif endif
FFLAGS += -default-real-8 -default-double-8
ifeq ($(MPI),Y) ifeq ($(MPI),Y)
FFLAGS += -DMPI FFLAGS += $(CPPPREFIX)-DMPI
endif endif
ifeq ($(OUTPUT),HDF5) ifeq ($(OUTPUT),HDF5)

View File

@ -142,13 +142,18 @@ module integrals
! create a new integrals file ! create a new integrals file
! !
#ifdef GNU
open (newunit = funit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* GNU */
#ifdef INTEL #ifdef INTEL
open (newunit = funit, file = fname, form = 'formatted' & open (newunit = funit, file = fname, form = 'formatted' &
, status = 'replace', buffered = 'yes') , status = 'replace', buffered = 'yes')
#else /* INTEL */
open (newunit = funit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* INTEL */ #endif /* INTEL */
#ifdef IBM
open (unit = funit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* IBM */
! write the integral file header ! write the integral file header
! !
@ -163,13 +168,18 @@ module integrals
! create a new statistics file ! create a new statistics file
! !
#ifdef GNU
open (newunit = sunit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* GNU */
#ifdef INTEL #ifdef INTEL
open (newunit = sunit, file = fname, form = 'formatted' & open (newunit = sunit, file = fname, form = 'formatted' &
, status = 'replace', buffered = 'yes') , status = 'replace', buffered = 'yes')
#else /* INTEL */
open (newunit = sunit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* INTEL */ #endif /* INTEL */
#ifdef IBM
open (unit = sunit, file = fname, form = 'formatted' &
, status = 'replace')
#endif /* IBM */
! write the integral file header ! write the integral file header
! !

View File

@ -453,7 +453,7 @@ module interpolations
! selection weights ! selection weights
! !
real, parameter :: dp = 2.0d+00 / 3.0d+00, dm = 1.0d+00 / 3.0d+00 real(kind=8), parameter :: dp = 2.0d+00 / 3.0d+00, dm = 1.0d+00 / 3.0d+00
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1554,9 +1554,9 @@ module interpolations
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n integer , intent(in) :: n
real, dimension(n), intent(in) :: f real(kind=8), dimension(n), intent(in) :: f
real, dimension(n), intent(inout) :: fl, fr real(kind=8), dimension(n), intent(inout) :: fl, fr
! local variables ! local variables
! !

View File

@ -117,9 +117,9 @@ module io
integer(kind=4) , save :: irest = 1 integer(kind=4) , save :: irest = 1
integer(kind=4) , save :: isnap = 0 integer(kind=4) , save :: isnap = 0
integer(kind=4) , save :: ishift = 0 integer(kind=4) , save :: ishift = 0
real , save :: hrest = 6.0e+00 real(kind=8) , save :: hrest = 6.0e+00
real , save :: hsnap = 1.0e+00 real(kind=8) , save :: hsnap = 1.0e+00
real , save :: tsnap = 0.0e+00 real(kind=8) , save :: tsnap = 0.0e+00
! flags to determine the way of data writing ! flags to determine the way of data writing
! !
@ -374,9 +374,9 @@ module io
! input and output arguments ! input and output arguments
! !
real , intent(in) :: thrs real(kind=8), intent(in) :: thrs
integer, intent(in) :: nrun integer , intent(in) :: nrun
integer, intent(out) :: iret integer , intent(out) :: iret
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -475,7 +475,7 @@ module io
! !
!=============================================================================== !===============================================================================
! !
real function next_tout() real(kind=8) function next_tout()
! local variables are not implicit by default ! local variables are not implicit by default
! !

View File

@ -51,20 +51,20 @@ endif
# #
# compiler # compiler
# #
FFLAGS += -D${COMPILER} FFLAGS += ${CPPPREFIX}-D${COMPILER}
# number of dimensions # number of dimensions
# #
FFLAGS += -DNDIMS=${NDIMS} FFLAGS += ${CPPPREFIX}-DNDIMS=${NDIMS}
# output data format # output data format
# #
FFLAGS += -D${OUTPUT} FFLAGS += ${CPPPREFIX}-D${OUTPUT}
# compression # compression
# #
ifneq ($(COMPRESS),NONE) ifneq ($(COMPRESS),NONE)
FFLAGS += -DCOMPRESS -D${COMPRESS} FFLAGS += ${CPPPREFIX}-DCOMPRESS ${CPPPREFIX}-D${COMPRESS}
endif endif
#------------------------------------------------------------------------------- #-------------------------------------------------------------------------------

View File

@ -1055,10 +1055,10 @@ module mesh
! local variables ! local variables
! !
integer :: i, j, k, q, p integer :: i, j, k, q, p
integer :: il, iu, jl, ju, kl, ku integer :: il, iu, jl, ju, kl, ku
integer :: ic, jc, kc, ip, jp, kp integer :: ic, jc, kc, ip, jp, kp
real :: dul, dur, dux, duy, duz, du1, du2, du3, du4 real(kind=8) :: dul, dur, dux, duy, duz, du1, du2, du3, du4
! local pointers ! local pointers
! !
@ -1071,7 +1071,7 @@ module mesh
! local allocatable arrays ! local allocatable arrays
! !
real, dimension(:,:,:,:), allocatable :: u real(kind=8), dimension(:,:,:,:), allocatable :: u
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !

View File

@ -457,8 +457,8 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
real , intent(inout) :: rbuf real(kind=8), intent(inout) :: rbuf
integer, intent(inout) :: iret integer , intent(inout) :: iret
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -604,12 +604,12 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
real , intent(inout) :: rbuf real(kind=8), intent(inout) :: rbuf
integer, intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real :: tbuf real(kind=8) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -715,12 +715,12 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
real , intent(inout) :: rbuf real(kind=8), intent(inout) :: rbuf
integer, intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real :: tbuf real(kind=8) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -825,12 +825,12 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
real , intent(inout) :: rbuf real(kind=8), intent(inout) :: rbuf
integer, intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real :: tbuf real(kind=8) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -881,13 +881,13 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n integer , intent(in) :: n
real , dimension(n), intent(inout) :: rbuf real(kind=8), dimension(n), intent(inout) :: rbuf
integer , intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real(kind=8), dimension(n) :: tbuf real(kind=8), dimension(n) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -938,13 +938,13 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n integer , intent(in) :: n
real , dimension(n), intent(inout) :: rbuf real(kind=8), dimension(n), intent(inout) :: rbuf
integer , intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real(kind=8), dimension(n) :: tbuf real(kind=8), dimension(n) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1052,13 +1052,13 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n integer , intent(in) :: n
real , dimension(n), intent(inout) :: rbuf real(kind=8), dimension(n), intent(inout) :: rbuf
integer , intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !
real(kind=8), dimension(n) :: tbuf real(kind=8), dimension(n) :: tbuf
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1176,9 +1176,9 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n, dst, tag integer , intent(in) :: n, dst, tag
real , dimension(n), intent(in) :: rbuf real(kind=8), dimension(n), intent(in) :: rbuf
integer , intent(out) :: iret integer , intent(out) :: iret
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -1232,9 +1232,9 @@ module mpitools
! subroutine arguments ! subroutine arguments
! !
integer , intent(in) :: n, src, tag integer , intent(in) :: n, src, tag
real , dimension(n), intent(out) :: rbuf real(kind=8), dimension(n), intent(out) :: rbuf
integer , intent(out) :: iret integer , intent(out) :: iret
! local variables ! local variables
! !

View File

@ -550,7 +550,7 @@ module parameters
! subroutine arguments ! subroutine arguments
! !
character(len=*), intent(in) :: name character(len=*), intent(in) :: name
real , intent(inout) :: value real(kind=8) , intent(inout) :: value
! local parameter counter ! local parameter counter
! !

View File

@ -96,8 +96,8 @@ module random
! local variables ! local variables
! !
integer :: i integer :: i
real :: r real(kind=4) :: r
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -217,8 +217,8 @@ module random
! local variables ! local variables
! !
integer :: i, l integer :: i, l
real :: r real(kind=4) :: r
! !
!------------------------------------------------------------------------------- !-------------------------------------------------------------------------------
! !
@ -326,7 +326,7 @@ module random
! output variables ! output variables
! !
real :: val real(kind=8) :: val
! local variables ! local variables
! !
@ -349,7 +349,7 @@ module random
seeds(kp) = jsr seeds(kp) = jsr
val = 0.5 + 0.23283064365e-9 * (jz + jsr) val = 0.5d+00 + 0.23283064365d-09 * (jz + jsr)
#ifdef PROFILE #ifdef PROFILE
! stop accounting time for the random number generation ! stop accounting time for the random number generation
@ -380,7 +380,7 @@ module random
! output variables ! output variables
! !
real :: val real(kind=8) :: val
! local variables ! local variables
! !
@ -403,7 +403,7 @@ module random
seeds(kp) = jsr seeds(kp) = jsr
val = 0.23283064365e-9 * (jz + jsr) val = 0.23283064365d-09 * (jz + jsr)
#ifdef PROFILE #ifdef PROFILE
! stop accounting time for the random number generation ! stop accounting time for the random number generation
@ -434,7 +434,7 @@ module random
! output variables ! output variables
! !
real :: val real(kind=8) :: val
! local variables ! local variables
! !
@ -457,7 +457,7 @@ module random
seeds(kp) = jsr seeds(kp) = jsr
val = 0.46566128730e-9 * (jz + jsr) val = 0.46566128730d-09 * (jz + jsr)
#ifdef PROFILE #ifdef PROFILE
! stop accounting time for the random number generation ! stop accounting time for the random number generation