Skip to content

Commit

Permalink
Fix indentation now that we have more directives and ifdefs (#388)
Browse files Browse the repository at this point in the history
  • Loading branch information
sbryngelson authored Apr 6, 2024
1 parent cc94ced commit ad9237f
Show file tree
Hide file tree
Showing 21 changed files with 126 additions and 125 deletions.
4 changes: 2 additions & 2 deletions src/common/include/inline_conversions.fpp
Original file line number Diff line number Diff line change
@@ -1,9 +1,9 @@
#:def s_compute_speed_of_sound()
subroutine s_compute_speed_of_sound(pres, rho, gamma, pi_inf, H, adv, vel_sum, c)
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_speed_of_sound
!DIR$ INLINEALWAYS s_compute_speed_of_sound
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), intent(IN) :: pres
real(kind(0d0)), intent(IN) :: rho, gamma, pi_inf
Expand Down
8 changes: 4 additions & 4 deletions src/common/include/macros.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -33,11 +33,11 @@
#:for arg in args
${re.sub('\(.*\)','',arg)}$ => ${ 'p_' + re.sub('\(.*\)','',arg.strip()) }$
#:endfor
!$acc enter data create(${', '.join(('p_' + re.sub('\(.*\)','',arg.strip()) for arg in args))}$) &
!$acc& attach(${', '.join(map(lambda x: re.sub('\(.*\)','',x), args))}$)
!$acc enter data create(${', '.join(('p_' + re.sub('\(.*\)','',arg.strip()) for arg in args))}$) &
!$acc& attach(${', '.join(map(lambda x: re.sub('\(.*\)','',x), args))}$)
#else
allocate (${', '.join(args)}$)
!$acc enter data create(${', '.join(args)}$)
!$acc enter data create(${', '.join(args)}$)
#endif

#:enddef ALLOCATE_GLOBAL
Expand All @@ -53,7 +53,7 @@
deallocate (${', '.join(('p_' + arg.strip() for arg in args))}$)
#else
deallocate (${', '.join(args)}$)
!$acc exit data delete(${', '.join(args)}$)
!$acc exit data delete(${', '.join(args)}$)
#endif

#:enddef DEALLOCATE_GLOBAL
Expand Down
10 changes: 5 additions & 5 deletions src/common/m_variables_conversion.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -86,19 +86,19 @@ module m_variables_conversion
!! In simulation, gammas, pi_infs, and qvs are already declared in m_global_variables
#ifndef MFC_SIMULATION
real(kind(0d0)), allocatable, public, dimension(:) :: gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
#endif

#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), Gs)
@:CRAY_DECLARE_GLOBAL(integer, dimension(:), bubrs)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), Res)
!$acc declare link(bubrs, Gs, Res)
!$acc declare link(bubrs, Gs, Res)
#else
real(kind(0d0)), allocatable, dimension(:) :: Gs
integer, allocatable, dimension(:) :: bubrs
real(kind(0d0)), allocatable, dimension(:, :) :: Res
!$acc declare create(bubrs, Gs, Res)
!$acc declare create(bubrs, Gs, Res)
#endif
integer :: is1b, is2b, is3b, is1e, is2e, is3e
!$acc declare create(is1b, is2b, is3b, is1e, is2e, is3e)
Expand Down Expand Up @@ -458,7 +458,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_convert_species_to_mixture_variables_acc
#else
!$acc routine seq
!$acc routine seq
#endif

real(kind(0d0)), intent(OUT) :: rho_K, gamma_K, pi_inf_K, qv_K
Expand Down Expand Up @@ -540,7 +540,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_convert_species_to_mixture_variables_bubbles_acc
#else
!$acc routine seq
!$acc routine seq
#endif

real(kind(0d0)), intent(INOUT) :: rho_K, gamma_K, pi_inf_K, qv_K
Expand Down
4 changes: 2 additions & 2 deletions src/simulation/m_bubbles.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -40,7 +40,7 @@ module m_bubbles
!$acc declare create(divu)

@:CRAY_DECLARE_GLOBAL(integer, dimension(:), rs, vs, ms, ps)
!$acc declare link(rs, vs, ms, ps)
!$acc declare link(rs, vs, ms, ps)
#else
real(kind(0d0)), allocatable, dimension(:, :, :) :: bub_adv_src
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: bub_r_src, bub_v_src, bub_p_src, bub_m_src
Expand All @@ -50,7 +50,7 @@ module m_bubbles
!$acc declare create(divu)

integer, allocatable, dimension(:) :: rs, vs, ms, ps
!$acc declare create(rs, vs, ms, ps)
!$acc declare create(rs, vs, ms, ps)
#endif

contains
Expand Down
14 changes: 7 additions & 7 deletions src/simulation/m_cbc.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -44,7 +44,7 @@ module m_cbc
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsx_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsy_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsz_vf)
!$acc declare link(q_prim_rsx_vf, q_prim_rsy_vf, q_prim_rsz_vf)
!$acc declare link(q_prim_rsx_vf, q_prim_rsy_vf, q_prim_rsz_vf)
#else
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: q_prim_rsx_vf
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: q_prim_rsy_vf
Expand All @@ -53,7 +53,7 @@ module m_cbc

#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:), F_rs_vf, F_src_rs_vf)
!$acc declare link(F_rs_vf, F_src_rs_vf)
!$acc declare link(F_rs_vf, F_src_rs_vf)
#else
type(scalar_field), allocatable, dimension(:) :: F_rs_vf, F_src_rs_vf !<
#endif
Expand All @@ -64,7 +64,7 @@ module m_cbc
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsx_vf, F_src_rsx_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsy_vf, F_src_rsy_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsz_vf, F_src_rsz_vf)
!$acc declare link(F_rsx_vf, F_src_rsx_vf, F_rsy_vf, F_src_rsy_vf, F_rsz_vf, F_src_rsz_vf)
!$acc declare link(F_rsx_vf, F_src_rsx_vf, F_rsy_vf, F_src_rsy_vf, F_rsz_vf, F_src_rsz_vf)
#else
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: F_rsx_vf, F_src_rsx_vf !<
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: F_rsy_vf, F_src_rsy_vf !<
Expand All @@ -75,7 +75,7 @@ module m_cbc
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsx_vf, flux_src_rsx_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsy_vf, flux_src_rsy_vf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsz_vf, flux_src_rsz_vf)
!$acc declare link(flux_rsx_vf, flux_src_rsx_vf, flux_rsy_vf, flux_src_rsy_vf, flux_rsz_vf, flux_src_rsz_vf)
!$acc declare link(flux_rsx_vf, flux_src_rsx_vf, flux_rsy_vf, flux_src_rsy_vf, flux_rsz_vf, flux_src_rsz_vf)
#else
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: flux_rsx_vf, flux_src_rsx_vf !<
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: flux_rsy_vf, flux_src_rsy_vf
Expand All @@ -90,7 +90,7 @@ module m_cbc
!$acc declare create(dpres_ds)
#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), ds)
!$acc declare link(ds)
!$acc declare link(ds)
#else
real(kind(0d0)), allocatable, dimension(:) :: ds !< Cell-width distribution in the s-direction
#endif
Expand All @@ -100,7 +100,7 @@ module m_cbc
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_x)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_y)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_z)
!$acc declare link(fd_coef_x, fd_coef_y, fd_coef_z)
!$acc declare link(fd_coef_x, fd_coef_y, fd_coef_z)
#else
real(kind(0d0)), allocatable, dimension(:, :) :: fd_coef_x !< Finite diff. coefficients x-dir
real(kind(0d0)), allocatable, dimension(:, :) :: fd_coef_y !< Finite diff. coefficients y-dir
Expand All @@ -115,7 +115,7 @@ module m_cbc
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_x)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_y)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_z)
!$acc declare link(pi_coef_x, pi_coef_y, pi_coef_z)
!$acc declare link(pi_coef_x, pi_coef_y, pi_coef_z)
#else
real(kind(0d0)), allocatable, dimension(:, :, :) :: pi_coef_x !< Polynominal interpolant coefficients in x-dir
real(kind(0d0)), allocatable, dimension(:, :, :) :: pi_coef_y !< Polynominal interpolant coefficients in y-dir
Expand Down
16 changes: 8 additions & 8 deletions src/simulation/m_compute_cbc.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -31,7 +31,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_slip_wall_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down Expand Up @@ -59,7 +59,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_nonreflecting_subsonic_buffer_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down Expand Up @@ -100,7 +100,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS ss_compute_nonreflecting_subsonic_inflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand All @@ -126,7 +126,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_nonreflecting_subsonic_outflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down Expand Up @@ -166,7 +166,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_force_free_subsonic_outflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down Expand Up @@ -202,7 +202,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_constant_pressure_subsonic_outflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down Expand Up @@ -239,7 +239,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_supersonic_inflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand All @@ -263,7 +263,7 @@ contains
#ifdef CRAY_ACC_WAR
!DIR$ INLINEALWAYS s_compute_supersonic_outflow_L
#else
!$acc routine seq
!$acc routine seq
#endif
real(kind(0d0)), dimension(3), intent(IN) :: lambda
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
Expand Down
4 changes: 2 additions & 2 deletions src/simulation/m_data_output.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -72,13 +72,13 @@ module m_data_output
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), vcfl_sf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), ccfl_sf)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), Rc_sf)
!$acc declare link(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
!$acc declare link(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
#else
real(kind(0d0)), allocatable, dimension(:, :, :) :: icfl_sf !< ICFL stability criterion
real(kind(0d0)), allocatable, dimension(:, :, :) :: vcfl_sf !< VCFL stability criterion
real(kind(0d0)), allocatable, dimension(:, :, :) :: ccfl_sf !< CCFL stability criterion
real(kind(0d0)), allocatable, dimension(:, :, :) :: Rc_sf !< Rc stability criterion
!$acc declare create(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
!$acc declare create(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
#endif

real(kind(0d0)) :: icfl_max_loc, icfl_max_glb !< ICFL stability extrema on local and global grids
Expand Down
2 changes: 1 addition & 1 deletion src/simulation/m_derived_variables.f90
Original file line number Diff line number Diff line change
Expand Up @@ -177,7 +177,7 @@ end subroutine s_compute_derived_variables ! ---------------------------
!! @param q_sf Acceleration component
subroutine s_derive_acceleration_component(i, q_prim_vf0, q_prim_vf1, &
q_prim_vf2, q_prim_vf3, q_sf) ! ----------
!DIR$ INLINEALWAYS s_derive_acceleration_component
!DIR$ INLINEALWAYS s_derive_acceleration_component
integer, intent(IN) :: i

type(scalar_field), dimension(sys_size), intent(IN) :: q_prim_vf0
Expand Down
8 changes: 4 additions & 4 deletions src/simulation/m_fftw.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -55,12 +55,12 @@ module m_fftw
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), data_real_gpu)
@:CRAY_DECLARE_GLOBAL(complex(kind(0d0)), dimension(:), data_cmplx_gpu)
@:CRAY_DECLARE_GLOBAL(complex(kind(0d0)), dimension(:), data_fltr_cmplx_gpu)
!$acc declare link(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
!$acc declare link(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
#else
real(kind(0d0)), allocatable :: data_real_gpu(:)
complex(kind(0d0)), allocatable :: data_cmplx_gpu(:)
complex(kind(0d0)), allocatable :: data_fltr_cmplx_gpu(:)
!$acc declare create(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
!$acc declare create(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
#endif

#if defined(__PGI)
Expand Down Expand Up @@ -99,8 +99,8 @@ contains
gpu_fft_size(1) = real_size;
iembed(1) = 0
oembed(1) = 0
!$acc enter data copyin(real_size, cmplx_size, x_size, sys_size, batch_size, Nfq)
!$acc update device(real_size, cmplx_size, x_size, sys_size, batch_size)
!$acc enter data copyin(real_size, cmplx_size, x_size, sys_size, batch_size, Nfq)
!$acc update device(real_size, cmplx_size, x_size, sys_size, batch_size)
#else
! Allocate input and output DFT data sizes
fftw_real_data = fftw_alloc_real(int(real_size, c_size_t))
Expand Down
36 changes: 18 additions & 18 deletions src/simulation/m_global_parameters.fpp
Original file line number Diff line number Diff line change
Expand Up @@ -88,10 +88,10 @@ module m_global_parameters
real(kind(0d0)) :: dt !< Size of the time-step

#ifdef CRAY_ACC_WAR
!$acc declare link(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz)
!$acc declare create(m, n, p, dt)
!$acc declare link(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz)
!$acc declare create(m, n, p, dt)
#else
!$acc declare create(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz, dt, m, n, p)
!$acc declare create(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz, dt, m, n, p)
#endif
!> @name Starting time-step iteration, stopping time-step iteration and the number
!! of time-step iterations between successive solution backups, respectively
Expand Down Expand Up @@ -212,10 +212,10 @@ module m_global_parameters
#endif
!> @}
#ifdef CRAY_ACC_WAR
!$acc declare create(Re_size)
!$acc declare link(Re_idx)
!$acc declare create(Re_size)
!$acc declare link(Re_idx)
#else
!$acc declare create(Re_size, Re_idx)
!$acc declare create(Re_size, Re_idx)
#endif

! The WENO average (WA) flag regulates whether the calculation of any cell-
Expand Down Expand Up @@ -321,12 +321,12 @@ module m_global_parameters
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), weight)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), R0)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), V0)
!$acc declare link(weight, R0, V0)
!$acc declare link(weight, R0, V0)
#else
real(kind(0d0)), dimension(:), allocatable :: weight !< Simpson quadrature weights
real(kind(0d0)), dimension(:), allocatable :: R0 !< Bubble sizes
real(kind(0d0)), dimension(:), allocatable :: V0 !< Bubble velocities
!$acc declare create(weight, R0, V0)
!$acc declare create(weight, R0, V0)
#endif
logical :: bubbles !< Bubbles on/off
logical :: polytropic !< Polytropic switch
Expand All @@ -336,10 +336,10 @@ module m_global_parameters
integer :: thermal !< Thermal behavior. 1 = adiabatic, 2 = isotherm, 3 = transfer
#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), ptil)
!$acc declare link(ptil)
!$acc declare link(ptil)
#else
real(kind(0d0)), allocatable, dimension(:, :, :) :: ptil !< Pressure modification
!$acc declare create(ptil)
!$acc declare create(ptil)
#endif
real(kind(0d0)) :: poly_sigma !< log normal sigma for polydisperse PDF

Expand All @@ -358,11 +358,11 @@ module m_global_parameters
#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:), mom_sp)
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:, :, :), mom_3d)
!$acc declare link(mom_sp, mom_3d)
!$acc declare link(mom_sp, mom_3d)
#else
type(scalar_field), allocatable, dimension(:) :: mom_sp
type(scalar_field), allocatable, dimension(:, :, :) :: mom_3d
!$acc declare create(mom_sp, mom_3d)
!$acc declare create(mom_sp, mom_3d)
#endif
!> @}

Expand All @@ -373,11 +373,11 @@ module m_global_parameters
#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), k_n, k_v, pb0, mass_n0, mass_v0, Pe_T)
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
!$acc declare link( k_n, k_v, pb0, mass_n0, mass_v0, Pe_T, Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
!$acc declare link( k_n, k_v, pb0, mass_n0, mass_v0, Pe_T, Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
#else
real(kind(0d0)), dimension(:), allocatable :: k_n, k_v, pb0, mass_n0, mass_v0, Pe_T
real(kind(0d0)), dimension(:), allocatable :: Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN
!$acc declare create( k_n, k_v, pb0, mass_n0, mass_v0, Pe_T, Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
!$acc declare create( k_n, k_v, pb0, mass_n0, mass_v0, Pe_T, Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
#endif
real(kind(0d0)) :: mul0, ss, gamma_v, mu_v
real(kind(0d0)) :: gamma_m, gamma_n, mu_n
Expand All @@ -404,10 +404,10 @@ module m_global_parameters

#ifdef CRAY_ACC_WAR
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
!$acc declare link(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
!$acc declare link(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
#else
real(kind(0d0)), allocatable, dimension(:) :: gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
#endif

real(kind(0d0)) :: mytime !< Current simulation time
Expand All @@ -419,13 +419,13 @@ module m_global_parameters

@:CRAY_DECLARE_GLOBAL(type(pres_field), dimension(:), mv_ts)

!$acc declare link(pb_ts, mv_ts)
!$acc declare link(pb_ts, mv_ts)
#else
type(pres_field), allocatable, dimension(:) :: pb_ts

type(pres_field), allocatable, dimension(:) :: mv_ts

!$acc declare create(pb_ts, mv_ts)
!$acc declare create(pb_ts, mv_ts)
#endif
! ======================================================================

Expand Down
Loading

0 comments on commit ad9237f

Please sign in to comment.