Skip to content

Commit 80c1e6f

Browse files
committed
Change "1.d0" to "1d0"
1 parent be2d78e commit 80c1e6f

File tree

131 files changed

+1007
-1007
lines changed

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

131 files changed

+1007
-1007
lines changed

amr/adaptive_loop.f90

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -205,7 +205,7 @@ subroutine adaptive_loop
205205
output_now=.true.
206206
if(myid==1) write(*,*) 'Dumping snapshot before walltime runs out'
207207
! Now set walltime to a negative number so we don't keep printing outputs
208-
walltime_hrs = -1.d0
208+
walltime_hrs = -1d0
209209
endif
210210
endif
211211
endif

amr/amr_parameters.f90

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -260,9 +260,9 @@ module amr_parameters
260260
real(dp),dimension(1:MAXREGION) ::x_center=0
261261
real(dp),dimension(1:MAXREGION) ::y_center=0
262262
real(dp),dimension(1:MAXREGION) ::z_center=0
263-
real(dp),dimension(1:MAXREGION) ::length_x=1.d10
264-
real(dp),dimension(1:MAXREGION) ::length_y=1.d10
265-
real(dp),dimension(1:MAXREGION) ::length_z=1.d10
263+
real(dp),dimension(1:MAXREGION) ::length_x=1d10
264+
real(dp),dimension(1:MAXREGION) ::length_y=1d10
265+
real(dp),dimension(1:MAXREGION) ::length_z=1d10
266266
real(dp),dimension(1:MAXREGION) ::exp_region=2
267267

268268
! Boundary conditions parameters

amr/constants.f90

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -3,7 +3,7 @@ module constants
33

44
! Numerical constants
55
real(dp),parameter ::twopi = 6.2831853d0
6-
real(dp),parameter ::pi = twopi/2.d0
6+
real(dp),parameter ::pi = twopi/2d0
77

88
real(dp),parameter ::mu_mol = 1.2195d0
99

amr/init_time.f90

Lines changed: 22 additions & 22 deletions
Original file line numberDiff line numberDiff line change
@@ -45,7 +45,7 @@ subroutine init_time
4545
! Compute Friedman model look up table
4646
if(myid==1)write(*,*)'Computing Friedman model'
4747
call friedman(dble(omega_m),dble(omega_l),dble(omega_k), &
48-
& 1.d-6,dble(aexp_ini), &
48+
& 1d-6,dble(aexp_ini), &
4949
& aexp_frw,hexp_frw,tau_frw,t_frw,n_frw)
5050

5151
! Compute initial conformal time
@@ -152,7 +152,7 @@ subroutine init_time
152152
if(cosmo) then
153153
my_grackle_units%comoving_coordinates = 1
154154
! Reonization redshift has to be later than starting redshift
155-
z_reion=min(1.d0/(1.1d0*aexp_ini)-1.d0,z_reion)
155+
z_reion=min(1d0/(1.1d0*aexp_ini)-1d0,z_reion)
156156
! Approximate initial temperature
157157
T2_start=1.356d-2/aexp_ini**2
158158
if(nrestart==0)then
@@ -232,7 +232,7 @@ subroutine init_time
232232
endif
233233
if(cosmo)then
234234
! Reonization redshift has to be later than starting redshift
235-
z_reion=min(1.d0/(1.1d0*aexp_ini)-1.d0,z_reion)
235+
z_reion=min(1d0/(1.1d0*aexp_ini)-1d0,z_reion)
236236
call set_model(Nmodel,dble(J21*1d-21),-1.0d0,dble(a_spec),-1.0d0,dble(z_reion), &
237237
& -1,2, &
238238
& dble(h0/100),dble(omega_b),dble(omega_m),dble(omega_l), &
@@ -244,7 +244,7 @@ subroutine init_time
244244
else
245245
call set_model(Nmodel,dble(J21*1d-21),-1.0d0,dble(a_spec),-1.0d0,dble(z_reion), &
246246
& -1,2, &
247-
& dble(70.d0/100.d0),0.04d0,0.3d0,0.7d0, &
247+
& dble(70d0/100d0),0.04d0,0.3d0,0.7d0, &
248248
& dble(aexp_ini),T2_sim)
249249
endif
250250
end if
@@ -258,7 +258,7 @@ subroutine init_time
258258
endif
259259
if(cosmo)then
260260
! Reonization redshift has to be later than starting redshift
261-
z_reion=min(1.d0/(1.1d0*aexp_ini)-1.d0,z_reion)
261+
z_reion=min(1d0/(1.1d0*aexp_ini)-1d0,z_reion)
262262
call set_model(Nmodel,dble(J21*1d-21),-1.0d0,dble(a_spec),-1.0d0,dble(z_reion), &
263263
& -1,2, &
264264
& dble(h0/100.),dble(omega_b),dble(omega_m),dble(omega_l), &
@@ -284,7 +284,7 @@ subroutine init_time
284284
endif
285285
if(cosmo)then
286286
! Reonization redshift has to be later than starting redshift
287-
z_reion=min(1.d0/(1.1d0*aexp_ini)-1.d0,z_reion)
287+
z_reion=min(1d0/(1.1d0*aexp_ini)-1d0,z_reion)
288288
call rt_set_model(dble(h0/100.),dble(omega_b),dble(omega_m),dble(omega_l), &
289289
& dble(aexp_ini),T2_sim)
290290
T2_start=T2_sim
@@ -553,7 +553,7 @@ subroutine init_cosmo
553553
endif
554554
omega_m = gadgetheader%omega0
555555
omega_l = gadgetheader%omegalambda
556-
h0 = gadgetheader%hubbleparam * 100.d0
556+
h0 = gadgetheader%hubbleparam * 100d0
557557
boxlen_ini = gadgetheader%boxsize
558558
aexp = gadgetheader%time
559559
aexp_ini = aexp
@@ -578,7 +578,7 @@ subroutine init_cosmo
578578
write(*,'(" omega_m=",F7.3," omega_l=",F7.3," omega_b=",F7.3)')omega_m,omega_l,omega_b
579579
write(*,'(" box size=",1pe10.3," h-1 Mpc")')boxlen_ini
580580
end if
581-
omega_k=1.d0-omega_l-omega_m
581+
omega_k=1d0-omega_l-omega_m
582582

583583
! Compute linear scaling factor between aexp and astart(ilevel)
584584
do ilevel=levelmin,nlevelmax_part
@@ -631,8 +631,8 @@ function fy(a)
631631
real(dp)::fy
632632
real(dp)::y,a
633633

634-
y=omega_m*(1.d0/a-1.d0) + omega_l*(a*a-1.d0) + 1.d0
635-
fy=1.d0/y**1.5d0
634+
y=omega_m*(1d0/a-1d0) + omega_l*(a*a-1d0) + 1d0
635+
fy=1d0/y**1.5d0
636636

637637
return
638638
end function fy
@@ -649,7 +649,7 @@ function d1a(a)
649649
write(*,*)'a=',a
650650
call clean_stop
651651
end if
652-
y=omega_m*(1.d0/a-1.d0) + omega_l*(a*a-1.d0) + 1.d0
652+
y=omega_m*(1d0/a-1d0) + omega_l*(a*a-1d0) + 1d0
653653
if(y .lt. 0.0D0)then
654654
write(*,*)'y=',y
655655
call clean_stop
@@ -672,7 +672,7 @@ end function d1a
672672
!!$ a=1.e-7
673673
!!$ niter=0
674674
!!$10 niter=niter+1
675-
!!$ da=(d1/d1a(a)-1.d0)/fpeebl(a)*a
675+
!!$ da=(d1/d1a(a)-1d0)/fpeebl(a)*a
676676
!!$ a=a+da
677677
!!$ if (abs(da).gt.1.0e-8.and.niter.lt.10) go to 10
678678
!!$ ad1=a
@@ -686,9 +686,9 @@ function fpeebl(a)
686686
real(dp) :: fact,y,eps
687687

688688
eps=1.0d-6
689-
y=omega_m*(1.d0/a-1.d0) + omega_l*(a*a-1.d0) + 1.d0
689+
y=omega_m*(1d0/a-1d0) + omega_l*(a*a-1d0) + 1d0
690690
fact=rombint(eps,a,eps)
691-
fpeebl=(omega_l*a*a-0.5d0*omega_m/a)/y - 1.d0 + a*fy(a)/fact
691+
fpeebl=(omega_l*a*a-0.5d0*omega_m/a)/y - 1d0 + a*fy(a)/fact
692692
return
693693
end function fpeebl
694694
!cccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
@@ -796,12 +796,12 @@ subroutine friedman(O_mat_0,O_vac_0,O_k_0,alpha,axp_min, &
796796

797797
nstep = nstep + 1
798798
dtau = alpha * axp_tau / dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)
799-
axp_tau_pre = axp_tau - dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)*dtau/2.d0
799+
axp_tau_pre = axp_tau - dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)*dtau/2d0
800800
axp_tau = axp_tau - dadtau(axp_tau_pre,O_mat_0,O_vac_0,O_k_0)*dtau
801801
tau = tau - dtau
802802

803803
dt = alpha * axp_t / dadt(axp_t,O_mat_0,O_vac_0,O_k_0)
804-
axp_t_pre = axp_t - dadt(axp_t,O_mat_0,O_vac_0,O_k_0)*dt/2.d0
804+
axp_t_pre = axp_t - dadt(axp_t,O_mat_0,O_vac_0,O_k_0)*dt/2d0
805805
axp_t = axp_t - dadt(axp_t_pre,O_mat_0,O_vac_0,O_k_0)*dt
806806
t = t - dt
807807

@@ -814,10 +814,10 @@ subroutine friedman(O_mat_0,O_vac_0,O_k_0,alpha,axp_min, &
814814

815815
nskip=nstep/ntable
816816

817-
axp_t = 1.d0
818-
t = 0.d0
819-
axp_tau = 1.d0
820-
tau = 0.d0
817+
axp_t = 1d0
818+
t = 0d0
819+
axp_tau = 1d0
820+
tau = 0d0
821821
nstep = 0
822822
nout=0
823823
t_out(nout)=t
@@ -829,12 +829,12 @@ subroutine friedman(O_mat_0,O_vac_0,O_k_0,alpha,axp_min, &
829829

830830
nstep = nstep + 1
831831
dtau = alpha * axp_tau / dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)
832-
axp_tau_pre = axp_tau - dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)*dtau/2.d0
832+
axp_tau_pre = axp_tau - dadtau(axp_tau,O_mat_0,O_vac_0,O_k_0)*dtau/2d0
833833
axp_tau = axp_tau - dadtau(axp_tau_pre,O_mat_0,O_vac_0,O_k_0)*dtau
834834
tau = tau - dtau
835835

836836
dt = alpha * axp_t / dadt(axp_t,O_mat_0,O_vac_0,O_k_0)
837-
axp_t_pre = axp_t - dadt(axp_t,O_mat_0,O_vac_0,O_k_0)*dt/2.d0
837+
axp_t_pre = axp_t - dadt(axp_t,O_mat_0,O_vac_0,O_k_0)*dt/2d0
838838
axp_t = axp_t - dadt(axp_t_pre,O_mat_0,O_vac_0,O_k_0)*dt
839839
t = t - dt
840840

amr/light_cone.f90

Lines changed: 7 additions & 7 deletions
Original file line numberDiff line numberDiff line change
@@ -38,8 +38,8 @@ subroutine output_cone()
3838

3939
if(nstep_coarse.lt.2)return
4040

41-
z2=1/aexp_old-1.d0
42-
z1=1/aexp-1.d0
41+
z2=1/aexp_old-1d0
42+
z1=1/aexp-1d0
4343

4444
if(z2.gt.zmax_cone)return
4545
if(abs(z2-z1)<1d-6)return
@@ -738,7 +738,7 @@ function coord_distance(zz,Omega0,OmegaL,OmegaR,coverH0)
738738
real(kind=8) :: z,res,coord_distance,zz
739739
real(kind=8) :: Omega0,OmegaL,OmegaR,coverH0
740740
z=abs(zz)
741-
call qromb(0.d0,z,res,omega0,omegaL,OmegaR)
741+
call qromb(0d0,z,res,omega0,omegaL,OmegaR)
742742
coord_distance=coverH0*res
743743
if (zz.lt.0) coord_distance=-coord_distance
744744
end function coord_distance
@@ -750,15 +750,15 @@ function funcE(z,Omega0,OmegaL,OmegaR)
750750
real(kind=8) :: funcE,z,HsurH0
751751
real(kind=8) :: omega0,omegaL,OmegaR
752752

753-
funcE=1.d0/HsurH0(z,Omega0,OmegaL,OmegaR)
753+
funcE=1d0/HsurH0(z,Omega0,OmegaL,OmegaR)
754754
end function funcE
755755

756756
!===========================================================================
757757
function HsurH0(z,omega0,omegaL,OmegaR)
758758
!===========================================================================
759759
implicit none
760760
real(kind=8) :: z,omega0,omegaL,OmegaR,HsurH0
761-
HsurH0=sqrt(Omega0*(1.d0+z)**3+OmegaR*(1.d0+z)**2+OmegaL)
761+
HsurH0=sqrt(Omega0*(1d0+z)**3+OmegaR*(1d0+z)**2+OmegaL)
762762
end function HsurH0
763763

764764

@@ -768,15 +768,15 @@ SUBROUTINE qromb(a,b,ss,omega0,omegaL,OmegaR)
768768
implicit none
769769
INTEGER :: JMAX,JMAXP,K,KM
770770
REAL(kind=8) :: a,b,ss,EPS,omega0,omegaL,OmegaR
771-
PARAMETER (EPS=1.d-6, JMAX=20, JMAXP=JMAX+1, K=5, KM=K-1)
771+
PARAMETER (EPS=1d-6, JMAX=20, JMAXP=JMAX+1, K=5, KM=K-1)
772772
! USES polint,trapzd
773773
INTEGER :: j
774774
REAL(kind=8) :: dss,h(JMAXP),s(JMAXP)
775775
h(1)=1.
776776
do j=1,JMAX
777777
call trapzd(a,b,s(j),j,omega0,omegaL,OmegaR)
778778
if (j.ge.K) then
779-
call polint(h(j-KM),s(j-KM),K,0.d0,ss,dss)
779+
call polint(h(j-KM),s(j-KM),K,0d0,ss,dss)
780780
if (abs(dss).le.EPS*abs(ss)) return
781781
endif
782782
s(j+1)=s(j)

amr/load_balance.f90

Lines changed: 15 additions & 15 deletions
Original file line numberDiff line numberDiff line change
@@ -742,18 +742,18 @@ subroutine cmp_ordering(x,order,nn)
742742
zc=boxlen/2
743743
#endif
744744
do i=1,nn
745-
xx=x(i,1)-xc+1.d-10
745+
xx=x(i,1)-xc+1d-10
746746
yy=x(i,2)-yc
747747
#if NDIM>2
748748
zz=x(i,3)
749749
#endif
750750
if(xx>0.)then
751-
order(i)=atan(yy/xx)+acos(-1.d0)/2.d0
751+
order(i)=atan(yy/xx)+acos(-1d0)/2d0
752752
else
753-
order(i)=atan(yy/xx)+acos(-1.d0)*3.d0/2.d0
753+
order(i)=atan(yy/xx)+acos(-1d0)*3d0/2d0
754754
endif
755755
#if NDIM>2
756-
if(zz.gt.zc)order(i)=order(i)+2.d0*acos(-1.d0)
756+
if(zz.gt.zc)order(i)=order(i)+2d0*acos(-1d0)
757757
#endif
758758
end do
759759
end if
@@ -861,53 +861,53 @@ subroutine cmp_minmaxorder(x,order_min,order_max,dx,nn)
861861
do i=1,nn
862862
if(dx==boxlen)then
863863
order_min(i)=0
864-
order_max(i)=4.d0*acos(-1.d0)
864+
order_max(i)=4d0*acos(-1d0)
865865
else
866866
! x- y-
867867
yy=x(i,2)-yc-dxx
868868
xx=x(i,1)-xc-dxx
869869
if(xx.ge.0.)then
870870
xx=xx+1d-10
871-
theta1=atan(yy/xx)+acos(-1.d0)/2
871+
theta1=atan(yy/xx)+acos(-1d0)/2
872872
else
873873
xx=xx-1d-10
874-
theta1=atan(yy/xx)+acos(-1.d0)*3.d0/2.d0
874+
theta1=atan(yy/xx)+acos(-1d0)*3d0/2d0
875875
endif
876876
! x+ y-
877877
xx=x(i,1)-xc+dxx
878878
if(xx.gt.0.)then
879879
xx=xx+1d-10
880-
theta2=atan(yy/xx)+acos(-1.d0)/2
880+
theta2=atan(yy/xx)+acos(-1d0)/2
881881
else
882882
xx=xx-1d-10
883-
theta2=atan(yy/xx)+acos(-1.d0)*3.d0/2.d0
883+
theta2=atan(yy/xx)+acos(-1d0)*3d0/2d0
884884
endif
885885

886886
! x+ y+
887887
yy=x(i,2)-yc+dxx
888888
if(xx.gt.0.)then
889889
xx=xx+1d-10
890-
theta3=atan(yy/xx)+acos(-1.d0)/2.d0
890+
theta3=atan(yy/xx)+acos(-1d0)/2d0
891891
else
892892
xx=xx-1d-10
893-
theta3=atan(yy/xx)+acos(-1.d0)*3.d0/2.d0
893+
theta3=atan(yy/xx)+acos(-1d0)*3d0/2d0
894894
endif
895895
! x- y+
896896
xx=x(i,1)-xc-dxx
897897
if(xx.ge.0.)then
898898
xx=xx+1d-10
899-
theta4=atan(yy/xx)+acos(-1.d0)/2.d0
899+
theta4=atan(yy/xx)+acos(-1d0)/2d0
900900
else
901901
xx=xx-1d-10
902-
theta4=atan(yy/xx)+acos(-1.d0)*3.d0/2.d0
902+
theta4=atan(yy/xx)+acos(-1d0)*3d0/2d0
903903
endif
904904
order_min(i)=min(theta1,theta2,theta3,theta4)
905905
order_max(i)=max(theta1,theta2,theta3,theta4)
906906
#if NDIM>2
907907
zz=x(i,3)
908908
if(zz.gt.zc)then
909-
order_min(i)=order_min(i)+2.d0*acos(-1.d0)
910-
order_max(i)=order_max(i)+2.d0*acos(-1.d0)
909+
order_min(i)=order_min(i)+2d0*acos(-1d0)
910+
order_max(i)=order_max(i)+2d0*acos(-1d0)
911911
endif
912912
#endif
913913
endif

amr/movie.f90

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -281,9 +281,9 @@ subroutine output_frame()
281281
if(cosmo) then
282282
if(tend_theta_camera(proj_ind).le.0d0) tend_theta_camera(proj_ind) = aendmov
283283
if(tend_phi_camera(proj_ind).le.0d0) tend_phi_camera(proj_ind) = aendmov
284-
theta_cam = theta_camera(proj_ind)*pi/180.d0 &
284+
theta_cam = theta_camera(proj_ind)*pi/180d0 &
285285
+min(max(aexp-tstart_theta_camera(proj_ind),0d0),tend_theta_camera(proj_ind))*dtheta_camera(proj_ind)*pi/180./(aendmov-astartmov)
286-
phi_cam = phi_camera(proj_ind)*pi/180.d0 &
286+
phi_cam = phi_camera(proj_ind)*pi/180d0 &
287287
+min(max(aexp-tstart_theta_camera(proj_ind),0d0),tend_phi_camera(proj_ind))*dphi_camera(proj_ind)*pi/180./(aendmov-astartmov)
288288
dist_cam = dist_camera(proj_ind)+min(max(aexp-tstart_theta_camera(proj_ind),0d0),tend_theta_camera(proj_ind))*ddist_camera(proj_ind)/(aendmov-astartmov)
289289
else

amr/output_amr.f90

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -595,9 +595,9 @@ subroutine savegadget(filename)
595595
header%npart = 0
596596
header%npart(2) = npart
597597
header%mass = 0
598-
header%mass(2) = omega_m*RHOcrit*(boxlen_ini)**3/npart_tot/1.d10
598+
header%mass(2) = omega_m*RHOcrit*(boxlen_ini)**3/npart_tot/1d10
599599
header%time = aexp
600-
header%redshift = 1.d0/aexp-1.d0
600+
header%redshift = 1d0/aexp-1d0
601601
header%flag_sfr = 0
602602
header%nparttotal = 0
603603
#ifndef LONGINT

amr/update_time.f90

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -560,7 +560,7 @@ SUBROUTINE getProperTime(tau,tproper)
560560
implicit none
561561
real(dp)::tau, tproper
562562
integer::i
563-
if(.not. cosmo .or. tau .eq. 0.d0) then ! this might happen quite often
563+
if(.not. cosmo .or. tau .eq. 0d0) then ! this might happen quite often
564564
tproper = tau
565565
return
566566
endif

0 commit comments

Comments
 (0)