diff --git a/src/common/m_phase_change.fpp b/src/common/m_phase_change.fpp index 9ae303ff3f..cac791f70e 100644 --- a/src/common/m_phase_change.fpp +++ b/src/common/m_phase_change.fpp @@ -313,8 +313,6 @@ contains real(kind(0.0d0)), intent(in) :: rhoe real(kind(0.0d0)), intent(out) :: TS - integer, dimension(num_fluids) :: ig !< flags to toggle the inclusion of fluids for the pT-equilibrium - real(kind(0.0d0)), dimension(num_fluids) :: pk !< individual initial pressures real(kind(0.0d0)) :: gp, gpp, hp, pO, mCP, mQ !< variables for the Newton Solver integer :: i, ns !< generic loop iterators diff --git a/src/simulation/m_bubbles.fpp b/src/simulation/m_bubbles.fpp index 804b473b8f..82ec9e4e45 100644 --- a/src/simulation/m_bubbles.fpp +++ b/src/simulation/m_bubbles.fpp @@ -57,7 +57,7 @@ contains subroutine s_initialize_bubbles_module - integer :: i, j, k, l, q + integer :: l @:ALLOCATE_GLOBAL(rs(1:nb)) @:ALLOCATE_GLOBAL(vs(1:nb)) @@ -119,7 +119,7 @@ contains integer, intent(in) :: idir type(scalar_field), dimension(sys_size), intent(in) :: q_prim_vf - integer :: i, j, k, l, q + integer :: j, k, l if (idir == 1) then @@ -183,18 +183,11 @@ contains real(kind(0d0)) :: rddot real(kind(0d0)) :: pb, mv, vflux, pbdot real(kind(0d0)) :: n_tait, B_tait - real(kind(0d0)), dimension(nb) :: Rtmp, Vtmp real(kind(0d0)) :: myR, myV, alf, myP, myRho, R2Vav, R3 real(kind(0d0)), dimension(num_fluids) :: myalpha, myalpha_rho - real(kind(0d0)) :: start, finish - real(kind(0d0)) :: nbub !< Bubble number density - - real(kind(0d0)), dimension(2) :: Re !< Reynolds number - integer :: i, j, k, l, q, ii !< Loop variables - integer :: ndirs !< Number of coordinate directions real(kind(0d0)) :: err1, err2, err3, err4, err5 !< Error estimates for adaptive time stepping real(kind(0d0)) :: t_new !< Updated time step size @@ -452,7 +445,7 @@ contains real(kind(0d0)), intent(IN) :: fntait, fBtait, f_bub_adv_src, f_divu real(kind(0d0)), intent(out) :: h - real(kind(0d0)) :: h0, h1, h_min !< Time step size + real(kind(0d0)) :: h0, h1 !< Time step size real(kind(0d0)) :: d0, d1, d2 !< norms real(kind(0d0)), dimension(2) :: myR_tmp, myV_tmp, myA_tmp !< Bubble radius, radial velocity, and radial acceleration @@ -912,7 +905,6 @@ contains real(kind(0.d0)) :: T_bar real(kind(0.d0)) :: grad_T - real(kind(0.d0)) :: tmp1, tmp2 real(kind(0.d0)) :: f_bpres_dot if (thermal == 3) then diff --git a/src/simulation/m_chemistry.fpp b/src/simulation/m_chemistry.fpp index 4465a8a4d7..14b6c3b8e8 100644 --- a/src/simulation/m_chemistry.fpp +++ b/src/simulation/m_chemistry.fpp @@ -55,8 +55,6 @@ contains type(vector_field), dimension(:), intent(IN) :: flux_n type(scalar_field), dimension(sys_size), intent(INOUT) :: rhs_vf - type(int_bounds_info) :: ix, iy, iz - integer :: x, y, z integer :: eqn @@ -103,21 +101,12 @@ contains subroutine s_compute_chemistry_reaction_flux(rhs_vf, q_cons_qp, q_prim_qp) type(scalar_field), dimension(sys_size), intent(INOUT) :: rhs_vf, q_cons_qp, q_prim_qp - - integer :: i - integer :: x, y, z integer :: eqn - real(kind(0d0)) :: T - integer :: o - real(kind(0d0)) :: dyn_pres - real(kind(0d0)) :: E - real(kind(0d0)) :: rho, omega_m real(kind(0d0)), dimension(num_species) :: Ys real(kind(0d0)), dimension(num_species) :: omega - real(kind(0d0)) :: cp_mix if (chemistry) then !$acc parallel loop collapse(3) gang vector default(present) & diff --git a/src/simulation/m_data_output.fpp b/src/simulation/m_data_output.fpp index 5e9386708a..28b3979e0c 100644 --- a/src/simulation/m_data_output.fpp +++ b/src/simulation/m_data_output.fpp @@ -224,7 +224,6 @@ contains type(scalar_field), dimension(sys_size), intent(IN) :: q_prim_vf integer, intent(IN) :: t_step - real(kind(0d0)), dimension(num_fluids) :: alpha_rho !< Cell-avg. partial density real(kind(0d0)) :: rho !< Cell-avg. density real(kind(0d0)), dimension(num_dims) :: vel !< Cell-avg. velocity real(kind(0d0)) :: vel_sum !< Cell-avg. velocity sum @@ -232,34 +231,17 @@ contains real(kind(0d0)), dimension(num_fluids) :: alpha !< Cell-avg. volume fraction real(kind(0d0)) :: gamma !< Cell-avg. sp. heat ratio real(kind(0d0)) :: pi_inf !< Cell-avg. liquid stiffness function - real(kind(0d0)) :: qv !< Cell-avg. fluid reference energy real(kind(0d0)) :: c !< Cell-avg. sound speed - real(kind(0d0)) :: E !< Cell-avg. energy real(kind(0d0)) :: H !< Cell-avg. enthalpy real(kind(0d0)), dimension(2) :: Re !< Cell-avg. Reynolds numbers - - ! ICFL, VCFL, CCFL and Rc stability criteria extrema for the current - ! time-step and located on both the local (loc) and the global (glb) - ! computational domains - - real(kind(0d0)) :: blkmod1, blkmod2 !< - !! Fluid bulk modulus for Woods mixture sound speed - - integer :: i, j, k, l, q !< Generic loop iterators - - integer :: Nfq - real(kind(0d0)) :: fltr_dtheta !< - !! Modified dtheta accounting for Fourier filtering in azimuthal direction. + integer :: j, k, l ! Computing Stability Criteria at Current Time-step ================ - !$acc parallel loop collapse(3) gang vector default(present) private(alpha_rho, vel, alpha, Re, fltr_dtheta, Nfq) + !$acc parallel loop collapse(3) gang vector default(present) private(vel, alpha, Re) do l = 0, p do k = 0, n do j = 0, m - call s_compute_enthalpy(q_prim_vf, pres, rho, gamma, pi_inf, Re, H, alpha, vel, vel_sum, j, k, l) - - ! Compute mixture sound speed call s_compute_speed_of_sound(pres, rho, gamma, pi_inf, H, alpha, vel_sum, 0d0, c) if (any(Re_size > 0)) then @@ -380,14 +362,9 @@ contains character(LEN=15) :: FMT - integer :: i, j, k, l, ii, r!< Generic loop iterators + integer :: i, j, k, l, r - real(kind(0d0)), dimension(nb) :: nRtmp !< Temporary bubble concentration - real(kind(0d0)) :: nbub, nR3, vftmp !< Temporary bubble number density real(kind(0d0)) :: gamma, lit_gamma, pi_inf, qv !< Temporary EOS params - real(kind(0d0)) :: rho !< Temporary density - real(kind(0d0)), dimension(2) :: Re !< Temporary Reynolds number - real(kind(0d0)) :: E_e !< Temp. elastic energy contribution ! Creating or overwriting the time-step root directory write (t_step_dir, '(A,I0,A,I0)') trim(case_dir)//'/p_all' @@ -950,21 +927,17 @@ contains real(kind(0d0)) :: int_pres real(kind(0d0)) :: max_pres real(kind(0d0)), dimension(2) :: Re - real(kind(0d0)) :: E_e real(kind(0d0)), dimension(6) :: tau_e real(kind(0d0)) :: G real(kind(0d0)) :: dyn_p, Temp - integer :: i, j, k, l, s, q, d !< Generic loop iterator + integer :: i, j, k, l, s, d !< Generic loop iterator real(kind(0d0)) :: nondim_time !< Non-dimensional time real(kind(0d0)) :: tmp !< !! Temporary variable to store quantity for mpi_allreduce - real(kind(0d0)) :: blkmod1, blkmod2 !< - !! Fluid bulk modulus for Woods mixture sound speed - integer :: npts !< Number of included integral points real(kind(0d0)) :: rad, thickness !< For integral quantities logical :: trigger !< For integral quantities @@ -978,7 +951,7 @@ contains if (t_step_old /= dflt_int) then nondim_time = real(t_step + t_step_old, kind(0d0))*dt else - nondim_time = real(t_step, kind(0d0))*dt !*1.d-5/10.0761131451d0 + nondim_time = real(t_step, kind(0d0))*dt end if end if @@ -1603,10 +1576,6 @@ contains !! other procedures that are necessary to setup the module. subroutine s_initialize_data_output_module - type(int_bounds_info) :: ix, iy, iz - - integer :: i !< Generic loop iterator - ! Allocating/initializing ICFL, VCFL, CCFL and Rc stability criteria @:ALLOCATE_GLOBAL(icfl_sf(0:m, 0:n, 0:p)) icfl_max = 0d0 @@ -1644,8 +1613,6 @@ contains !> Module deallocation and/or disassociation procedures subroutine s_finalize_data_output_module - integer :: i !< Generic loop iterator - ! Deallocating the ICFL, VCFL, CCFL, and Rc stability criteria @:DEALLOCATE_GLOBAL(icfl_sf) if (any(Re_size > 0)) then diff --git a/src/simulation/m_mpi_proxy.fpp b/src/simulation/m_mpi_proxy.fpp index 7da0b04d62..3827bb61fe 100644 --- a/src/simulation/m_mpi_proxy.fpp +++ b/src/simulation/m_mpi_proxy.fpp @@ -870,10 +870,8 @@ contains logical :: beg_end_geq_0 - integer :: pack_offsets(1:3), unpack_offsets(1:3) integer :: pack_offset, unpack_offset real(kind(0d0)), pointer :: p_send, p_recv - integer, pointer, dimension(:) :: p_i_send, p_i_recv #ifdef MFC_MPI @@ -2135,7 +2133,6 @@ contains logical :: beg_end_geq_0 - integer :: pack_offsets(1:3), unpack_offsets(1:3) integer :: pack_offset, unpack_offset real(kind(0d0)), pointer :: p_send, p_recv diff --git a/src/simulation/m_qbmm.fpp b/src/simulation/m_qbmm.fpp index c478495a56..96e75a47d8 100644 --- a/src/simulation/m_qbmm.fpp +++ b/src/simulation/m_qbmm.fpp @@ -702,7 +702,7 @@ contains real(kind(0.d0)), intent(in) :: pres, rho, c real(kind(0.d0)), dimension(nterms, 0:2, 0:2), intent(out) :: coeffs - integer :: i1, i2, q + integer :: i1, i2 coeffs = 0d0 @@ -776,7 +776,7 @@ contains real(kind(0.d0)), intent(inout) :: pres, rho, c real(kind(0.d0)), dimension(nterms, 0:2, 0:2), intent(out) :: coeffs - integer :: i1, i2, q + integer :: i1, i2 coeffs = 0d0 @@ -841,20 +841,19 @@ contains real(kind(0d0)), dimension(nmom) :: moms, msum real(kind(0d0)), dimension(nnode, nb) :: wght, abscX, abscY, wght_pb, wght_mv, wght_ht, ht - real(kind(0d0)), dimension(nterms, 0:2, 0:2) :: mom3d_terms, coeff - real(kind(0d0)) :: pres, rho, nbub, c, alf, R3, momsum, drdt, drdt2, chi_vw, x_vw, rho_mw, k_mw, T_bar, grad_T - real(kind(0d0)) :: start, finish + real(kind(0d0)), dimension(nterms, 0:2, 0:2) :: coeff + real(kind(0d0)) :: pres, rho, nbub, c, alf, momsum, drdt, drdt2, chi_vw, x_vw, rho_mw, k_mw, T_bar, grad_T real(kind(0d0)) :: n_tait, B_tait - integer :: j, k, l, q, r, s !< Loop variables integer :: id1, id2, id3 integer :: i1, i2 + integer :: j, q, r is1_qbmm = ix; is2_qbmm = iy; is3_qbmm = iz !$acc update device(is1_qbmm, is2_qbmm, is3_qbmm) - !$acc parallel loop collapse(3) gang vector default(present) private(moms, msum, wght, abscX, abscY, wght_pb, wght_mv, wght_ht, coeff, ht, r, q, n_tait, B_tait, pres, rho, nbub, c, alf, R3, momsum, drdt, drdt2, chi_vw, x_vw, rho_mw, k_mw, T_bar, grad_T) + !$acc parallel loop collapse(3) gang vector default(present) private(moms, msum, wght, abscX, abscY, wght_pb, wght_mv, wght_ht, coeff, ht, r, q, n_tait, B_tait, pres, rho, nbub, c, alf, momsum, drdt, drdt2, chi_vw, x_vw, rho_mw, k_mw, T_bar, grad_T) do id3 = is3_qbmm%beg, is3_qbmm%end do id2 = is2_qbmm%beg, is2_qbmm%end do id1 = is1_qbmm%beg, is1_qbmm%end diff --git a/src/simulation/m_rhs.fpp b/src/simulation/m_rhs.fpp index a415baf213..248ea5b627 100644 --- a/src/simulation/m_rhs.fpp +++ b/src/simulation/m_rhs.fpp @@ -706,30 +706,9 @@ contains integer, intent(in) :: t_step real(kind(0d0)), intent(inout) :: time_avg - real(kind(0d0)) :: t_start, t_finish - real(kind(0d0)) :: gp_sum - - real(kind(0d0)) :: top, bottom !< Numerator and denominator when evaluating flux limiter function - real(kind(0d0)), dimension(num_fluids) :: myalpha_rho, myalpha - - real(kind(0d0)) :: tmp1, tmp2, tmp3, tmp4, & - c_gas, c_liquid, & - Cpbw, Cpinf, Cpinf_dot, & - myH, myHdot, rddot, alf_gas - - real(kind(0d0)) :: n_tait, B_tait, angle, angle_z - - real(kind(0d0)), dimension(nb) :: Rtmp, Vtmp - real(kind(0d0)) :: myR, myV, alf, myP, myRho, R2Vav real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: nbub - integer :: ndirs - - real(kind(0d0)) :: sound - real(kind(0d0)) :: start, finish - real(kind(0d0)) :: s2, const_sos, s1 - - integer :: i, c, j, k, l, q, ii, id !< Generic loop iterators - integer :: term_index + real(kind(0d0)) :: t_start, t_finish + integer :: i, j, k, l, id !< Generic loop iterators call nvtxStartRange("Compute_RHS") @@ -1600,7 +1579,7 @@ contains type(scalar_field), dimension(sys_size), intent(in) :: flux_src_n type(scalar_field), dimension(sys_size), intent(in) :: dq_prim_dx_vf, dq_prim_dy_vf, dq_prim_dz_vf - integer :: i, j, k, l, q + integer :: i, j, k, l if (idir == 1) then ! x-direction @@ -2096,7 +2075,6 @@ contains integer :: weno_dir !< Coordinate direction of the WENO reconstruction - integer :: i, j, k, l ! Reconstruction in s1-direction =================================== if (norm_dir == 1) then @@ -2220,7 +2198,7 @@ contains !> Module deallocation and/or disassociation procedures subroutine s_finalize_rhs_module - integer :: i, j, k, l !< Generic loop iterators + integer :: i, j, l do j = cont_idx%beg, cont_idx%end !$acc exit data detach(q_prim_qp%vf(j)%sf) diff --git a/src/simulation/m_riemann_solvers.fpp b/src/simulation/m_riemann_solvers.fpp index 9930e3ee60..a0e267a395 100644 --- a/src/simulation/m_riemann_solvers.fpp +++ b/src/simulation/m_riemann_solvers.fpp @@ -314,7 +314,7 @@ contains real(kind(0d0)), dimension(num_species) :: Ys_L, Ys_R real(kind(0d0)), dimension(num_species) :: Cp_iL, Cp_iR, Xs_L, Xs_R, Gamma_iL, Gamma_iR real(kind(0d0)), dimension(num_species) :: Yi_avg, Phi_avg, h_iL, h_iR, h_avg_2 - real(kind(0d0)) :: Cp_avg, Cv_avg, gamma_avggg, T_avg, eps, c_sum_Yi_Phi + real(kind(0d0)) :: Cp_avg, Cv_avg, T_avg, eps, c_sum_Yi_Phi real(kind(0d0)) :: T_L, T_R real(kind(0d0)) :: Y_L, Y_R real(kind(0d0)) :: MW_L, MW_R @@ -331,20 +331,15 @@ contains real(kind(0d0)), dimension(2) :: Re_L, Re_R real(kind(0d0)) :: rho_avg - real(kind(0d0)), dimension(num_dims) :: vel_avg real(kind(0d0)) :: H_avg real(kind(0d0)) :: gamma_avg real(kind(0d0)) :: c_avg real(kind(0d0)) :: s_L, s_R, s_M, s_P, s_S - real(kind(0d0)) :: xi_L, xi_R !< Left and right wave speeds functions real(kind(0d0)) :: xi_M, xi_P - real(kind(0d0)) :: nbub_L, nbub_R real(kind(0d0)) :: ptilde_L, ptilde_R real(kind(0d0)) :: vel_L_rms, vel_R_rms, vel_avg_rms - real(kind(0d0)) :: blkmod1, blkmod2 - real(kind(0d0)) :: rho_Star, E_Star, p_Star, p_K_Star real(kind(0d0)) :: Ms_L, Ms_R, pres_SL, pres_SR real(kind(0d0)) :: alpha_L_sum, alpha_R_sum @@ -374,7 +369,7 @@ contains if (norm_dir == ${NORM_DIR}$) then !$acc parallel loop collapse(3) gang vector default(present) & !$acc private(alpha_rho_L, alpha_rho_R, vel_L, vel_R, alpha_L, & - !$acc alpha_R, vel_avg, tau_e_L, tau_e_R, G_L, G_R, Re_L, Re_R, & + !$acc alpha_R, tau_e_L, tau_e_R, G_L, G_R, Re_L, Re_R, & !$acc rho_avg, h_avg, gamma_avg, s_L, s_R, s_S, Ys_L, Ys_R, & !$acc Cp_iL, Cp_iR, Xs_L, Xs_R, Gamma_iL, Gamma_iR, & !$acc Yi_avg, Phi_avg, h_iL, h_iR, h_avg_2) @@ -947,7 +942,6 @@ contains real(kind(0d0)), dimension(2) :: Re_L, Re_R real(kind(0d0)) :: rho_avg - real(kind(0d0)), dimension(num_dims) :: vel_avg real(kind(0d0)) :: H_avg real(kind(0d0)) :: gamma_avg real(kind(0d0)) :: c_avg @@ -961,7 +955,6 @@ contains real(kind(0d0)), dimension(nb) :: V0_L, V0_R real(kind(0d0)), dimension(nb) :: P0_L, P0_R real(kind(0d0)), dimension(nb) :: pbw_L, pbw_R - real(kind(0d0)), dimension(nb, nmom) :: moms_L, moms_R real(kind(0d0)) :: ptilde_L, ptilde_R real(kind(0d0)) :: alpha_L_sum, alpha_R_sum, nbub_L_denom, nbub_R_denom @@ -972,10 +965,8 @@ contains real(kind(0d0)) :: vel_L_rms, vel_R_rms, vel_avg_rms real(kind(0d0)) :: vel_L_tmp, vel_R_tmp - real(kind(0d0)) :: blkmod1, blkmod2 real(kind(0d0)) :: rho_Star, E_Star, p_Star, p_K_Star real(kind(0d0)) :: pres_SL, pres_SR, Ms_L, Ms_R - real(kind(0d0)) :: start, finish real(kind(0d0)) :: zcoef, pcorr !< low Mach number correction integer :: i, j, k, l, q !< Generic loop iterators integer :: idx1, idxi @@ -1360,7 +1351,7 @@ contains end do elseif (model_eqns == 4) then !ME4 - !$acc parallel loop collapse(3) gang vector default(present) private(alpha_rho_L, alpha_rho_R, vel_L, vel_R, alpha_L, alpha_R, vel_avg, & + !$acc parallel loop collapse(3) gang vector default(present) private(alpha_rho_L, alpha_rho_R, vel_L, vel_R, alpha_L, alpha_R, & !$acc rho_avg, h_avg, gamma_avg, s_L, s_R, s_S, vel_avg_rms, nbub_L, nbub_R, ptilde_L, ptilde_R) do l = is3%beg, is3%end do k = is2%beg, is2%end diff --git a/src/simulation/m_sim_helpers.f90 b/src/simulation/m_sim_helpers.f90 index 9b1f1ce216..bb78b8d160 100644 --- a/src/simulation/m_sim_helpers.f90 +++ b/src/simulation/m_sim_helpers.f90 @@ -86,7 +86,7 @@ end subroutine s_compute_enthalpy subroutine s_compute_stability_from_dt(vel, c, rho, Re_l, j, k, l, icfl_sf, vcfl_sf, Rc_sf) !$acc routine seq real(kind(0d0)), dimension(num_dims) :: vel - real(kind(0d0)) :: c, icfl_dt, vcfl_dt, rho + real(kind(0d0)) :: c, rho real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf real(kind(0d0)) :: fltr_dtheta !< diff --git a/src/simulation/m_start_up.fpp b/src/simulation/m_start_up.fpp index f40429b538..f48b8216bc 100644 --- a/src/simulation/m_start_up.fpp +++ b/src/simulation/m_start_up.fpp @@ -215,9 +215,6 @@ contains ! Logical used to check the existence of the current directory file logical :: file_exist - ! Generic loop iterators - integer :: i, j - ! Logistics ======================================================== file_path = trim(case_dir)//'/.' @@ -416,8 +413,6 @@ contains end if if (patch_ib(i)%c > 0) then - - print *, "HERE Np", Np allocate (airfoil_grid_u(1:Np)) allocate (airfoil_grid_l(1:Np)) @@ -1099,7 +1094,7 @@ contains real(kind(0d0)), intent(inout) :: start, finish integer, intent(inout) :: nt - integer :: i, j, k, l + integer :: i if (cfl_dt) then if (cfl_const_dt .and. t_step == 0) call s_compute_dt() diff --git a/src/simulation/m_time_steppers.fpp b/src/simulation/m_time_steppers.fpp index 4f78bb28bb..f1a8c2be5e 100644 --- a/src/simulation/m_time_steppers.fpp +++ b/src/simulation/m_time_steppers.fpp @@ -301,15 +301,9 @@ contains integer, intent(in) :: t_step real(kind(0d0)), intent(inout) :: time_avg - integer :: i, j, k, l, q!< Generic loop iterator - real(kind(0d0)) :: nR3bar - real(kind(0d0)) :: e_mix - - real(kind(0d0)) :: T - real(kind(0d0)), dimension(num_species) :: Ys + integer :: i, j, k, l, q !< Generic loop iterator ! Stage 1 of 1 ===================================================== - call nvtxStartRange("Time_Step") call s_compute_rhs(q_cons_ts(1)%vf, q_prim_vf, rhs_vf, pb_ts(1)%sf, rhs_pb, mv_ts(1)%sf, rhs_mv, t_step, time_avg) @@ -417,7 +411,6 @@ contains integer :: i, j, k, l, q!< Generic loop iterator real(kind(0d0)) :: start, finish - real(kind(0d0)) :: nR3bar ! Stage 1 of 2 ===================================================== @@ -599,9 +592,7 @@ contains real(kind(0d0)), intent(INOUT) :: time_avg integer :: i, j, k, l, q !< Generic loop iterator - real(kind(0d0)) :: ts_error, denom, error_fraction, time_step_factor !< Generic loop iterator real(kind(0d0)) :: start, finish - real(kind(0d0)) :: nR3bar ! Stage 1 of 3 ===================================================== @@ -862,7 +853,6 @@ contains integer, intent(in) :: t_step real(kind(0d0)), intent(inout) :: time_avg - integer :: i, j, k, l !< Generic loop iterator real(kind(0d0)) :: start, finish call cpu_time(start) @@ -896,8 +886,6 @@ contains type(vector_field) :: gm_alpha_qp - integer :: i, j, k, l, q !< Generic loop iterator - call s_convert_conservative_to_primitive_variables( & q_cons_ts(1)%vf, & q_prim_vf, & @@ -924,7 +912,7 @@ contains real(kind(0d0)), dimension(2) :: Re !< Cell-avg. Reynolds numbers type(vector_field) :: gm_alpha_qp real(kind(0d0)) :: dt_local - integer :: i, j, k, l, q !< Generic loop iterators + integer :: j, k, l !< Generic loop iterators call s_convert_conservative_to_primitive_variables( & q_cons_ts(1)%vf, & diff --git a/src/simulation/m_viscous.fpp b/src/simulation/m_viscous.fpp index 139fccc7c3..fc23d3c9e1 100644 --- a/src/simulation/m_viscous.fpp +++ b/src/simulation/m_viscous.fpp @@ -1467,8 +1467,6 @@ contains subroutine s_finalize_viscous_module() - integer :: i - @:DEALLOCATE_GLOBAL(Res_viscous) end subroutine s_finalize_viscous_module diff --git a/src/simulation/m_weno.fpp b/src/simulation/m_weno.fpp index f0b5490b41..655e0c6a58 100644 --- a/src/simulation/m_weno.fpp +++ b/src/simulation/m_weno.fpp @@ -160,7 +160,6 @@ contains !! other procedures that are necessary to setup the module. subroutine s_initialize_weno_module - integer :: i, j if (weno_order == 1) return ! Allocating/Computing WENO Coefficients in x-direction ============ @@ -552,7 +551,6 @@ contains real(kind(0d0)), dimension(0:weno_num_stencils) :: delta real(kind(0d0)), dimension(-3:3) :: v ! temporary field value array for clarity (WENO7 only) real(kind(0d0)) :: tau - real(kind(0d0)), pointer :: beta_p(:) integer :: i, j, k, l @@ -974,7 +972,7 @@ contains integer, intent(IN) :: norm_dir integer, intent(IN) :: weno_dir - integer :: i, j, k, l, q !< Generic loop iterators + integer :: j, k, l, q ! Determining the number of cell-average variables which will be ! WENO-reconstructed and mapping their indical bounds in the x-, @@ -1253,8 +1251,6 @@ contains !> Module deallocation and/or disassociation procedures subroutine s_finalize_weno_module() - integer :: i, j - if (weno_order == 1) return ! Deallocating the WENO-stencil of the WENO-reconstructed variables