-
Notifications
You must be signed in to change notification settings - Fork 121
Closed
Labels
continuous-integrationContinuous integration (CI)Continuous integration (CI)enhancementNew feature or requestNew feature or requestgood first issueGood for newcomersGood for newcomers
Description
Here's the current output of fortitude, which is in CI here: https://github.com/MFlowCode/MFC/actions/workflows/lint-source.yml
warning: ./src/common/m_checker_common.fpp:133:5: S061 end statement should read 'end subroutine s_check_inputs_adv_n'
|
131 | @:PROHIBIT(adv_n .and. num_fluids /= 1)
132 | @:PROHIBIT(adv_n .and. qbmm)
133 | end subroutine
| ^^^^^^^^^^^^^^ S061
134 |
135 | !> Checks constraints on the hypoelasticity parameters.
136 | !! Called by s_check_inputs_common for pre-processing and simulation
|
warning: ./src/common/m_compile_specific.f90:67:23: T042 character 'cwd' has assumed size but does not have intent(in)
|
66 | subroutine s_get_cwd(cwd)
67 | character(LEN=*), intent(out) :: cwd
| ^ T042
68 |
69 | call GETCWD(cwd)
|
warning: ./src/common/m_compile_specific.f90:74:23: T042 character 'basename' has assumed size but does not have intent(in)
|
72 | subroutine s_get_basename(dirpath, basename)
73 | character(LEN=), intent(in) :: dirpath
74 | character(LEN=), intent(out) :: basename
| ^ T042
75 |
76 | integer :: iUnit
|
warning: ./src/common/m_eigen_solver.f90:708:5: M001 subroutine not contained within (sub)module or program
|
706 | !! @param zi the imaginary part of the eigenvectors to be back
707 | !! transformed in their first ml columns
708 | subroutine cbabk2(nm, nl, low, igh, scale, ml, zr, zi)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
709 | integer, intent(in) :: nm, nl, low, igh
710 | double precision, intent(in) :: scale(nl)
|
warning: ./src/common/m_eigen_solver.f90:710:9: P011 prefer 'real(real64)' to 'double precision' (see 'iso_fortran_env')
|
708 | subroutine cbabk2(nm, nl, low, igh, scale, ml, zr, zi)
709 | integer, intent(in) :: nm, nl, low, igh
710 | double precision, intent(in) :: scale(nl)
| ^^^^^^^^^^^^^^^^ P011
711 | integer, intent(in) :: ml
712 | double precision, intent(inout) :: zr(nm, ml), zi(nm, ml)
|
warning: ./src/common/m_eigen_solver.f90:712:9: P011 prefer 'real(real64)' to 'double precision' (see 'iso_fortran_env')
|
710 | double precision, intent(in) :: scale(nl)
711 | integer, intent(in) :: ml
712 | double precision, intent(inout) :: zr(nm, ml), zi(nm, ml)
| ^^^^^^^^^^^^^^^^ P011
713 |
714 | integer :: i, j, k, ii
|
warning: ./src/common/m_eigen_solver.f90:715:9: P011 prefer 'real(real64)' to 'double precision' (see 'iso_fortran_env')
|
714 | integer :: i, j, k, ii
715 | double precision :: s
| ^^^^^^^^^^^^^^^^ P011
716 |
717 | if (ml == 0) go to 200
|
warning: ./src/common/m_eigen_solver.f90:754:5: M001 subroutine not contained within (sub)module or program
|
752 | end subroutine cbabk2
753 |
754 | subroutine csroot(xr, xi, yr, yi)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
755 | real(kind(0d0)), intent(in) :: xr, xi
756 | real(kind(0d0)), intent(out) :: yr, yi
|
warning: ./src/common/m_eigen_solver.f90:774:5: M001 subroutine not contained within (sub)module or program
|
772 | end subroutine csroot
773 |
774 | subroutine cdiv(ar, ai, br, bi, cr, ci)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
775 | real(kind(0d0)), intent(in) :: ar, ai, br, bi
776 | real(kind(0d0)), intent(out) :: cr, ci
|
warning: ./src/common/m_eigen_solver.f90:798:5: M001 subroutine not contained within (sub)module or program
|
796 | end subroutine cdiv
797 |
798 | subroutine pythag(a, b, c)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
799 | real(kind(0d0)), intent(in) :: a, b
800 | real(kind(0d0)), intent(out) :: c
|
warning: ./src/common/m_helper.fpp:81:9: P021 real has implicit kind
|
80 | real(kind(0d0)), dimension(:, :), intent(in) :: A
81 | real, optional, intent(in) :: div
| ^^^^ P021
82 |
83 | integer :: i, j
|
warning: ./src/common/m_helper.fpp:85:9: P021 real has implicit kind
|
83 | integer :: i, j
84 | integer :: m, n
85 | real :: c
| ^^^^ P021
86 |
87 | m = size(A, 1)
|
warning: ./src/common/m_helper.fpp:106:5: S061 end statement should read 'end subroutine s_print_2D_array'
|
104 | write (*, fmt="(A1)") " "
105 |
106 | end subroutine
| ^^^^^^^^^^^^^^ S061
107 |
108 | !> Initializes non-polydisperse bubble modeling
109 | subroutine s_initialize_nonpoly
|
warning: ./src/common/m_helper.fpp:232:9: P021 complex has implicit kind
|
230 | real(kind(0.d0)), intent(out) :: Re_trans, Im_trans
231 |
232 | complex :: trans, c1, c2, c3
| ^^^^^^^ P021
233 | complex :: imag = (0., 1.)
234 | real(kind(0.d0)) :: f_transcoeff
|
warning: ./src/common/m_helper.fpp:233:9: P021 complex has implicit kind
|
232 | complex :: trans, c1, c2, c3
233 | complex :: imag = (0., 1.)
| ^^^^^^^ P021
234 | real(kind(0.d0)) :: f_transcoeff
|
warning: ./src/common/m_helper.fpp:233:20: T051 'imag' is initialised in its declaration and has no explicit save or parameter attribute
|
232 | complex :: trans, c1, c2, c3
233 | complex :: imag = (0., 1.)
| ^^^^^^^^^^^^^^^ T051
234 | real(kind(0.d0)) :: f_transcoeff
|
warning: ./src/common/m_helper.fpp:233:28: P001 real literal 0. missing kind suffix
|
232 | complex :: trans, c1, c2, c3
233 | complex :: imag = (0., 1.)
| ^^ P001
234 | real(kind(0.d0)) :: f_transcoeff
|
warning: ./src/common/m_helper.fpp:233:32: P001 real literal 1. missing kind suffix
|
232 | complex :: trans, c1, c2, c3
233 | complex :: imag = (0., 1.)
| ^^ P001
234 | real(kind(0.d0)) :: f_transcoeff
|
warning: ./src/common/m_helper.fpp:249:23: T042 character 'res' has assumed size but does not have intent(in)
|
248 | integer, intent(in) :: i
249 | character(len=*), intent(out) :: res
| ^ T042
250 |
251 | write (res, '(I0)') i
|
warning: ./src/common/m_helper.fpp:253:5: S061 end statement should read 'end subroutine s_int_to_str'
|
251 | write (res, '(I0)') i
252 | res = trim(res)
253 | end subroutine
| ^^^^^^^^^^^^^^ S061
254 |
255 | !> Computes the Simpson weights for quadrature
256 | subroutine s_simpson
|
warning: ./src/common/m_phase_change.fpp:39:38: P001 real literal 1e8 missing kind suffix
|
37 | !> @name Parameters for the first order transition phase change
38 | !> @{
39 | integer, parameter :: max_iter = 1e8 !< max # of iterations
| ^^^ P001
40 | real(kind(0d0)), parameter :: pCr = 4.94d7 !< Critical water pressure
41 | real(kind(0d0)), parameter :: TCr = 385.05 + 273.15 !< Critical water temperature
|
warning: ./src/common/m_phase_change.fpp:41:41: P001 real literal 385.05 missing kind suffix
|
39 | integer, parameter :: max_iter = 1e8 !< max # of iterations
40 | real(kind(0d0)), parameter :: pCr = 4.94d7 !< Critical water pressure
41 | real(kind(0d0)), parameter :: TCr = 385.05 + 273.15 !< Critical water temperature
| ^^^^^^ P001
42 | real(kind(0d0)), parameter :: mixM = 1.0d-8 !< threshold for 'mixture cell'. If Y < mixM, phase change does not happen
43 | integer, parameter :: lp = 1 !< index for the liquid phase of the reacting fluid
|
warning: ./src/common/m_phase_change.fpp:41:50: P001 real literal 273.15 missing kind suffix
|
39 | integer, parameter :: max_iter = 1e8 !< max # of iterations
40 | real(kind(0d0)), parameter :: pCr = 4.94d7 !< Critical water pressure
41 | real(kind(0d0)), parameter :: TCr = 385.05 + 273.15 !< Critical water temperature
| ^^^^^^ P001
42 | real(kind(0d0)), parameter :: mixM = 1.0d-8 !< threshold for 'mixture cell'. If Y < mixM, phase change does not happen
43 | integer, parameter :: lp = 1 !< index for the liquid phase of the reacting fluid
|
warning: ./src/common/m_phase_change.fpp:356:87: P001 real literal 1e4 missing kind suffix
|
354 | ns = 0
355 | ! change this relative error metric. 1E4 is just arbitrary
356 | do while ((DABS(pS - pO) > palpha_eps) .and. (DABS((pS - pO)/pO) > palpha_eps/1e4) .or. (ns == 0))
| ^^^ P001
357 |
358 | ! increasing counter
|
warning: ./src/common/m_phase_change.fpp:807:5: S061 end statement should read 'end subroutine s_finalize_relaxation_solver_module'
|
805 | !> This subroutine finalizes the phase change module
806 | subroutine s_finalize_relaxation_solver_module
807 | end subroutine
| ^^^^^^^^^^^^^^ S061
808 |
809 | #endif
|
warning: ./src/common/m_variables_conversion.fpp:762:99: P001 real literal 0.5 missing kind suffix
|
760 | do i = 1, nb
761 | mu = qK_cons_vf(bubxb + 1 + (i - 1)*nmom)%sf(j, k, l)/nbub_sc
762 | sig = (qK_cons_vf(bubxb + 3 + (i - 1)nmom)%sf(j, k, l)/nbub_sc - mu**2)**0.5
| ^^^ P001
763 |
764 | mv(j, k, l, 1, i) = (mass_v0(i))(mu - sig)(3d0)/(R0(i)(3d0))
|
warning: ./src/common/m_variables_conversion.fpp:794:99: P001 real literal 0.5 missing kind suffix
|
792 | do i = 1, nb
793 | mu = qK_cons_vf(bubxb + 1 + (i - 1)*nmom)%sf(j, k, l)/nbub_sc
794 | sig = (qK_cons_vf(bubxb + 3 + (i - 1)*nmom)%sf(j, k, l)/nbub_sc - mu**2)**0.5
| ^^^ P001
795 |
796 | !PRESTON (ISOTHERMAL)
|
warning: ./src/common/m_variables_conversion.fpp:1069:28: T051 'G' is initialised in its declaration and has no explicit save or parameter attribute
|
1067 | real(kind(0d0)) :: nbub, R3, vftmp, R3tmp
1068 | real(kind(0d0)), dimension(nb) :: Rtmp
1069 | real(kind(0d0)) :: G = 0d0
| ^^^^^^^ T051
1070 | real(kind(0d0)), dimension(2) :: Re_K
|
warning: ./src/common/m_variables_conversion.fpp:1138:60: P001 real literal 0. missing kind suffix
|
1136 | else
1137 | !Tait EOS, no conserved energy variable
1138 | q_cons_vf(E_idx)%sf(j, k, l) = 0.
| ^^ P001
1139 | end if
1140 | end if
|
warning: ./src/post_process/m_data_input.f90:40:9: T002 interface subroutine missing 'implicit none'
|
38 | !> Subroutine for reading data files
39 | !! @param t_step Current time-step to input
40 | subroutine s_read_abstract_data_files(t_step)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
41 |
42 | integer, intent(in) :: t_step
|
warning: ./src/post_process/m_data_output.fpp:48:15: P001 real literal 0.0 missing kind suffix
|
46 | real(kind(0d0)), allocatable, dimension(:, :, :) :: cyl_q_sf
47 | ! Single precision storage for flow variables
48 | real(kind(0.0)), allocatable, dimension(:, :, :), public :: q_sf_s
| ^^^ P001
49 | real(kind(0.0)), allocatable, dimension(:, :, :) :: q_root_sf_s
50 | real(kind(0.0)), allocatable, dimension(:, :, :) :: cyl_q_sf_s
|
warning: ./src/post_process/m_data_output.fpp:49:15: P001 real literal 0.0 missing kind suffix
|
47 | ! Single precision storage for flow variables
48 | real(kind(0.0)), allocatable, dimension(:, :, :), public :: q_sf_s
49 | real(kind(0.0)), allocatable, dimension(:, :, :) :: q_root_sf_s
| ^^^ P001
50 | real(kind(0.0)), allocatable, dimension(:, :, :) :: cyl_q_sf_s
|
warning: ./src/post_process/m_data_output.fpp:50:15: P001 real literal 0.0 missing kind suffix
|
48 | real(kind(0.0)), allocatable, dimension(:, :, :), public :: q_sf_s
49 | real(kind(0.0)), allocatable, dimension(:, :, :) :: q_root_sf_s
50 | real(kind(0.0)), allocatable, dimension(:, :, :) :: cyl_q_sf_s
| ^^^ P001
51 |
52 | ! The spatial and data extents array variables contain information about the
|
warning: ./src/post_process/m_data_output.fpp:684:52: P001 real literal 0.0 missing kind suffix
|
682 | if (p > 0) then
683 | if (precision == 1) then
684 | write (dbfile) real(x_cb, kind(0.0)), &
| ^^^ P001
685 | real(y_cb, kind(0.0)), &
686 | real(z_cb, kind(0.0))
|
warning: ./src/post_process/m_data_output.fpp:685:41: P001 real literal 0.0 missing kind suffix
|
683 | if (precision == 1) then
684 | write (dbfile) real(x_cb, kind(0.0)), &
685 | real(y_cb, kind(0.0)), &
| ^^^ P001
686 | real(z_cb, kind(0.0))
687 | else
|
warning: ./src/post_process/m_data_output.fpp:686:41: P001 real literal 0.0 missing kind suffix
|
684 | write (dbfile) real(x_cb, kind(0.0)), &
685 | real(y_cb, kind(0.0)), &
686 | real(z_cb, kind(0.0))
| ^^^ P001
687 | else
688 | write (dbfile) x_cb, y_cb, z_cb
|
warning: ./src/post_process/m_data_output.fpp:693:52: P001 real literal 0.0 missing kind suffix
|
691 | elseif (n > 0) then
692 | if (precision == 1) then
693 | write (dbfile) real(x_cb, kind(0.0)), &
| ^^^ P001
694 | real(y_cb, kind(0.0))
695 | else
|
warning: ./src/post_process/m_data_output.fpp:694:41: P001 real literal 0.0 missing kind suffix
|
692 | if (precision == 1) then
693 | write (dbfile) real(x_cb, kind(0.0)), &
694 | real(y_cb, kind(0.0))
| ^^^ P001
695 | else
696 | write (dbfile) x_cb, y_cb
|
warning: ./src/post_process/m_data_output.fpp:705:52: P001 real literal 0.0 missing kind suffix
|
704 | if (precision == 1) then
705 | write (dbfile) real(x_cb, kind(0.0))
| ^^^ P001
706 | else
707 | write (dbfile) x_cb
|
warning: ./src/post_process/m_data_output.fpp:718:61: P001 real literal 0.0 missing kind suffix
|
716 | if (proc_rank == 0) then
717 | if (precision == 1) then
718 | write (dbroot) real(x_root_cb, kind(0.0))
| ^^^ P001
719 | else
720 | write (dbroot) x_root_cb
|
warning: ./src/post_process/m_data_output.fpp:909:57: P001 real literal 0.0 missing kind suffix
|
907 | ! with the local processor, to the formatted database slave file
908 | if (precision == 1) then
909 | write (dbfile) varname, real(q_sf, kind(0.0))
| ^^^ P001
910 | else
911 | write (dbfile) varname, q_sf
|
warning: ./src/post_process/m_data_output.fpp:927:70: P001 real literal 0.0 missing kind suffix
|
925 | if (proc_rank == 0) then
926 | if (precision == 1) then
927 | write (dbroot) varname, real(q_root_sf, kind(0.0))
| ^^^ P001
928 | else
929 | write (dbroot) varname, q_root_sf
|
warning: ./src/post_process/m_derived_variables.fpp:549:25: P001 real literal 0.5 missing kind suffix
|
548 | ! Compute Q
549 | Q = 0.5*((O2(1, 1) + O2(2, 2) + O2(3, 3)) - &
| ^^^ P001
550 | (S2(1, 1) + S2(2, 2) + S2(3, 3)))
551 | trS = S(1, 1) + S(2, 2) + S(3, 3)
|
warning: ./src/post_process/m_derived_variables.fpp:552:27: P001 real literal 0.5 missing kind suffix
|
550 | (S2(1, 1) + S2(2, 2) + S2(3, 3)))
551 | trS = S(1, 1) + S(2, 2) + S(3, 3)
552 | IIS = 0.5*((S(1, 1) + S(2, 2) + S(3, 3))**2 - &
| ^^^ P001
553 | (S2(1, 1) + S2(2, 2) + S2(3, 3)))
554 | q_sf(j, k, l) = Q + IIS
|
warning: ./src/post_process/m_global_parameters.fpp:44:13: T011 integer kind set with number literal '8', use 'iso_fortran_env' parameter
|
42 | !> @}
43 |
44 | integer(8) :: nGlobal ! Total number of cells in global domain
| ^ T011
45 |
46 | !> @name Cylindrical coordinates (either axisymmetric or full 3D)
|
warning: ./src/post_process/m_global_parameters.fpp:62:15: P001 real literal 0.0 missing kind suffix
|
60 | !> @{
61 | real(kind(0d0)), allocatable, dimension(:) :: x_cb, x_root_cb, y_cb, z_cb
62 | real(kind(0.0)), allocatable, dimension(:) :: x_cb_s, y_cb_s, z_cb_s
| ^^^ P001
63 | !> @}
|
warning: ./src/pre_process/m_assign_variables.fpp:49:9: T002 interface subroutine missing 'implicit none'
|
47 | !! @param q_prim_vf Primitive variables
48 | !! @param patch_id_fp Array to track patch ids
49 | subroutine s_assign_patch_xxxxx_primitive_variables(patch_id, j, k, l, &
| ^
50 | | eta, q_prim_vf, patch_id_fp)
| |_______________________________________________________________________________^ T002
51 |
52 | import :: scalar_field, sys_size, n, m, p
|
warning: ./src/pre_process/m_assign_variables.fpp:228:44: P001 real literal 0.5 missing kind suffix
|
227 | if (j < 177) then
228 | q_prim_vf(E_idx)%sf(j, k, l) = 0.5*q_prim_vf(E_idx)%sf(j, k, l)
| ^^^ P001
229 | end if
|
warning: ./src/pre_process/m_assign_variables.fpp:685:1: S061 end statement should read 'end module m_assign_variables'
|
683 | end subroutine s_finalize_assign_variables_module
684 |
685 | end module
| ^^^^^^^^^^ S061
|
warning: ./src/pre_process/m_compute_levelset.fpp:267:20: T031 subroutine argument 'ib_patch_id' missing 'intent' attribute
|
265 | type(levelset_norm_field), intent(INOUT) :: levelset_norm
266 |
267 | integer :: ib_patch_id
| ^^^^^^^^^^^ T031
268 | real(kind(0d0)) :: top_right(2), bottom_left(2)
269 | real(kind(0d0)) :: x, y, min_dist
|
warning: ./src/pre_process/m_compute_levelset.fpp:407:41: P001 real literal 0.5 missing kind suffix
|
406 | if (length_x /= 0d0) then
407 | boundary%beg = x_centroid - 0.5length_x
| ^^^ P001
408 | boundary%end = x_centroid + 0.5length_x
409 | dist_sides_vec = (/1, 0, 0/)
|
warning: ./src/pre_process/m_compute_levelset.fpp:408:41: P001 real literal 0.5 missing kind suffix
|
406 | if (length_x /= 0d0) then
407 | boundary%beg = x_centroid - 0.5length_x
408 | boundary%end = x_centroid + 0.5length_x
| ^^^ P001
409 | dist_sides_vec = (/1, 0, 0/)
410 | dist_surface_vec = (/0, 1, 1/)
|
warning: ./src/pre_process/m_compute_levelset.fpp:412:41: P001 real literal 0.5 missing kind suffix
|
410 | dist_surface_vec = (/0, 1, 1/)
411 | else if (length_y /= 0d0) then
412 | boundary%beg = y_centroid - 0.5length_y
| ^^^ P001
413 | boundary%end = y_centroid + 0.5length_y
414 | dist_sides_vec = (/0, 1, 0/)
|
warning: ./src/pre_process/m_compute_levelset.fpp:413:41: P001 real literal 0.5 missing kind suffix
|
411 | else if (length_y /= 0d0) then
412 | boundary%beg = y_centroid - 0.5length_y
413 | boundary%end = y_centroid + 0.5length_y
| ^^^ P001
414 | dist_sides_vec = (/0, 1, 0/)
415 | dist_surface_vec = (/1, 0, 1/)
|
warning: ./src/pre_process/m_compute_levelset.fpp:417:41: P001 real literal 0.5 missing kind suffix
|
415 | dist_surface_vec = (/1, 0, 1/)
416 | else if (length_z /= 0d0) then
417 | boundary%beg = z_centroid - 0.5length_z
| ^^^ P001
418 | boundary%end = z_centroid + 0.5length_z
419 | dist_sides_vec = (/0, 0, 1/)
|
warning: ./src/pre_process/m_compute_levelset.fpp:418:41: P001 real literal 0.5 missing kind suffix
|
416 | else if (length_z /= 0d0) then
417 | boundary%beg = z_centroid - 0.5length_z
418 | boundary%end = z_centroid + 0.5length_z
| ^^^ P001
419 | dist_sides_vec = (/0, 0, 1/)
420 | dist_surface_vec = (/1, 1, 0/)
|
warning: ./src/pre_process/m_data_output.fpp:53:9: T002 interface subroutine missing 'implicit none'
|
51 | !! @param levelset closest distance from every cell to the IB
52 | !! @param levelset_norm normalized vector from every cell to the closest point to the IB
53 | subroutine s_write_abstract_data_files(q_cons_vf, ib_markers, levelset, levelset_norm)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
54 |
55 | import :: scalar_field, integer_field, sys_size, m, n, p, &
|
warning: ./src/pre_process/m_data_output.fpp:840:43: T051 'coord' is initialised in its declaration and has no explicit save or parameter attribute
|
838 | character(LEN=len_trim(case_dir) + 2*name_len) :: file_loc
839 | character(len=15) :: temp
840 | character(LEN=1), dimension(3) :: coord = (/'x', 'y', 'z'/)
| ^^^^^^^^^^^^^^^^^^^^^^^^^ T051
841 |
842 | ! Generic logical used to check the existence of directories
|
warning: ./src/pre_process/m_global_parameters.fpp:47:13: T011 integer kind set with number literal '8', use 'iso_fortran_env' parameter
|
45 | integer :: p
46 |
47 | integer(8) :: nGlobal !< Global number of cells in the domain
| ^ T011
48 |
49 | integer :: m_glb, n_glb, p_glb !< Global number of cells in each direction
|
warning: ./src/pre_process/m_grid.f90:40:9: T002 interface subroutine missing 'implicit none'
|
38 | abstract interface ! ===================================================
39 |
40 | subroutine s_generate_abstract_grid
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
41 |
42 | ! integer, intent(IN), optional :: dummy
|
warning: ./src/pre_process/m_model.fpp:186:5: S061 end statement should read 'end subroutine s_read_stl'
|
184 | end if
185 |
186 | end subroutine
| ^^^^^^^^^^^^^^ S061
187 |
188 | !> This procedure reads an OBJ file.
189 | !! @param filepath Path to the odj file.
|
warning: ./src/pre_process/m_model.fpp:262:5: S061 end statement should read 'end subroutine s_read_obj'
|
260 | close (iunit)
261 |
262 | end subroutine
| ^^^^^^^^^^^^^^ S061
263 |
264 | !> This procedure reads a mesh from a file.
265 | !! @param filepath Path to the file to read.
|
warning: ./src/pre_process/m_model.fpp:466:62: P001 real literal 0.5 missing kind suffix
|
464 | do i = 1, spc
465 | call random_number(ray_origins(i, :))
466 | ray_origins(i, :) = point + (ray_origins(i, :) - 0.5)*spacing(:)
| ^^^ P001
467 |
468 | call random_number(ray_dirs(i, :))
|
warning: ./src/pre_process/m_model.fpp:469:47: P001 real literal 0.5 missing kind suffix
|
468 | call random_number(ray_dirs(i, :))
469 | ray_dirs(i, :) = ray_dirs(i, :) - 0.5
| ^^^ P001
470 | ray_dirs(i, :) = ray_dirs(i, :)/sqrt(sum(ray_dirs(i, :)*ray_dirs(i, :)))
471 | end do
|
warning: ./src/pre_process/m_model.fpp:514:37: P001 real literal 0.0000001 missing kind suffix
|
512 | NdotRayDirection = sum(N(:)*ray%d(:))
513 |
514 | if (abs(NdotRayDirection) < 0.0000001) then
| ^^^^^^^^^ P001
515 | return
516 | end if
|
warning: ./src/pre_process/m_patches.fpp:348:28: P001 real literal 0.2969 missing kind suffix
|
346 | end if
347 |
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:348:47: P001 real literal 0.126 missing kind suffix
|
346 | end if
347 |
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^ P001
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:348:58: P001 real literal 0.3516 missing kind suffix
|
346 | end if
347 |
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:348:75: P001 real literal 0.2843 missing kind suffix
|
346 | end if
347 |
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:348:90: P001 real literal 0.1015 missing kind suffix
|
346 | end if
347 |
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:349:45: P001 real literal 0.5 missing kind suffix
|
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
| ^^^ P001
350 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:350:40: P001 real literal 0.5 missing kind suffix
|
348 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
349 | sin_c = dycdxc/(1 + dycdxc**2)0.5
350 | cos_c = 1/(1 + dycdxc2)**0.5
| ^^^ P001
351 |
352 | xu = xa - yt*sin_c
|
warning: ./src/pre_process/m_patches.fpp:515:28: P001 real literal 0.2969 missing kind suffix
|
513 | end if
514 |
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:515:47: P001 real literal 0.126 missing kind suffix
|
513 | end if
514 |
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^ P001
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:515:58: P001 real literal 0.3516 missing kind suffix
|
513 | end if
514 |
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:515:75: P001 real literal 0.2843 missing kind suffix
|
513 | end if
514 |
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:515:90: P001 real literal 0.1015 missing kind suffix
|
513 | end if
514 |
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
| ^^^^^^ P001
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:516:45: P001 real literal 0.5 missing kind suffix
|
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
| ^^^ P001
517 | cos_c = 1/(1 + dycdxc2)**0.5
|
warning: ./src/pre_process/m_patches.fpp:517:40: P001 real literal 0.5 missing kind suffix
|
515 | yt = (5d0ta)(0.2969xa**0.5d0 - 0.126xa - 0.3516xa**2d0 + 0.2843xa3 - 0.1015*xa4)
516 | sin_c = dycdxc/(1 + dycdxc**2)0.5
517 | cos_c = 1/(1 + dycdxc2)**0.5
| ^^^ P001
518 |
519 | xu = xa - yt*sin_c
|
warning: ./src/pre_process/m_patches.fpp:1303:14: P001 real literal 0.1 missing kind suffix
|
1301 | eta = 1d0
1302 | l = 1d0
1303 | U0 = 0.1
| ^^^ P001
1304 | ! Checking whether the patch covers a particular cell in the
1305 | ! domain and verifying whether the current patch has the
|
warning: ./src/pre_process/m_patches.fpp:1428:31: T051 'cmplx_i' is initialised in its declaration and has no explicit save or parameter attribute
|
1426 | integer :: i, j, k !< generic loop iterators
1427 | real(kind(0d0)) :: radius, epsilon, beta
1428 | complex(kind(0d0)) :: cmplx_i = (0d0, 1d0)
| ^^^^^^^^^^^^^^^^^^^^ T051
1429 | complex(kind(0d0)) :: H
|
warning: ./src/pre_process/m_perturbation.fpp:131:38: P001 real literal 4.0 missing kind suffix
|
130 | ! Compute 2D waves
131 | call s_instability_wave(2pi4.0/Ldomain, 0d0, wave_tmp, 0d0)
| ^^^ P001
132 | wave1 = wave1 + wave_tmp
133 | call s_instability_wave(2pi2.0/Ldomain, 0d0, wave_tmp, 0d0)
|
warning: ./src/pre_process/m_perturbation.fpp:133:38: P001 real literal 2.0 missing kind suffix
|
131 | call s_instability_wave(2pi4.0/Ldomain, 0d0, wave_tmp, 0d0)
132 | wave1 = wave1 + wave_tmp
133 | call s_instability_wave(2pi2.0/Ldomain, 0d0, wave_tmp, 0d0)
| ^^^ P001
134 | wave1 = wave1 + wave_tmp
135 | call s_instability_wave(2pi1.0/Ldomain, 0d0, wave_tmp, 0d0)
|
warning: ./src/pre_process/m_perturbation.fpp:135:38: P001 real literal 1.0 missing kind suffix
|
133 | call s_instability_wave(2pi2.0/Ldomain, 0d0, wave_tmp, 0d0)
134 | wave1 = wave1 + wave_tmp
135 | call s_instability_wave(2pi1.0/Ldomain, 0d0, wave_tmp, 0d0)
| ^^^ P001
136 | wave1 = wave1 + wave_tmp
137 | wave = wave1*0.05
|
warning: ./src/pre_process/m_perturbation.fpp:137:22: P001 real literal 0.05 missing kind suffix
|
135 | call s_instability_wave(2pi1.0/Ldomain, 0d0, wave_tmp, 0d0)
136 | wave1 = wave1 + wave_tmp
137 | wave = wave1*0.05
| ^^^^ P001
138 |
139 | if (p > 0) then
|
warning: ./src/pre_process/m_perturbation.fpp:141:42: P001 real literal 4.0 missing kind suffix
|
139 | if (p > 0) then
140 | ! Compute 3D waves with phase shifts.
141 | call s_instability_wave(2pi4.0/Ldomain, 2pi4.0/Ldomain, wave_tmp, 2pi11d0/31d0)
| ^^^ P001
142 | wave2 = wave2 + wave_tmp
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:141:60: P001 real literal 4.0 missing kind suffix
|
139 | if (p > 0) then
140 | ! Compute 3D waves with phase shifts.
141 | call s_instability_wave(2pi4.0/Ldomain, 2pi4.0/Ldomain, wave_tmp, 2pi11d0/31d0)
| ^^^ P001
142 | wave2 = wave2 + wave_tmp
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:143:42: P001 real literal 2.0 missing kind suffix
|
141 | call s_instability_wave(2pi4.0/Ldomain, 2pi4.0/Ldomain, wave_tmp, 2pi11d0/31d0)
142 | wave2 = wave2 + wave_tmp
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
| ^^^ P001
144 | wave2 = wave2 + wave_tmp
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:143:60: P001 real literal 2.0 missing kind suffix
|
141 | call s_instability_wave(2pi4.0/Ldomain, 2pi4.0/Ldomain, wave_tmp, 2pi11d0/31d0)
142 | wave2 = wave2 + wave_tmp
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
| ^^^ P001
144 | wave2 = wave2 + wave_tmp
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:145:42: P001 real literal 1.0 missing kind suffix
|
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
144 | wave2 = wave2 + wave_tmp
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
| ^^^ P001
146 | wave2 = wave2 + wave_tmp
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:145:60: P001 real literal 1.0 missing kind suffix
|
143 | call s_instability_wave(2pi2.0/Ldomain, 2pi2.0/Ldomain, wave_tmp, 2pi13d0/31d0)
144 | wave2 = wave2 + wave_tmp
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
| ^^^ P001
146 | wave2 = wave2 + wave_tmp
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:147:42: P001 real literal 4.0 missing kind suffix
|
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
146 | wave2 = wave2 + wave_tmp
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
| ^^^ P001
148 | wave2 = wave2 + wave_tmp
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:147:61: P001 real literal 4.0 missing kind suffix
|
145 | call s_instability_wave(2pi1.0/Ldomain, 2pi1.0/Ldomain, wave_tmp, 2pi17d0/31d0)
146 | wave2 = wave2 + wave_tmp
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
| ^^^ P001
148 | wave2 = wave2 + wave_tmp
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:149:42: P001 real literal 2.0 missing kind suffix
|
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
148 | wave2 = wave2 + wave_tmp
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
| ^^^ P001
150 | wave2 = wave2 + wave_tmp
151 | call s_instability_wave(2pi1.0/Ldomain, -2pi1.0/Ldomain, wave_tmp, 2pi29d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:149:61: P001 real literal 2.0 missing kind suffix
|
147 | call s_instability_wave(2pi4.0/Ldomain, -2pi4.0/Ldomain, wave_tmp, 2pi19d0/31d0)
148 | wave2 = wave2 + wave_tmp
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
| ^^^ P001
150 | wave2 = wave2 + wave_tmp
151 | call s_instability_wave(2pi1.0/Ldomain, -2pi1.0/Ldomain, wave_tmp, 2pi29d0/31d0)
|
warning: ./src/pre_process/m_perturbation.fpp:151:42: P001 real literal 1.0 missing kind suffix
|
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
150 | wave2 = wave2 + wave_tmp
151 | call s_instability_wave(2pi1.0/Ldomain, -2pi1.0/Ldomain, wave_tmp, 2pi29d0/31d0)
| ^^^ P001
152 | wave2 = wave2 + wave_tmp
153 | wave = wave + 0.15*wave2
|
warning: ./src/pre_process/m_perturbation.fpp:151:61: P001 real literal 1.0 missing kind suffix
|
149 | call s_instability_wave(2pi2.0/Ldomain, -2pi2.0/Ldomain, wave_tmp, 2pi23d0/31d0)
150 | wave2 = wave2 + wave_tmp
151 | call s_instability_wave(2pi1.0/Ldomain, -2pi1.0/Ldomain, wave_tmp, 2pi29d0/31d0)
| ^^^ P001
152 | wave2 = wave2 + wave_tmp
153 | wave = wave + 0.15*wave2
|
warning: ./src/pre_process/m_perturbation.fpp:153:27: P001 real literal 0.15 missing kind suffix
|
151 | call s_instability_wave(2pi1.0/Ldomain, -2pi1.0/Ldomain, wave_tmp, 2pi29d0/31d0)
152 | wave2 = wave2 + wave_tmp
153 | wave = wave + 0.15*wave2
| ^^^^ P001
154 | end if
|
warning: ./src/pre_process/m_perturbation.fpp:229:28: T031 subroutine argument 'shift' missing 'intent' attribute
|
227 | real(kind(0d0)), intent(in) :: alpha, beta !< spatial wavenumbers
228 | real(kind(0d0)), dimension(mixlayer_nvar, 0:m, 0:n, 0:p), intent(inout) :: wave !< instability wave
229 | real(kind(0d0)) :: shift !< phase shift
| ^^^^^ T031
230 | real(kind(0d0)), dimension(0:nbp - 1) :: u_mean !< mean density and velocity profiles
231 | real(kind(0d0)) :: rho_mean, p_mean !< mean density and pressure
|
warning: ./src/pre_process/m_start_up.fpp:75:9: T002 interface subroutine missing 'implicit none'
|
73 | abstract interface ! ===================================================
74 |
75 | subroutine s_read_abstract_grid_data_files
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
76 |
77 | end subroutine s_read_abstract_grid_data_files
|
warning: ./src/pre_process/m_start_up.fpp:81:9: T002 interface subroutine missing 'implicit none'
|
79 | !! @param q_cons_vf Conservative variables
80 | !! @param ib_markers track if a cell is within the immersed boundary
81 | subroutine s_read_abstract_ic_data_files(q_cons_vf, ib_markers)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
82 |
83 | import :: scalar_field, integer_field, sys_size, pres_field
|
warning: ./src/simulation/m_acoustic_src.fpp:332:5: S061 end statement should read 'end subroutine s_acoustic_src_calculations'
|
330 | end do
331 | end do
332 | end subroutine
| ^^^^^^^^^^^^^^ S061
333 |
334 | !> This subroutine gives the temporally varying amplitude of the pulse
335 | !! @param sim_time Simulation time
|
warning: ./src/simulation/m_acoustic_src.fpp:490:5: S061 end statement should read 'end subroutine s_precalculate_acoustic_spatial_sources'
|
488 | #endif
489 |
490 | end subroutine
| ^^^^^^^^^^^^^^ S061
491 |
492 | !> This subroutine gives the spatial support of the acoustic source
493 | !! @param j x-index
|
warning: ./src/simulation/m_boundary_conditions.fpp:1355:5: S061 end statement should read 'end subroutine s_qbmm_extrapolation'
|
1353 | end if
1354 |
1355 | end subroutine
| ^^^^^^^^^^^^^^ S061
1356 |
1357 | subroutine s_populate_capillary_buffers(c_divs)
|
warning: ./src/simulation/m_chemistry.fpp:48:5: M001 subroutine not contained within (sub)module or program
|
46 | end subroutine s_initialize_chemistry_module
47 |
48 | subroutine s_finalize_chemistry_module
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
49 |
50 | deallocate (grads(1)%sf, grads(2)%sf, grads(3)%sf)
|
warning: ./src/simulation/m_chemistry.fpp:54:5: M001 subroutine not contained within (sub)module or program
|
52 | end subroutine s_finalize_chemistry_module
53 |
54 | subroutine s_compute_chemistry_advection_flux(flux_n, rhs_vf)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
55 |
56 | type(vector_field), dimension(:), intent(IN) :: flux_n
|
warning: ./src/simulation/m_chemistry.fpp:101:5: M001 subroutine not contained within (sub)module or program
|
99 | end subroutine s_compute_chemistry_advection_flux
100 |
101 | subroutine s_compute_chemistry_reaction_flux(rhs_vf, q_cons_qp, q_prim_qp)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
102 |
103 | type(scalar_field), dimension(sys_size), intent(INOUT) :: rhs_vf, q_cons_qp, q_prim_qp
|
warning: ./src/simulation/m_data_output.fpp:104:36: T051 'file_name' is initialised in its declaration and has no explicit save or parameter attribute
|
102 | subroutine s_open_run_time_information_file
103 |
104 | character(LEN=name_len) :: file_name = 'run_time.inf' !<
| ^^^^^^^^^^^^^^^^^^^^^^^^^^ T051
105 | !! Name of the run-time information file
|
warning: ./src/simulation/m_fftw.fpp:328:1: S061 end statement should read 'end module m_fftw'
|
326 | end subroutine s_finalize_fftw_module
327 |
328 | end module
| ^^^^^^^^^^ S061
|
warning: ./src/simulation/m_mpi_proxy.fpp:1296:5: M001 subroutine not contained within (sub)module or program
|
1294 | !! the cell-average conservative variables by communicating
1295 | !! with the neighboring processors.
1296 | subroutine s_mpi_sendrecv_ib_buffers(ib_markers, gp_layers)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
1297 |
1298 | type(integer_field), intent(inout) :: ib_markers
|
warning: ./src/simulation/m_mpi_proxy.fpp:2142:5: M001 subroutine not contained within (sub)module or program
|
2140 | end subroutine s_mpi_sendrecv_ib_buffers
2141 |
2142 | subroutine s_mpi_sendrecv_capilary_variables_buffers(c_divs_vf, mpi_dir, pbc_loc)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
2143 |
2144 | type(scalar_field), dimension(num_dims + 1), intent(inout) :: c_divs_vf
|
warning: ./src/simulation/m_mpi_proxy.fpp:2353:5: M001 subroutine not contained within (sub)module or program
|
2351 | end subroutine s_mpi_sendrecv_capilary_variables_buffers
2352 |
2353 | subroutine s_mpi_send_random_number(phi_rn, num_freq)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
2354 | integer, intent(in) :: num_freq
2355 | real(kind(0d0)), intent(inout), dimension(1:num_freq) :: phi_rn
|
warning: ./src/simulation/m_mpi_proxy.fpp:2362:5: M001 subroutine not contained within (sub)module or program
|
2361 | !> Module deallocation and/or disassociation procedures
2362 | subroutine s_finalize_mpi_proxy_module
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
2363 |
2364 | #ifdef MFC_MPI
|
warning: ./src/simulation/m_nvtx.f90:26:5: S061 end statement should read 'end type nvtxEventAttributes'
|
24 | integer(c_int) :: messageType = 1 ! NVTX_MESSAGE_TYPE_ASCII = 1
25 | type(c_ptr) :: message ! ascii char
26 | end type
| ^^^^^^^^ S061
27 |
28 | #if defined(MFC_OpenACC) && defined(__PGI)
|
warning: ./src/simulation/m_nvtx.f90:32:9: T002 interface subroutine missing 'implicit none'
|
30 | interface nvtxRangePush
31 | ! push range with custom label and standard color
32 | subroutine nvtxRangePushA(name) bind(C, name='nvtxRangePushA')
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
33 | use iso_c_binding
|
warning: ./src/simulation/m_nvtx.f90:35:40: T042 character 'name' has assumed size but does not have intent(in)
|
33 | use iso_c_binding
34 |
35 | character(kind=c_char, len=*) :: name
| ^ T042
36 | end subroutine
|
warning: ./src/simulation/m_nvtx.f90:35:46: T031 subroutine argument 'name' missing 'intent' attribute
|
33 | use iso_c_binding
34 |
35 | character(kind=c_char, len=*) :: name
| ^^^^ T031
36 | end subroutine
|
warning: ./src/simulation/m_nvtx.f90:36:9: S061 end statement should read 'end subroutine nvtxRangePushA'
|
35 | character(kind=c_char, len=*) :: name
36 | end subroutine
| ^^^^^^^^^^^^^^ S061
37 |
38 | ! push range with custom label and custom color
39 | subroutine nvtxRangePushEx(event) bind(C, name='nvtxRangePushEx')
|
warning: ./src/simulation/m_nvtx.f90:39:9: T002 interface subroutine missing 'implicit none'
|
38 | ! push range with custom label and custom color
39 | subroutine nvtxRangePushEx(event) bind(C, name='nvtxRangePushEx')
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
40 | use iso_c_binding
|
warning: ./src/simulation/m_nvtx.f90:43:42: T031 subroutine argument 'event' missing 'intent' attribute
|
42 | import :: nvtxEventAttributes
43 | type(nvtxEventAttributes) :: event
| ^^^^^ T031
44 | end subroutine
45 | end interface
|
warning: ./src/simulation/m_nvtx.f90:44:9: S061 end statement should read 'end subroutine nvtxRangePushEx'
|
42 | import :: nvtxEventAttributes
43 | type(nvtxEventAttributes) :: event
44 | end subroutine
| ^^^^^^^^^^^^^^ S061
45 | end interface
46 |
47 | interface nvtxRangePop
|
warning: ./src/simulation/m_nvtx.f90:48:9: T002 interface subroutine missing 'implicit none'
|
47 | interface nvtxRangePop
48 | subroutine nvtxRangePop() bind(C, name='nvtxRangePop')
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T002
49 | end subroutine
50 | end interface
|
warning: ./src/simulation/m_nvtx.f90:49:9: S061 end statement should read 'end subroutine nvtxRangePop'
|
47 | interface nvtxRangePop
48 | subroutine nvtxRangePop() bind(C, name='nvtxRangePop')
49 | end subroutine
| ^^^^^^^^^^^^^^ S061
50 | end interface
51 |
52 | #endif
|
warning: ./src/simulation/m_nvtx.f90:57:36: T042 character 'name' has assumed size but does not have intent(in)
|
56 | subroutine nvtxStartRange(name, id)
57 | character(kind=c_char, len=*) :: name
| ^ T042
58 | integer, optional :: id
59 | type(nvtxEventAttributes) :: event
|
warning: ./src/simulation/m_nvtx.f90:57:42: T031 subroutine argument 'name' missing 'intent' attribute
|
56 | subroutine nvtxStartRange(name, id)
57 | character(kind=c_char, len=*) :: name
| ^^^^ T031
58 | integer, optional :: id
59 | type(nvtxEventAttributes) :: event
|
warning: ./src/simulation/m_nvtx.f90:58:30: T031 subroutine argument 'id' missing 'intent' attribute
|
56 | subroutine nvtxStartRange(name, id)
57 | character(kind=c_char, len=*) :: name
58 | integer, optional :: id
| ^^ T031
59 | type(nvtxEventAttributes) :: event
|
warning: ./src/simulation/m_nvtx.f90:74:5: S061 end statement should read 'end subroutine nvtxStartRange'
|
73 | #endif
74 | end subroutine
| ^^^^^^^^^^^^^^ S061
75 |
76 | subroutine nvtxEndRange
77 | #if defined(MFC_OpenACC) && defined(__PGI)
|
warning: ./src/simulation/m_nvtx.f90:80:5: S061 end statement should read 'end subroutine nvtxEndRange'
|
78 | call nvtxRangePop
79 | #endif
80 | end subroutine
| ^^^^^^^^^^^^^^ S061
81 |
82 | end module m_nvtx
|
warning: ./src/simulation/m_qbmm.fpp:682:5: S061 end statement should read 'end subroutine s_compute_qbmm_rhs'
|
680 | end if
681 |
682 | end subroutine
| ^^^^^^^^^^^^^^ S061
683 |
684 | !Coefficient array for non-polytropic model (pb and mv values are accounted in wght_pb and wght_mv)
|
warning: ./src/simulation/m_qbmm.fpp:830:66: T031 subroutine argument 'nbub_sc' missing 'intent' attribute
|
828 | real(kind(0d0)), dimension(startx:, starty:, startz:, 1:, 1:), intent(inout) :: mv, rhs_mv
829 | type(int_bounds_info), intent(in) :: ix, iy, iz
830 | real(kind(0d0)), dimension(startx:, starty:, startz:) :: nbub_sc !> Unused Variable not sure what to put as intent
| ^^^^^^^ T031
831 |
832 | real(kind(0d0)), dimension(nmom) :: moms, msum
|
warning: ./src/simulation/m_sim_helpers.f90:40:52: T031 subroutine argument 'q_prim_vf' missing 'intent' attribute
|
38 | #endif
39 |
40 | type(scalar_field), dimension(sys_size) :: q_prim_vf
| ^^^^^^^^^ T031
41 | real(kind(0d0)), dimension(num_fluids) :: alpha_rho
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
|
warning: ./src/simulation/m_sim_helpers.f90:42:51: T031 subroutine argument 'alpha' missing 'intent' attribute
|
40 | type(scalar_field), dimension(sys_size) :: q_prim_vf
41 | real(kind(0d0)), dimension(num_fluids) :: alpha_rho
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
| ^^^^^ T031
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
|
warning: ./src/simulation/m_sim_helpers.f90:43:49: T031 subroutine argument 'vel' missing 'intent' attribute
|
41 | real(kind(0d0)), dimension(num_fluids) :: alpha_rho
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
| ^^^ T031
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
45 | real(kind(0d0)), dimension(2) :: Re
|
warning: ./src/simulation/m_sim_helpers.f90:44:28: T031 subroutine argument 'rho' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^^^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:44:33: T031 subroutine argument 'gamma' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^^^^^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:44:40: T031 subroutine argument 'pi_inf' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^^^^^^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:44:52: T031 subroutine argument 'vel_sum' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^^^^^^^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:44:64: T031 subroutine argument 'H' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:44:67: T031 subroutine argument 'pres' missing 'intent' attribute
|
42 | real(kind(0d0)), dimension(num_fluids) :: alpha
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
| ^^^^ T031
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:45:42: T031 subroutine argument 'Re' missing 'intent' attribute
|
43 | real(kind(0d0)), dimension(num_dims) :: vel
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
45 | real(kind(0d0)), dimension(2) :: Re
| ^^ T031
46 | integer :: i, j, k, l
|
warning: ./src/simulation/m_sim_helpers.f90:46:23: T031 subroutine argument 'j' missing 'intent' attribute
|
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
| ^ T031
47 |
48 | do i = 1, num_fluids
|
warning: ./src/simulation/m_sim_helpers.f90:46:26: T031 subroutine argument 'k' missing 'intent' attribute
|
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
| ^ T031
47 |
48 | do i = 1, num_fluids
|
warning: ./src/simulation/m_sim_helpers.f90:46:29: T031 subroutine argument 'l' missing 'intent' attribute
|
44 | real(kind(0d0)) :: rho, gamma, pi_inf, qv, vel_sum, E, H, pres
45 | real(kind(0d0)), dimension(2) :: Re
46 | integer :: i, j, k, l
| ^ T031
47 |
48 | do i = 1, num_fluids
|
warning: ./src/simulation/m_sim_helpers.f90:88:49: T031 subroutine argument 'vel' missing 'intent' attribute
|
86 | subroutine s_compute_stability_from_dt(vel, c, rho, Re_l, j, k, l, icfl_sf, vcfl_sf, Rc_sf)
87 | !$acc routine seq
88 | real(kind(0d0)), dimension(num_dims) :: vel
| ^^^ T031
89 | real(kind(0d0)) :: c, rho
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
|
warning: ./src/simulation/m_sim_helpers.f90:89:28: T031 subroutine argument 'c' missing 'intent' attribute
|
87 | !$acc routine seq
88 | real(kind(0d0)), dimension(num_dims) :: vel
89 | real(kind(0d0)) :: c, rho
| ^ T031
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
91 | real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf
|
warning: ./src/simulation/m_sim_helpers.f90:89:31: T031 subroutine argument 'rho' missing 'intent' attribute
|
87 | !$acc routine seq
88 | real(kind(0d0)), dimension(num_dims) :: vel
89 | real(kind(0d0)) :: c, rho
| ^^^ T031
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
91 | real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf
|
warning: ./src/simulation/m_sim_helpers.f90:90:54: T031 subroutine argument 'icfl_sf' missing 'intent' attribute
|
88 | real(kind(0d0)), dimension(num_dims) :: vel
89 | real(kind(0d0)) :: c, rho
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
| ^^^^^^^ T031
91 | real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf
92 | real(kind(0d0)) :: fltr_dtheta !<
|
warning: ./src/simulation/m_sim_helpers.f90:91:64: T031 subroutine argument 'vcfl_sf' missing 'intent' attribute
|
89 | real(kind(0d0)) :: c, rho
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
91 | real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf
| ^^^^^^^ T031
92 | real(kind(0d0)) :: fltr_dtheta !<
93 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
|
warning: ./src/simulation/m_sim_helpers.f90:91:73: T031 subroutine argument 'Rc_sf' missing 'intent' attribute
|
89 | real(kind(0d0)) :: c, rho
90 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: icfl_sf
91 | real(kind(0d0)), dimension(0:m, 0:n, 0:p), optional :: vcfl_sf, Rc_sf
| ^^^^^ T031
92 | real(kind(0d0)) :: fltr_dtheta !<
93 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
|
warning: ./src/simulation/m_sim_helpers.f90:94:20: T031 subroutine argument 'j' missing 'intent' attribute
|
92 | real(kind(0d0)) :: fltr_dtheta !<
93 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
94 | integer :: j, k, l
| ^ T031
95 | integer :: Nfq
96 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:94:23: T031 subroutine argument 'k' missing 'intent' attribute
|
92 | real(kind(0d0)) :: fltr_dtheta !<
93 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
94 | integer :: j, k, l
| ^ T031
95 | integer :: Nfq
96 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:94:26: T031 subroutine argument 'l' missing 'intent' attribute
|
92 | real(kind(0d0)) :: fltr_dtheta !<
93 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
94 | integer :: j, k, l
| ^ T031
95 | integer :: Nfq
96 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:96:42: T031 subroutine argument 'Re_l' missing 'intent' attribute
|
94 | integer :: j, k, l
95 | integer :: Nfq
96 | real(kind(0d0)), dimension(2) :: Re_l
| ^^^^ T031
97 |
98 | if (grid_geometry == 3) then
|
warning: ./src/simulation/m_sim_helpers.f90:184:49: T031 subroutine argument 'vel' missing 'intent' attribute
|
182 | subroutine s_compute_dt_from_cfl(vel, c, max_dt, rho, Re_l, j, k, l)
183 | !$acc routine seq
184 | real(kind(0d0)), dimension(num_dims) :: vel
| ^^^ T031
185 | real(kind(0d0)) :: c, icfl_dt, vcfl_dt, rho
186 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: max_dt
|
warning: ./src/simulation/m_sim_helpers.f90:185:28: T031 subroutine argument 'c' missing 'intent' attribute
|
183 | !$acc routine seq
184 | real(kind(0d0)), dimension(num_dims) :: vel
185 | real(kind(0d0)) :: c, icfl_dt, vcfl_dt, rho
| ^ T031
186 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: max_dt
187 | real(kind(0d0)) :: fltr_dtheta !<
|
warning: ./src/simulation/m_sim_helpers.f90:185:49: T031 subroutine argument 'rho' missing 'intent' attribute
|
183 | !$acc routine seq
184 | real(kind(0d0)), dimension(num_dims) :: vel
185 | real(kind(0d0)) :: c, icfl_dt, vcfl_dt, rho
| ^^^ T031
186 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: max_dt
187 | real(kind(0d0)) :: fltr_dtheta !<
|
warning: ./src/simulation/m_sim_helpers.f90:186:54: T031 subroutine argument 'max_dt' missing 'intent' attribute
|
184 | real(kind(0d0)), dimension(num_dims) :: vel
185 | real(kind(0d0)) :: c, icfl_dt, vcfl_dt, rho
186 | real(kind(0d0)), dimension(0:m, 0:n, 0:p) :: max_dt
| ^^^^^^ T031
187 | real(kind(0d0)) :: fltr_dtheta !<
188 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
|
warning: ./src/simulation/m_sim_helpers.f90:189:20: T031 subroutine argument 'j' missing 'intent' attribute
|
187 | real(kind(0d0)) :: fltr_dtheta !<
188 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
189 | integer :: j, k, l
| ^ T031
190 | integer :: Nfq
191 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:189:23: T031 subroutine argument 'k' missing 'intent' attribute
|
187 | real(kind(0d0)) :: fltr_dtheta !<
188 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
189 | integer :: j, k, l
| ^ T031
190 | integer :: Nfq
191 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:189:26: T031 subroutine argument 'l' missing 'intent' attribute
|
187 | real(kind(0d0)) :: fltr_dtheta !<
188 | !! Modified dtheta accounting for Fourier filtering in azimuthal direction.
189 | integer :: j, k, l
| ^ T031
190 | integer :: Nfq
191 | real(kind(0d0)), dimension(2) :: Re_l
|
warning: ./src/simulation/m_sim_helpers.f90:191:42: T031 subroutine argument 'Re_l' missing 'intent' attribute
|
189 | integer :: j, k, l
190 | integer :: Nfq
191 | real(kind(0d0)), dimension(2) :: Re_l
| ^^^^ T031
192 |
193 | if (grid_geometry == 3) then
|
warning: ./src/simulation/m_start_up.fpp:126:36: T051 'file_path' is initialised in its declaration and has no explicit save or parameter attribute
|
125 | ! Relative path to the input file provided by the user
126 | character(LEN=name_len) :: file_path = './simulation.inp'
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ T051
127 |
128 | logical :: file_exist !<
|
warning: ./src/simulation/m_surface_tension.fpp:76:52: T031 subroutine argument 'q_prim_vf' missing 'intent' attribute
|
74 | id, isx, isy, isz)
75 |
76 | type(scalar_field), dimension(sys_size) :: q_prim_vf !> unused so unsure what intent to give it
| ^^^^^^^^^ T031
77 | real(kind(0d0)), dimension(-1:, 0:, 0:, 1:), intent(in) :: vSrc_rsx_vf
78 | real(kind(0d0)), dimension(-1:, 0:, 0:, 1:), intent(in) :: vSrc_rsy_vf
|
warning: ./src/syscheck/syscheck.fpp:87:1: M001 subroutine not contained within (sub)module or program
|
85 | end program syscheck
86 |
87 | subroutine assert(condition)
| ^^^^^^^^^^^^^^^^^^^^^^^^^^^^ M001
88 |
89 | use iso_fortran_env, only: output_unit, error_unit
|
-- Number of errors: 164
-- For more information, run:Metadata
Metadata
Assignees
Labels
continuous-integrationContinuous integration (CI)Continuous integration (CI)enhancementNew feature or requestNew feature or requestgood first issueGood for newcomersGood for newcomers