Skip to content

Commit a27f4cf

Browse files
committed
cleanup
1 parent 23822da commit a27f4cf

File tree

7 files changed

+38
-38
lines changed

7 files changed

+38
-38
lines changed

src/common/m_derived_types.fpp

Lines changed: 4 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -167,10 +167,10 @@ module m_derived_types
167167
!! Vector indicating the various radii for the elliptical and ellipsoidal
168168
!! patch geometries. It is specified through its x-, y-, and z-components
169169
!! respectively.
170-
170+
171171
real(wp) :: epsilon, beta !<
172-
!! The isentropic vortex parameters administrating, respectively, both
173-
!! the amplitude of the disturbance as well as its domain of influence.
172+
!! The isentropic vortex parameters for the amplitude of the disturbance and
173+
!! domain of influence.
174174

175175
real(wp), dimension(2:9) :: a !<
176176
!! The parameters needed for the spherical harmonic patch
@@ -180,7 +180,7 @@ module m_derived_types
180180
real(wp), dimension(3) :: normal !<
181181
!! Normal vector indicating the orientation of the patch. It is specified
182182
!! through its x-, y- and z-components, respectively.
183-
183+
184184
logical, dimension(0:num_patches_max - 1) :: alter_patch !<
185185

186186
!! List of permissions that indicate to the current patch which preceding

src/post_process/m_data_output.fpp

Lines changed: 8 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -537,7 +537,7 @@ contains
537537
! END: Binary Database Format ======================================
538538
539539
end subroutine s_open_formatted_database_file ! ------------------------
540-
540+
541541
subroutine s_open_intf_data_file() ! ------------------------
542542
543543
character(LEN=path_len + 3*name_len) :: file_path !<
@@ -1030,10 +1030,10 @@ contains
10301030
type(scalar_field), dimension(sys_size), intent(IN) :: q_prim_vf
10311031
integer :: i, j, k, l, w, cent !< Generic loop iterators
10321032
integer :: ierr, counter, root !< number of data points extracted to fit shape to SH perturbations
1033-
real(kind(0d0)), dimension(num_fluids) :: alpha, vol_fluid, xcom, ycom, zcom
1034-
real(kind=8), parameter :: pi = 4.d0*datan(1.d0)
1035-
real(kind(0d0)), allocatable :: x_td(:), y_td(:), x_d1(:), y_d1(:), y_d(:), x_d(:)
1036-
real(kind(0d0)) :: axp, axm, ayp, aym, azm, azp, tgp, euc_d, thres, maxalph_loc, maxalph_glb
1033+
real(wp), dimension(num_fluids) :: alpha, vol_fluid, xcom, ycom, zcom
1034+
real(wp), parameter :: pi = 4._wp*tan(1._wp)
1035+
real(wp), allocatable :: x_td(:), y_td(:), x_d1(:), y_d1(:), y_d(:), x_d(:)
1036+
real(wp) :: axp, axm, ayp, aym, azm, azp, tgp, euc_d, thres, maxalph_loc, maxalph_glb
10371037
10381038
allocate (x_d1(m*n))
10391039
allocate (y_d1(m*n))
@@ -1123,7 +1123,7 @@ contains
11231123
real(kind(0d0)) :: rho, pres, dV, tmp, gamma, pi_inf, MaxMa, MaxMa_glb, maxvel, c, Ma, H
11241124
real(kind(0d0)), dimension(num_dims) :: vel
11251125
real(kind(0d0)), dimension(num_fluids) :: gammas, pi_infs, adv
1126-
integer :: i, j, k, l, s !looping indicies
1126+
integer :: i, j, k, l, s !looping indices
11271127
integer :: ierr, counter, root !< number of data points extracted to fit shape to SH perturbations
11281128
11291129
Egk = 0d0
@@ -1153,8 +1153,8 @@ contains
11531153
vel(s) = q_prim_vf(num_fluids + s)%sf(i, j, k)
11541154
Egk = Egk + 0.5d0*q_prim_vf(E_idx + 2)%sf(i, j, k)*q_prim_vf(2)%sf(i, j, k)*vel(s)*vel(s)*dV
11551155
Elk = Elk + 0.5d0*q_prim_vf(E_idx + 1)%sf(i, j, k)*q_prim_vf(1)%sf(i, j, k)*vel(s)*vel(s)*dV
1156-
if (dabs(vel(s)) > maxvel) then
1157-
maxvel = dabs(vel(s))
1156+
if (abs(vel(s)) > maxvel) then
1157+
maxvel = abs(vel(s))
11581158
end if
11591159
end do
11601160
do l = 1, adv_idx%end - E_idx

src/pre_process/include/2dHardcodedIC.fpp

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -2,7 +2,7 @@
22

33
real(wp) :: eps
44
real(wp) :: r, rmax, gam, umax, p0
5-
real(wp) :: rhoH, rhoL, pRef, pInt, h, lam, wl, amp, intH, alph
5+
real(wp) :: rhoH, rhoL, pRef, pInt, h, lam, wl, amp, intH, intL, alph
66

77
eps = 1e-9_wp
88

src/pre_process/m_global_parameters.fpp

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -393,7 +393,7 @@ contains
393393
patch_icpp(i)%a(8) = dflt_real
394394
patch_icpp(i)%a(9) = dflt_real
395395
patch_icpp(i)%non_axis_sym = .false.
396-
396+
397397
!should get all of r0's and v0's
398398
patch_icpp(i)%r0 = dflt_real
399399
patch_icpp(i)%v0 = dflt_real

src/pre_process/m_patches.fpp

Lines changed: 5 additions & 5 deletions
Original file line numberDiff line numberDiff line change
@@ -1418,8 +1418,8 @@ contains
14181418
logical :: non_axis_sym
14191419
14201420
integer :: i, j, k !< generic loop iterators
1421-
1422-
real(wp) :: radius, epsilon, beta
1421+
1422+
real(wp) :: epsilon, beta
14231423
complex(wp) :: cmplx_i = (0._wp, 1._wp)
14241424
complex(wp) :: H
14251425
@@ -1464,9 +1464,9 @@ contains
14641464

14651465
r = dsqrt((x_cc(i) - x_centroid)**2 + (cart_y - y_centroid)**2 + (cart_z - z_centroid)**2) + eps
14661466
if (x_cc(i) - x_centroid <= 0) then
1467-
x_p = -dabs(x_cc(i) - x_centroid + eps)/r
1467+
x_p = -1._wp*abs(x_cc(i) - x_centroid + eps)/r
14681468
else
1469-
x_p = dabs(x_cc(i) - x_centroid + eps)/r
1469+
x_p = abs(x_cc(i) - x_centroid + eps)/r
14701470
end if
14711471

14721472
Ps(2) = unassociated_legendre(x_p, 2)
@@ -1514,7 +1514,7 @@ contains
15141514
Ps(9) = spherical_harmonic_func(x_p, phi, 9, 9)
15151515
else
15161516
r = dsqrt((x_cc(i) - x_centroid)**2d0 + (y_cc(j) - y_centroid)**2d0) + eps
1517-
x_p = dabs(x_cc(i) - x_centroid + eps)/r
1517+
x_p = abs(x_cc(i) - x_centroid + eps)/r
15181518
Ps(2) = unassociated_legendre(x_p, 2)
15191519
Ps(3) = unassociated_legendre(x_p, 3)
15201520
Ps(4) = unassociated_legendre(x_p, 4)

src/simulation/m_hyperelastic.fpp

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -179,7 +179,7 @@ contains
179179
! STEP 2d: computing the J = det(F) = 1/det(\grad{\xi})
180180
tensorb(tensor_size) = 1d0/tensorb(tensor_size)
181181

182-
! STEP 3: computing F tranpose F
182+
! STEP 3: computing F transpose F
183183
tensorb(1) = tensora(1)**2 + tensora(2)**2 + tensora(3)**2
184184
tensorb(5) = tensora(4)**2 + tensora(5)**2 + tensora(6)**2
185185
tensorb(9) = tensora(7)**2 + tensora(8)**2 + tensora(9)**2

src/simulation/m_riemann_solvers.fpp

Lines changed: 18 additions & 18 deletions
Original file line numberDiff line numberDiff line change
@@ -537,13 +537,13 @@ contains
537537
! elastic energy update
538538
if (hypoelasticity) then
539539
G_L = 0._wp; G_R = 0._wp
540-
540+
541541
!$acc loop seq
542542
do i = 1, num_fluids
543543
G_L = G_L + alpha_L(i)*Gs(i)
544544
G_R = G_R + alpha_R(i)*Gs(i)
545545
end do
546-
546+
547547
do i = 1, strxe - strxb + 1
548548
tau_e_L(i) = qL_prim_rs${XYZ}$_vf(j, k, l, strxb - 1 + i)
549549
tau_e_R(i) = qR_prim_rs${XYZ}$_vf(j + 1, k, l, strxb - 1 + i)
@@ -959,7 +959,7 @@ contains
959959
960960
integer, intent(in) :: norm_dir
961961
type(int_bounds_info), intent(in) :: ix, iy, iz
962-
962+
963963
real(wp), dimension(num_fluids) :: alpha_rho_L, alpha_rho_R
964964
real(wp) :: rho_L, rho_R
965965
real(wp), dimension(num_dims) :: vel_L, vel_R
@@ -1009,7 +1009,7 @@ contains
10091009
real(wp), dimension(6) :: tau_e_L, tau_e_R
10101010
real(wp), dimension(num_dims) :: xi_field_L, xi_field_R
10111011
real(wp) :: G_L, G_R
1012-
1012+
10131013
real(wp) :: vel_L_rms, vel_R_rms, vel_avg_rms
10141014
real(wp) :: vel_L_tmp, vel_R_tmp
10151015
real(wp) :: rho_Star, E_Star, p_Star, p_K_Star
@@ -1279,7 +1279,7 @@ contains
12791279
Ms_R = max(1._wp, sqrt(1._wp + ((5e-1_wp + gamma_R)/(1._wp + gamma_R))* &
12801280
(pres_SR/pres_R - 1._wp)*pres_R/ &
12811281
((pres_R + pi_inf_R/(1._wp + gamma_R)))))
1282-
1282+
12831283
s_L = vel_L(dir_idx(1)) - c_L*Ms_L
12841284
s_R = vel_R(dir_idx(1)) + c_R*Ms_R
12851285
@@ -1307,15 +1307,15 @@ contains
13071307
xi_MP = -min(0d0, sign(1d0, s_L))
13081308
xi_PP = max(0d0, sign(1d0, s_R))
13091309
1310-
E_star = xi_M * (E_L + xi_MP * (xi_L*(E_L + (s_S - vel_L(dir_idx(1)))* &
1311-
(rho_L*s_S + pres_L/(s_L - vel_L(dir_idx(1))))) - E_L)) + &
1312-
xi_P * (E_R + xi_PP * (xi_R*(E_R + (s_S - vel_R(dir_idx(1)))* &
1313-
(rho_R*s_S + pres_R/(s_R - vel_R(dir_idx(1))))) - E_R))
1314-
p_Star = xi_M * (pres_L + xi_MP * (rho_L*(s_L - vel_L(dir_idx(1)))*(s_S - vel_L(dir_idx(1))))) + &
1315-
xi_P * (pres_R + xi_PP * (rho_R*(s_R - vel_R(dir_idx(1)))*(s_S - vel_R(dir_idx(1)))))
1310+
E_star = xi_M*(E_L + xi_MP*(xi_L*(E_L + (s_S - vel_L(dir_idx(1)))* &
1311+
(rho_L*s_S + pres_L/(s_L - vel_L(dir_idx(1))))) - E_L)) + &
1312+
xi_P*(E_R + xi_PP*(xi_R*(E_R + (s_S - vel_R(dir_idx(1)))* &
1313+
(rho_R*s_S + pres_R/(s_R - vel_R(dir_idx(1))))) - E_R))
1314+
p_Star = xi_M*(pres_L + xi_MP*(rho_L*(s_L - vel_L(dir_idx(1)))*(s_S - vel_L(dir_idx(1))))) + &
1315+
xi_P*(pres_R + xi_PP*(rho_R*(s_R - vel_R(dir_idx(1)))*(s_S - vel_R(dir_idx(1)))))
13161316
1317-
rho_Star = xi_M * (rho_L * (xi_MP * xi_L + 1._wp - xi_MP)) + &
1318-
xi_P * (rho_R * (xi_PP * xi_R + 1._wp - xi_PP))
1317+
rho_Star = xi_M*(rho_L*(xi_MP*xi_L + 1._wp - xi_MP)) + &
1318+
xi_P*(rho_R*(xi_PP*xi_R + 1._wp - xi_PP))
13191319
13201320
vel_K_Star = vel_L(idx1)*(1d0 - xi_MP) + xi_MP*vel_R(idx1) + &
13211321
xi_MP*xi_PP*(s_S - vel_R(idx1))
@@ -1334,13 +1334,13 @@ contains
13341334
!$acc loop seq
13351335
do i = 1, num_dims
13361336
idxi = dir_idx(i)
1337-
flux_rs${XYZ}$_vf(j, k, l, contxe + idxi) = rho_Star * vel_K_Star * &
1338-
(dir_flg(idxi) * vel_K_Star + (1d0 - dir_flg(idxi)) * (xi_M*vel_L(idxi) + xi_P * vel_R(idxi)) ) + dir_flg(idxi)*p_Star
1337+
flux_rs${XYZ}$_vf(j, k, l, contxe + idxi) = rho_Star*vel_K_Star* &
1338+
(dir_flg(idxi)*vel_K_Star + (1d0 - dir_flg(idxi))*(xi_M*vel_L(idxi) + xi_P*vel_R(idxi))) + dir_flg(idxi)*p_Star
13391339
end do
13401340
13411341
! ENERGY FLUX.
13421342
! f = u*(E-\sigma), q = E, q_star = \xi*E+(s-u)(\rho s_star - \sigma/(s-u))
1343-
flux_rs${XYZ}$_vf(j, k, l, E_idx) = (E_star + p_Star) * vel_K_Star
1343+
flux_rs${XYZ}$_vf(j, k, l, E_idx) = (E_star + p_Star)*vel_K_Star
13441344
13451345
! ELASTICITY. Elastic shear stress additions for the momentum and energy flux
13461346
if (elasticity) then
@@ -1389,9 +1389,9 @@ contains
13891389
xi_R**(1d0/gammas(i) + 1d0) - pi_infs(i)/(1d0 + gammas(i)) - pres_R) + pres_R)
13901390
13911391
flux_rs${XYZ}$_vf(j, k, l, i + intxb - 1) = &
1392-
((xi_M * qL_prim_rs${XYZ}$_vf(j, k, l, i + advxb - 1) + xi_P * qR_prim_rs${XYZ}$_vf(j + 1, k, l, i + advxb - 1)) * &
1392+
((xi_M*qL_prim_rs${XYZ}$_vf(j, k, l, i + advxb - 1) + xi_P*qR_prim_rs${XYZ}$_vf(j + 1, k, l, i + advxb - 1))* &
13931393
(gammas(i)*p_K_Star + pi_infs(i)) + &
1394-
(xi_M * qL_prim_rs${XYZ}$_vf(j, k, l, i + contxb - 1) + xi_P * qR_prim_rs${XYZ}$_vf(j + 1, k, l, i + contxb - 1)) * &
1394+
(xi_M*qL_prim_rs${XYZ}$_vf(j, k, l, i + contxb - 1) + xi_P*qR_prim_rs${XYZ}$_vf(j + 1, k, l, i + contxb - 1))* &
13951395
qvs(i))*vel_K_Star
13961396
end do
13971397

0 commit comments

Comments
 (0)