Skip to content

Commit

Permalink
adding missing d0s
Browse files Browse the repository at this point in the history
  • Loading branch information
pmocz committed Feb 13, 2025
1 parent 2895820 commit 00beab8
Show file tree
Hide file tree
Showing 23 changed files with 176 additions and 176 deletions.
4 changes: 2 additions & 2 deletions astero/private/adipls_support.f90
Original file line number Diff line number Diff line change
Expand Up @@ -788,10 +788,10 @@ subroutine store_amdl(nn_in, iriche, iturpr, data, aa, x, nn, ierr)

if (iturpr == 1) then
do n=1,nn
if (x(n) < 0.999) then
if (x(n) < 0.999d0) then
ggt=1
else
ggt=1./(x(n)*x(n)*x(n)*aa(1,n))
ggt=1.0d0/(x(n)*x(n)*x(n)*aa(1,n))
end if
aa(10,n)=ggt
end do
Expand Down
14 changes: 7 additions & 7 deletions astero/private/astero_support.f90
Original file line number Diff line number Diff line change
Expand Up @@ -444,7 +444,7 @@ subroutine get_r02_frequency_ratios(init, nl0, l0, nl1, l1, nl2, l2, r02)
i0 = i + ratios_l0_first
i1 = i + ratios_l1_first
dnu = l1(i1) - l1(i1-1)
df = 0.25*dnu
df = 0.25d0*dnu
f0 = l0(i0)
fmin = f0 - df
fmax = f0 + df
Expand Down Expand Up @@ -573,7 +573,7 @@ subroutine get_max_sequence(nl, l_obs, max_seq_i, max_seq_n)
seq_i = i
seq_n = 1
do j = seq_i, nl-1 ! j is in series; try to add j+1
if (l_obs(j+1) - l_obs(j) > 1.5*delta_nu) then ! end of series
if (l_obs(j+1) - l_obs(j) > 1.5d0*delta_nu) then ! end of series
if (seq_n > max_seq_n) then
max_seq_i = seq_i
max_seq_n = seq_n
Expand Down Expand Up @@ -659,12 +659,12 @@ subroutine init_obs_data(ierr)
! set l0_n_obs(i) to order of freq_target(0,i)
range = freq_target(0,nl(0)) - freq_target(0,1)
norders = int(range/delta_nu + 0.5d0) + 1
nmax = (nu_max/delta_nu)*(delta_nu_sun/nu_max_sun)*22.6 - 1.6
nmax = (nu_max/delta_nu)*(delta_nu_sun/nu_max_sun)*22.6d0 - 1.6d0
l0_n_obs(1) = int(nmax - (norders-1)/2)
if (dbg) write(*,3) 'l0_n_obs(i)', 1, l0_n_obs(1), freq_target(0,1)
do i=2,norders
l0_n_obs(i) = l0_n_obs(1) + &
int((freq_target(0,i) - freq_target(0,1))/delta_nu + 0.5)
int((freq_target(0,i) - freq_target(0,1))/delta_nu + 0.5d0)
if (dbg) write(*,3) 'l0_n_obs(i)', i, l0_n_obs(i), freq_target(0,i)
end do
if (dbg) then
Expand Down Expand Up @@ -1294,7 +1294,7 @@ subroutine get_freq_corr(s, radial_only, ierr)
call get_kjeldsen_freq_corr
else if (correction_scheme == 'cubic') then
call get_cubic_freq_corr(radial_only)
surf_coef1 = a3*pow3(5000.*s%nu_max/s% nu_max_sun)
surf_coef1 = a3*pow3(5000.0d0*s%nu_max/s% nu_max_sun)
surf_coef2 = 0

if (save_next_best_at_higher_frequency) &
Expand All @@ -1304,8 +1304,8 @@ subroutine get_freq_corr(s, radial_only, ierr)
call get_cubic_freq_corr(radial_only)
else if (correction_scheme == 'combined') then
call get_combined_freq_corr(radial_only)
surf_coef1 = a3*pow3(5000.*s%nu_max/s% nu_max_sun)
surf_coef2 = a1/(5000.*s%nu_max/s% nu_max_sun)
surf_coef1 = a3*pow3(5000.0d0*s%nu_max/s% nu_max_sun)
surf_coef2 = a1/(5000.0d0*s%nu_max/s% nu_max_sun)

if (save_next_best_at_higher_frequency) &
call get_combined_freq_corr_alt_up(radial_only)
Expand Down
2 changes: 1 addition & 1 deletion astero/test_suite/example_astero/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -100,7 +100,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion astero/test_suite/fast_from_file/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -107,7 +107,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion astero/test_suite/fast_newuoa/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -100,7 +100,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion astero/test_suite/fast_scan_grid/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -107,7 +107,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion astero/test_suite/fast_simplex/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -107,7 +107,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion astero/work/src/run_star_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -102,7 +102,7 @@ subroutine set_constraint_value(id, name, val, ierr) ! called from star_astero
do i = 1, s% nz-1 ! locate bottom of solar convective zone
if (s% mixing_type(i+1) /= convective_mixing &
.and. s% mixing_type(i) == convective_mixing) then
if (s% r(i+1) > 0.25*Rsun .and. s% r(i) < 0.9*Rsun) then
if (s% r(i+1) > 0.25d0*Rsun .and. s% r(i) < 0.9d0*Rsun) then
val = s% r(i)/Rsun
exit
end if
Expand Down
2 changes: 1 addition & 1 deletion binary/private/pgbinary_support.f90
Original file line number Diff line number Diff line change
Expand Up @@ -619,7 +619,7 @@ subroutine show_age_pgbinary(b)
!age = age
units_str = 'yrs'
end if
if (abs(age) > 1e-3 .and. abs(age) < 1e3) then
if (abs(age) > 1d-3 .and. abs(age) < 1d3) then
write(age_str, '(f14.6)') age
else
write(age_str, '(1pe14.6)') age
Expand Down
10 changes: 5 additions & 5 deletions binary/test_suite/double_bh/src/run_binary_extras.f90
Original file line number Diff line number Diff line change
Expand Up @@ -171,12 +171,12 @@ integer function extras_binary_finish_step(binary_id)
end if

if (b% ignore_rlof_flag .and. &
abs(log10(abs(b% s1% L_nuc_burn_total * Lsun / b% s1% L(1)))) < 0.005 .and. &
abs(log10(abs(b% s1% L_nuc_burn_total * Lsun / b% s1% L(1)))) < 0.005d0 .and. &
b% s1% star_age > 1d2) then
! if here, primary reached thermal equilibrium (reached ZAMS), so activate RLOF
! this is the amount of overflow of a q=1 system at L2, anything more than this
! is too much
if (b% rl_relative_gap(1) > 0.320819224) then
if (b% rl_relative_gap(1) > 0.320819224d0) then
extras_binary_finish_step = terminate
write(*,*) "Terminate due to overflow of L2 at ZAMS"
return
Expand All @@ -197,7 +197,7 @@ integer function extras_binary_finish_step(binary_id)
b% terminate_if_L2_overflow = .true.
write(*,*) "Engage RLOF!"
else if (b% ignore_rlof_flag .and. &
(abs(log10(abs(b% s1% L_nuc_burn_total * Lsun / b% s1% L(1)))) > 0.005 .or. &
(abs(log10(abs(b% s1% L_nuc_burn_total * Lsun / b% s1% L(1)))) > 0.005d0 .or. &
b% s1% star_age < 1d2)) then
! if here, still not in ZAMS, keep period fixed
call binary_set_period_eccentricity(b% binary_id, &
Expand All @@ -209,14 +209,14 @@ integer function extras_binary_finish_step(binary_id)

! check if stars are evolving homogeneously
if (b% s1% center_h1 > 1d-3) then
if (b% s1% center_he4 - b% s1% surface_he4 > 0.2) then
if (b% s1% center_he4 - b% s1% surface_he4 > 0.2d0) then
extras_binary_finish_step = terminate
write(*,*) "Terminate due to primary not evolving homogeneously"
return
end if
end if
if (b% s2% center_h1 > 1d-3) then
if (b% s2% center_he4 - b% s2% surface_he4 > 0.2) then
if (b% s2% center_he4 - b% s2% surface_he4 > 0.2d0) then
extras_binary_finish_step = terminate
write(*,*) "Terminate due to secondary not evolving homogeneously"
return
Expand Down
Loading

0 comments on commit 00beab8

Please sign in to comment.