diff --git a/src/common/m_boundary_common.fpp b/src/common/m_boundary_common.fpp index 55ac2fec82..a242316f15 100644 --- a/src/common/m_boundary_common.fpp +++ b/src/common/m_boundary_common.fpp @@ -77,7 +77,6 @@ contains real(wp), dimension(idwbuff(1)%beg:, idwbuff(2)%beg:, idwbuff(3)%beg:, 1:, 1:), intent(inout) :: pb, mv type(integer_field), dimension(1:num_dims, -1:1), intent(in) :: bc_type - integer :: bc_loc, bc_dir integer :: k, l ! Population of Buffers in x-direction @@ -249,7 +248,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, q, i + integer :: j, i if (qbmm .and. .not. polytropic) then call s_qbmm_extrapolation(pb, mv, bc_dir, bc_loc, k, l) @@ -789,7 +788,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, q, i + integer :: j, i if (qbmm .and. .not. polytropic) then call s_qbmm_extrapolation(pb, mv, bc_dir, bc_loc, k, l) @@ -888,7 +887,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, q, i + integer :: j, i if (qbmm .and. .not. polytropic) then call s_qbmm_extrapolation(pb, mv, bc_dir, bc_loc, k, l) @@ -1023,7 +1022,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, i, q + integer :: j, i #ifdef MFC_PRE_PROCESS call s_ghost_cell_extrapolation(q_prim_vf, pb, mv, 1, -1, k, l) @@ -1162,7 +1161,7 @@ contains type(scalar_field), dimension(num_dims + 1), intent(inout) :: c_divs type(integer_field), dimension(1:num_dims, -1:1), intent(in) :: bc_type - integer :: i, j, k, l + integer :: k, l !< x-direction if (bcxb >= 0) then @@ -1290,7 +1289,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, i, q + integer :: j, i if (bc_dir == 1) then !< x-direction if (bc_loc == -1) then !bc_x%beg @@ -1348,7 +1347,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, i, q + integer :: j, i if (bc_dir == 1) then !< x-direction if (bc_loc == -1) then !bc_x%beg @@ -1430,7 +1429,7 @@ contains integer, intent(in) :: bc_dir, bc_loc integer, intent(in) :: k, l - integer :: j, i, q + integer :: j, i if (bc_dir == 1) then !< x-direction if (bc_loc == -1) then !bc_x%beg @@ -1485,7 +1484,7 @@ contains #ifdef MFC_MPI integer :: dir, loc integer, dimension(3) :: sf_start_idx, sf_extents_loc - integer :: ifile, ierr, data_size + integer :: ierr do dir = 1, num_dims do loc = -1, 1, 2 diff --git a/src/common/m_chemistry.fpp b/src/common/m_chemistry.fpp index 47bbd71d19..1cdc837348 100644 --- a/src/common/m_chemistry.fpp +++ b/src/common/m_chemistry.fpp @@ -28,7 +28,7 @@ contains type(int_bounds_info), dimension(1:3), intent(in) :: bounds integer :: x, y, z, eqn - real(wp) :: energy, mean_molecular_weight + real(wp) :: energy real(wp), dimension(num_species) :: Ys do z = bounds(3)%beg, bounds(3)%end diff --git a/src/common/m_eigen_solver.f90 b/src/common/m_eigen_solver.f90 index 4fef5153fb..4bbf6aa97e 100644 --- a/src/common/m_eigen_solver.f90 +++ b/src/common/m_eigen_solver.f90 @@ -225,7 +225,7 @@ subroutine corth(nm, nl, low, igh, ar, ai, ortr, orti) real(wp), dimension(igh), intent(out) :: ortr, orti integer :: i, j, ml, ii, jj, la, mp, kp1, mll - real(wp) :: f, g, h, fi, fr, scale, c + real(wp) :: f, g, h, fi, fr, scale mll = 6 @@ -353,7 +353,7 @@ subroutine comqr2(nm, nl, low, igh, ortr, orti, hr, hi, wr, wi, zr, zi, ierr) integer :: i, j, k, l, ml, en, ii, jj, ll, nn, ip1, itn, its, lp1, enm1, iend real(wp) :: si, sr, ti, tr, xi, xr, xxi, xxr, yi, yr, zzi, zzr, & - norm, tst1, tst2, c, d + norm, tst1, tst2, c ! ierr = 0 ! initialize eigenvector matrix diff --git a/src/common/m_helper.fpp b/src/common/m_helper.fpp index aab6855a37..186ff9e2e7 100644 --- a/src/common/m_helper.fpp +++ b/src/common/m_helper.fpp @@ -395,8 +395,6 @@ contains integer :: i - real(wp), dimension(1:4) :: tmp - do i = 1, 3 call s_transform_vec(triangle%v(i, :), matrix) end do diff --git a/src/common/m_mpi_common.fpp b/src/common/m_mpi_common.fpp index 4645e59c13..8450f94710 100644 --- a/src/common/m_mpi_common.fpp +++ b/src/common/m_mpi_common.fpp @@ -160,7 +160,7 @@ contains #ifdef MFC_MPI ! Generic loop iterator - integer :: i, j, q, k, l + integer :: i, j !Altered system size for the lagrangian subgrid bubble model integer :: alt_sys @@ -309,7 +309,7 @@ contains integer, intent(in) :: root ! Rank of the root process real(wp), allocatable, intent(out) :: gathered_vector(:) ! Gathered vector on the root process - integer :: i, offset, ierr + integer :: i, ierr integer, allocatable :: recounts(:), displs(:) #ifdef MFC_MPI @@ -1076,7 +1076,7 @@ contains type(scalar_field), dimension(num_dims + 1), intent(inout) :: c_divs_vf integer, intent(in) :: mpi_dir, pbc_loc - integer :: i, j, k, l, r, q !< Generic loop iterators + integer :: i, j, k, l, r !< Generic loop iterators integer :: buffer_counts(1:3), buffer_count diff --git a/src/common/m_variables_conversion.fpp b/src/common/m_variables_conversion.fpp index c3a62deeab..9cac8081f0 100644 --- a/src/common/m_variables_conversion.fpp +++ b/src/common/m_variables_conversion.fpp @@ -846,15 +846,15 @@ contains real(wp) :: rhoYks(1:num_species) - real(wp) :: vftmp, nR3, nbub_sc, R3tmp + real(wp) :: vftmp, nbub_sc real(wp) :: G_K - real(wp) :: pres, Yksum + real(wp) :: pres - integer :: i, j, k, l, q !< Generic loop iterators + integer :: i, j, k, l !< Generic loop iterators - real(wp) :: ntmp, T + real(wp) :: T real(wp) :: pres_mag real(wp) :: Ga ! Lorentz factor (gamma in relativity) @@ -885,7 +885,7 @@ contains !$acc parallel loop collapse(3) gang vector default(present) & !$acc private(alpha_K, alpha_rho_K, Re_K, nRtmp, rho_K, gamma_K, & - !$acc pi_inf_K, qv_K, dyn_pres_K, R3tmp, rhoYks, B) + !$acc pi_inf_K, qv_K, dyn_pres_K, rhoYks, B) do l = ibounds(3)%beg, ibounds(3)%end do k = ibounds(2)%beg, ibounds(2)%end do j = ibounds(1)%beg, ibounds(1)%end @@ -1181,13 +1181,12 @@ contains real(wp) :: pi_inf real(wp) :: qv real(wp) :: dyn_pres - real(wp) :: nbub, R3, vftmp, R3tmp + real(wp) :: nbub, R3tmp real(wp), dimension(nb) :: Rtmp real(wp) :: G real(wp), dimension(2) :: Re_K - integer :: i, j, k, l, q !< Generic loop iterators - integer :: spec + integer :: i, j, k, l !< Generic loop iterators real(wp), dimension(num_species) :: Ys real(wp) :: e_mix, mix_mol_weight, T @@ -1592,8 +1591,6 @@ contains subroutine s_finalize_variables_conversion_module() - integer :: i !< Generic loop iterators - ! Deallocating the density, the specific heat ratio function and the ! liquid stiffness function #ifdef MFC_POST_PROCESS @@ -1698,7 +1695,6 @@ contains integer, intent(in) :: norm real(wp) :: B2, term, disc - real(wp) :: term2 B2 = sum(B**2) diff --git a/src/post_process/m_data_input.f90 b/src/post_process/m_data_input.f90 index 5385ef7619..473ba80fc1 100644 --- a/src/post_process/m_data_input.f90 +++ b/src/post_process/m_data_input.f90 @@ -278,7 +278,7 @@ subroutine s_read_parallel_data_files(t_step) integer :: ifile, ierr, data_size integer, dimension(MPI_STATUS_SIZE) :: status - real(wp) :: start, finish + integer(KIND=MPI_OFFSET_KIND) :: disp integer(KIND=MPI_OFFSET_KIND) :: m_MOK, n_MOK, p_MOK integer(KIND=MPI_OFFSET_KIND) :: WP_MOK, var_MOK, str_MOK diff --git a/src/post_process/m_data_output.fpp b/src/post_process/m_data_output.fpp index 202c287c34..4426f58074 100644 --- a/src/post_process/m_data_output.fpp +++ b/src/post_process/m_data_output.fpp @@ -859,7 +859,6 @@ contains ! Generic loop iterator integer :: i, j, k - real(wp) :: start, finish ! Silo-HDF5 Database Format @@ -1092,23 +1091,22 @@ contains subroutine s_write_lag_bubbles_results(t_step) integer, intent(in) :: t_step - character(len=len_trim(case_dir) + 2*name_len) :: t_step_dir + character(len=len_trim(case_dir) + 3*name_len) :: file_loc - logical :: dir_check - integer :: id, nlg_bubs + + integer :: id #ifdef MFC_MPI real(wp), dimension(20) :: inputvals - real(wp) :: id_real, time_real + real(wp) :: time_real integer, dimension(MPI_STATUS_SIZE) :: status integer(KIND=MPI_OFFSET_KIND) :: disp integer :: view - integer, dimension(3) :: cell - logical :: indomain, lg_bub_file, lg_bub_data, file_exist + logical :: lg_bub_file, file_exist integer, dimension(2) :: gsizes, lsizes, start_idx_part - integer :: ifile, ireq, ierr, data_size, tot_data + integer :: ifile, ierr, tot_data integer :: i write (file_loc, '(A,I0,A)') 'lag_bubbles_mpi_io_', t_step, '.dat' @@ -1196,12 +1194,11 @@ contains subroutine s_write_intf_data_file(q_prim_vf) type(scalar_field), dimension(sys_size), intent(IN) :: q_prim_vf - integer :: i, j, k, l, w, cent !< Generic loop iterators - integer :: ierr, counter, root !< number of data points extracted to fit shape to SH perturbations - real(wp), dimension(num_fluids) :: alpha, vol_fluid, xcom, ycom, zcom + integer :: i, j, k, l, cent !< Generic loop iterators + integer :: counter, root !< number of data points extracted to fit shape to SH perturbations real(wp), parameter :: pi = 4._wp*tan(1._wp) real(wp), allocatable :: x_td(:), y_td(:), x_d1(:), y_d1(:), y_d(:), x_d(:) - real(wp) :: axp, axm, ayp, aym, azm, azp, tgp, euc_d, thres, maxalph_loc, maxalph_glb + real(wp) :: axp, axm, ayp, aym, tgp, euc_d, thres, maxalph_loc, maxalph_glb allocate (x_d1(m*n)) allocate (y_d1(m*n)) @@ -1290,9 +1287,8 @@ contains real(wp) :: Elk, Egk, Elp, Egint, Vb, Vl, pres_av, Et real(wp) :: rho, pres, dV, tmp, gamma, pi_inf, MaxMa, MaxMa_glb, maxvel, c, Ma, H real(wp), dimension(num_vels) :: vel - real(wp), dimension(num_fluids) :: gammas, pi_infs, adv + real(wp), dimension(num_fluids) :: adv integer :: i, j, k, l, s !looping indices - integer :: ierr, counter, root !< number of data points extracted to fit shape to SH perturbations Egk = 0_wp Elp = 0_wp diff --git a/src/post_process/m_derived_variables.fpp b/src/post_process/m_derived_variables.fpp index 7fdb620763..65f78dfdac 100644 --- a/src/post_process/m_derived_variables.fpp +++ b/src/post_process/m_derived_variables.fpp @@ -329,9 +329,6 @@ contains real(wp), dimension(ndim), intent(inout) :: b real(wp), dimension(ndim), intent(out) :: sol - integer, dimension(ndim) :: ipiv - - integer :: nrhs, lda, ldb, info !EXTERNAL DGESV integer :: i, j, k @@ -491,7 +488,7 @@ contains real(wp), & dimension(1:3, 1:3) :: q_jacobian_sf, S, S2, O, O2 - real(wp) :: trS, trS2, trO2, Q, IIS + real(wp) :: trS, Q, IIS integer :: j, k, l, r, jj, kk !< Generic loop iterators do l = -offset_z%beg, p + offset_z%end @@ -585,8 +582,6 @@ contains !! The first position in the variable contains the maximum value and !! the second contains the rank of the processor on which it occurred. - real(wp) :: alpha_unadv !< Unadvected volume fraction - integer :: i, j, k, l !< Generic loop iterators ! Computing Gradient Magnitude of Density diff --git a/src/pre_process/m_assign_variables.fpp b/src/pre_process/m_assign_variables.fpp index ba5ab6608d..d79c97d39a 100644 --- a/src/pre_process/m_assign_variables.fpp +++ b/src/pre_process/m_assign_variables.fpp @@ -111,14 +111,7 @@ contains type(scalar_field), dimension(1:sys_size), intent(inout) :: q_prim_vf integer, dimension(0:m, 0:n, 0:p), intent(inout) :: patch_id_fp - real(wp) :: rho !< density - real(wp), dimension(int(E_idx - mom_idx%beg)) :: vel !< velocity - real(wp) :: pres !< pressure - real(wp) :: gamma !< specific heat ratio function - real(wp) :: x_centroid, y_centroid - real(wp) :: epsilon, beta real(wp) :: Ys(1:num_species) - real(wp) :: mean_molecular_weight integer :: smooth_patch_id integer :: i !< generic loop operator @@ -308,13 +301,7 @@ contains real(wp) :: rcoord, theta, phi, xi_sph real(wp), dimension(3) :: xi_cart - real(wp), dimension(int(E_idx - mom_idx%beg)) :: vel !< velocity - real(wp) :: pres !< pressure - real(wp) :: x_centroid, y_centroid - real(wp) :: epsilon, beta - real(wp) :: Ys(1:num_species) - real(wp) :: mean_molecular_weight real(wp), dimension(sys_size) :: orig_prim_vf !< !! Vector to hold original values of cell for smoothing purposes diff --git a/src/pre_process/m_boundary_conditions.fpp b/src/pre_process/m_boundary_conditions.fpp index 5bc18ad68c..8c8b185c69 100644 --- a/src/pre_process/m_boundary_conditions.fpp +++ b/src/pre_process/m_boundary_conditions.fpp @@ -35,7 +35,7 @@ contains type(integer_field), dimension(1:num_dims, -1:1), intent(inout) :: bc_type integer, intent(in) :: patch_id - integer :: i, j, k, l + integer :: j ! Patch is a vertical line at x_beg or x_end if (patch_bc(patch_id)%dir == 1) then @@ -86,7 +86,7 @@ contains integer, intent(in) :: patch_id - integer :: i, j, k, l + integer :: j, k if (patch_bc(patch_id)%dir == 1) then y_centroid = patch_bc(patch_id)%centroid(2) z_centroid = patch_bc(patch_id)%centroid(3) @@ -149,7 +149,7 @@ contains type(integer_field), dimension(1:num_dims, -1:1), intent(inout) :: bc_type integer, intent(in) :: patch_id - integer :: i, j, k, l + integer :: j, k if (patch_bc(patch_id)%dir == 1) then y_centroid = patch_bc(patch_id)%centroid(2) z_centroid = patch_bc(patch_id)%centroid(3) @@ -274,7 +274,7 @@ contains character(LEN=*), intent(in) :: step_dirpath - integer :: dir, loc, i + integer :: dir, loc character(len=path_len) :: file_path character(len=10) :: status @@ -315,8 +315,6 @@ contains integer :: dir, loc character(len=path_len) :: file_loc, file_path - character(len=10) :: status - #ifdef MFC_MPI integer :: ierr integer :: file_id diff --git a/src/pre_process/m_compute_levelset.fpp b/src/pre_process/m_compute_levelset.fpp index d339157be6..b22efc7c2b 100644 --- a/src/pre_process/m_compute_levelset.fpp +++ b/src/pre_process/m_compute_levelset.fpp @@ -77,7 +77,7 @@ contains type(levelset_norm_field), intent(INOUT) :: levelset_norm integer, intent(IN) :: ib_patch_id - real(wp) :: radius, dist, global_dist + real(wp) :: dist, global_dist integer :: global_id real(wp) :: x_centroid, y_centroid, x_act, y_act, theta real(wp), dimension(3) :: dist_vec @@ -160,7 +160,7 @@ contains type(levelset_norm_field), intent(INOUT) :: levelset_norm integer, intent(IN) :: ib_patch_id - real(wp) :: radius, dist, dist_surf, dist_side, global_dist + real(wp) :: dist, dist_surf, dist_side, global_dist integer :: global_id real(wp) :: x_centroid, y_centroid, z_centroid, lz, z_max, z_min, x_act, y_act, theta real(wp), dimension(3) :: dist_vec @@ -507,10 +507,10 @@ contains type(levelset_norm_field), intent(INOUT) :: levelset_norm integer, intent(IN) :: ib_patch_id - real(wp) :: radius, dist + real(wp) :: radius real(wp) :: x_centroid, y_centroid, z_centroid real(wp) :: length_x, length_y, length_z - real(wp), dimension(3) :: pos_vec, centroid_vec, dist_vec, dist_sides_vec, dist_surface_vec + real(wp), dimension(3) :: pos_vec, centroid_vec, dist_sides_vec, dist_surface_vec real(wp) :: dist_side, dist_surface, side_pos type(bounds_info) :: boundary integer :: i, j, k !< Loop index variables diff --git a/src/pre_process/m_data_output.fpp b/src/pre_process/m_data_output.fpp index 7ae637f034..99695b2dab 100644 --- a/src/pre_process/m_data_output.fpp +++ b/src/pre_process/m_data_output.fpp @@ -131,7 +131,7 @@ contains character(LEN=len_trim(t_step_dir) + name_len) :: file_loc !< !! Generic string used to store the address of a particular file - integer :: i, j, k, l, r, c, dir !< Generic loop iterator + integer :: i, j, k, l, r, c !< Generic loop iterator integer :: t_step real(wp), dimension(nb) :: nRtmp !< Temporary bubble concentration @@ -140,9 +140,6 @@ contains real(wp) :: rho !< Temporary density real(wp) :: pres, T !< Temporary pressure - real(wp) :: nR3 - real(wp) :: ntmp - real(wp) :: rhoYks(1:num_species) !< Temporary species mass fractions real(wp) :: pres_mag diff --git a/src/pre_process/m_initial_condition.fpp b/src/pre_process/m_initial_condition.fpp index 0efc1c225d..67e07a2542 100644 --- a/src/pre_process/m_initial_condition.fpp +++ b/src/pre_process/m_initial_condition.fpp @@ -175,8 +175,6 @@ contains !! primitive variables are converted to conservative ones. subroutine s_generate_initial_condition - integer :: i !< Generic loop operator - ! First, compute the temperature field from the conservative variables. if (chemistry) call s_compute_q_T_sf(q_T_sf, q_cons_vf, idwint) diff --git a/src/pre_process/m_model.fpp b/src/pre_process/m_model.fpp index bbd50e52bd..8565556abc 100644 --- a/src/pre_process/m_model.fpp +++ b/src/pre_process/m_model.fpp @@ -34,7 +34,7 @@ contains character(LEN=*), intent(in) :: filepath type(t_model), intent(out) :: model - integer :: i, j, iunit, iostat + integer :: i, iunit, iostat character(kind=c_char, len=80) :: header integer(kind=c_int32_t) :: nTriangles @@ -539,7 +539,7 @@ contains logical :: intersects - real(wp) :: v0v1(3), v0v2(3), N(3), P(3), C(3), edge(3), vp(3) + real(wp) :: N(3), P(3), C(3), edge(3), vp(3) real(wp) :: area2, d, t, NdotRayDirection intersects = .false. @@ -810,7 +810,6 @@ contains real(wp) :: edge_length, cell_width real(wp), dimension(1:2) :: edge_x, edge_y, edge_del - real(wp), allocatable :: temp_boundary_v(:, :) ! Get the number of boundary edges cell_width = minval(spacing(1:2)) @@ -904,7 +903,6 @@ contains t_vec3 :: edge_del, cell_area t_vec3 :: bary_coord !< Barycentric coordinates real(wp) :: edge_length, cell_width, cell_area_min, tri_area - real(wp), allocatable :: temp_boundary_v(:, :) ! Number of triangles in the model num_triangles = model%ntrs @@ -1050,7 +1048,6 @@ contains t_vec3, intent(out) :: normals real(wp), intent(out) :: distance - real(wp), dimension(1:model%ntrs, 1:3) :: tri_normals real(wp), dimension(1:3, 1:3) :: tri real(wp) :: dist_min, dist_t_min real(wp) :: dist_min_normal, dist_buffer_normal diff --git a/src/pre_process/m_patches.fpp b/src/pre_process/m_patches.fpp index c01f91654b..dca1ff1352 100644 --- a/src/pre_process/m_patches.fpp +++ b/src/pre_process/m_patches.fpp @@ -455,8 +455,8 @@ contains type(scalar_field), dimension(1:sys_size), intent(inout) :: q_prim_vf logical, optional, intent(in) :: ib - real(wp) :: x0, y0, f, x_act, y_act, ca, pa, ma, ta, theta, xa, ya, yt, xu, yu, xl, yl, xc, yc, dycdxc, sin_c, cos_c - integer :: i, j, k, l + real(wp) :: x0, y0, f, x_act, y_act, ca, pa, ma, ta, theta, xa, yt, xu, yu, xl, yl, xc, yc, dycdxc, sin_c, cos_c + integer :: i, j, k integer :: Np1, Np2 if (.not. present(ib)) return @@ -617,7 +617,7 @@ contains type(scalar_field), dimension(1:sys_size), intent(inout) :: q_prim_vf logical, optional, intent(in) :: ib - real(wp) :: x0, y0, z0, lz, z_max, z_min, f, x_act, y_act, ca, pa, ma, ta, theta, xa, ya, yt, xu, yu, xl, yl, xc, yc, dycdxc, sin_c, cos_c + real(wp) :: x0, y0, z0, lz, z_max, z_min, f, x_act, y_act, ca, pa, ma, ta, theta, xa, yt, xu, yu, xl, yl, xc, yc, dycdxc, sin_c, cos_c integer :: i, j, k, l integer :: Np1, Np2 @@ -1297,9 +1297,9 @@ contains type(scalar_field), dimension(1:sys_size), intent(inout) :: q_prim_vf ! Generic loop iterators - integer :: i, j, k + integer :: i ! Placeholders for the cell boundary values - real(wp) :: a, b, c, d, pi_inf, gamma, lit_gamma + real(wp) :: pi_inf, gamma, lit_gamma @:Hardcoded1DVariables() @@ -1359,7 +1359,7 @@ contains ! Generic loop iterators integer :: i, j, k ! Placeholders for the cell boundary values - real(wp) :: fac, a, b, c, d, pi_inf, gamma, lit_gamma + real(wp) :: pi_inf, gamma, lit_gamma pi_inf = fluid_pp(1)%pi_inf gamma = fluid_pp(1)%gamma @@ -1410,8 +1410,8 @@ contains integer, dimension(0:m, 0:n, 0:p), intent(inout) :: patch_id_fp type(scalar_field), dimension(1:sys_size), intent(inout) :: q_prim_vf - integer :: i, j, k !< generic loop iterators - real(wp) :: a, b, c, d !< placeholderrs for the cell boundary values + integer :: i, j !< generic loop iterators + real(wp) :: pi_inf, gamma, lit_gamma !< equation of state parameters real(wp) :: l, U0 !< Taylor Green Vortex parameters @@ -1570,9 +1570,7 @@ contains integer :: i, j, k !< generic loop iterators - real(wp) :: epsilon, beta complex(wp), parameter :: cmplx_i = (0._wp, 1._wp) - complex(wp) :: H ! Transferring the patch's centroid and radius information x_centroid = patch_icpp(patch_id)%x_centroid @@ -1720,8 +1718,7 @@ contains integer :: i, j, k !< generic loop iterators real(wp) :: radius - real(wp) :: radius_pressure, pressure_bubble, pressure_inf !< - !! Variables to initialize the pressure field that corresponds to the + !! Variables to initialize the pressure field that corresponds to the !! bubble-collapse test case found in Tiwari et al. (2013) ! Transferring spherical patch's radius, centroid, smoothing patch diff --git a/src/pre_process/m_perturbation.fpp b/src/pre_process/m_perturbation.fpp index d1b7536fdb..23353eee0f 100644 --- a/src/pre_process/m_perturbation.fpp +++ b/src/pre_process/m_perturbation.fpp @@ -61,7 +61,7 @@ contains integer :: i, j, k, l !< generic loop operators real(wp) :: perturb_alpha - real(wp) :: alpha_unadv + real(wp) :: rand_real call random_seed() @@ -90,7 +90,7 @@ contains subroutine s_perturb_surrounding_flow(q_prim_vf) type(scalar_field), dimension(sys_size), intent(inout) :: q_prim_vf - integer :: i, j, k, l !< generic loop iterators + integer :: i, j, k !< generic loop iterators real(wp) :: perturb_alpha real(wp) :: rand_real @@ -188,7 +188,7 @@ contains real(wp), intent(inout) :: fR real(wp) :: f0, f1 real(wp) :: gam_b - integer :: ii, jj + integer :: ii gam_b = 1._wp + 1._wp/fluid_pp(num_fluids + 1)%gamma @@ -238,7 +238,7 @@ contains real(wp), dimension(0:nbp - 1, 0:nbp - 1) :: d !< differential operator in y dir real(wp) :: gam, pi_inf, mach, c1, adv real(wp) :: xratio, uratio - integer :: i, j !< generic loop iterators + integer :: j !< generic loop iterators xratio = mixlayer_vel_coef uratio = 1._wp/patch_icpp(1)%vel(1) @@ -299,7 +299,7 @@ contains real(wp), dimension(0:mixlayer_nvar*n - n_bc_skip - 1) :: fv1, fv2, fv3 !< temporary memory integer :: ierr - integer :: i, j, k, l !< generic loop iterators + integer :: j, k !< generic loop iterators integer :: ii, jj !< block matrix indices ! Compute y-derivatives of rho and u diff --git a/src/pre_process/p_main.f90 b/src/pre_process/p_main.f90 index b45a100c5a..56e6ab928f 100644 --- a/src/pre_process/p_main.f90 +++ b/src/pre_process/p_main.f90 @@ -12,7 +12,6 @@ program p_main implicit none - integer :: i logical :: file_exists real(wp) :: start, finish, time_avg, time_final real(wp), allocatable, dimension(:) :: proc_time diff --git a/src/simulation/m_boundary_conditions.fpp b/src/simulation/m_boundary_conditions.fpp index 0d6d22f8af..3707fec910 100644 --- a/src/simulation/m_boundary_conditions.fpp +++ b/src/simulation/m_boundary_conditions.fpp @@ -28,8 +28,6 @@ contains logical :: file_exist character(len=path_len) :: file_path - character(len=10) :: status - ! Read bc_types file_path = trim(step_dirpath)//'/bc_type.dat' inquire (FILE=trim(file_path), EXIST=file_exist) @@ -71,8 +69,6 @@ contains integer :: dir, loc character(len=path_len) :: file_loc, file_path - character(len=10) :: status - #ifdef MFC_MPI integer :: ierr integer :: file_id diff --git a/src/simulation/m_cbc.fpp b/src/simulation/m_cbc.fpp index f90d25ebcd..1723d4cd5d 100644 --- a/src/simulation/m_cbc.fpp +++ b/src/simulation/m_cbc.fpp @@ -655,7 +655,6 @@ contains real(wp), dimension(num_fluids) :: adv, dadv_ds real(wp), dimension(sys_size) :: L real(wp), dimension(3) :: lambda - real(wp), dimension(num_species) :: Y_s real(wp) :: rho !< Cell averaged density real(wp) :: pres !< Cell averaged pressure @@ -672,9 +671,7 @@ contains real(wp) :: vel_K_sum, vel_dv_dt_sum - integer :: i, j, k, r, q !< Generic loop iterators - - real(wp) :: blkmod1, blkmod2 !< Fluid bulk modulus for Wood mixture sound speed + integer :: i, j, k, r !< Generic loop iterators ! Reshaping of inputted data and association of the FD and PI ! coefficients, or CBC coefficients, respectively, hinging on diff --git a/src/simulation/m_data_output.fpp b/src/simulation/m_data_output.fpp index 56b21207ff..7255f68cea 100644 --- a/src/simulation/m_data_output.fpp +++ b/src/simulation/m_data_output.fpp @@ -994,7 +994,7 @@ contains integer, intent(in) :: t_step real(wp), dimension(num_fluids, 5), intent(in) :: c_mass - integer :: i, j !< Generic loop iterator + integer :: i !< Generic loop iterator real(wp) :: nondim_time !< Non-dimensional time ! Non-dimensional time calculation diff --git a/src/simulation/m_hypoelastic.fpp b/src/simulation/m_hypoelastic.fpp index 5a10800044..3913cc8313 100644 --- a/src/simulation/m_hypoelastic.fpp +++ b/src/simulation/m_hypoelastic.fpp @@ -39,7 +39,7 @@ contains subroutine s_initialize_hypoelastic_module - integer :: i, k, r + integer :: i @:ALLOCATE(Gs(1:num_fluids)) @:ALLOCATE(rho_K_field(0:m,0:n,0:p), G_K_field(0:m,0:n,0:p)) diff --git a/src/simulation/m_ibm.fpp b/src/simulation/m_ibm.fpp index 0c18d17327..70e184ac30 100644 --- a/src/simulation/m_ibm.fpp +++ b/src/simulation/m_ibm.fpp @@ -431,7 +431,7 @@ contains :: subsection_2D integer, dimension(2*gp_layers + 1, 2*gp_layers + 1, 2*gp_layers + 1) & :: subsection_3D - integer :: i, j, k, l, q !< Iterator variables + integer :: i, j, k!< Iterator variables num_gps = 0 num_inner_gps = 0 @@ -595,7 +595,7 @@ contains real(wp) :: buf real(wp), dimension(2, 2, 2) :: eta type(ghost_point) :: gp - integer :: i, j, k, l, q !< Iterator variables + integer :: i !< Iterator variables integer :: i1, i2, j1, j2, k1, k2 !< Grid indexes integer :: patch_id diff --git a/src/simulation/m_mhd.fpp b/src/simulation/m_mhd.fpp index 2a188fc332..49b1639391 100644 --- a/src/simulation/m_mhd.fpp +++ b/src/simulation/m_mhd.fpp @@ -35,8 +35,6 @@ contains subroutine s_initialize_mhd_powell_module - integer :: i, k, r - ! Additional safety check beyond m_checker if (n == 0) call s_mpi_abort('Fatal Error: Powell correction is not applicable for 1D') diff --git a/src/simulation/m_mpi_proxy.fpp b/src/simulation/m_mpi_proxy.fpp index ae6cf9c8c9..27e3beae49 100644 --- a/src/simulation/m_mpi_proxy.fpp +++ b/src/simulation/m_mpi_proxy.fpp @@ -591,8 +591,6 @@ contains integer, intent(in) :: mpi_dir integer, intent(in) :: pbc_loc - integer :: dst_proc(1:3) - #ifdef MFC_MPI ! MPI Communication in x-direction @@ -771,7 +769,7 @@ contains type(integer_field), intent(inout) :: ib_markers integer, intent(in) :: gp_layers - integer :: i, j, k, l, r !< Generic loop iterators + integer :: j, k, l, r !< Generic loop iterators integer, pointer, dimension(:) :: p_i_send, p_i_recv #ifdef MFC_MPI