Skip to content

Commit ad9237f

Browse files
authored
Fix indentation now that we have more directives and ifdefs (#388)
1 parent cc94ced commit ad9237f

21 files changed

+126
-125
lines changed

src/common/include/inline_conversions.fpp

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -1,9 +1,9 @@
11
#:def s_compute_speed_of_sound()
22
subroutine s_compute_speed_of_sound(pres, rho, gamma, pi_inf, H, adv, vel_sum, c)
33
#ifdef CRAY_ACC_WAR
4-
!DIR$ INLINEALWAYS s_compute_speed_of_sound
4+
!DIR$ INLINEALWAYS s_compute_speed_of_sound
55
#else
6-
!$acc routine seq
6+
!$acc routine seq
77
#endif
88
real(kind(0d0)), intent(IN) :: pres
99
real(kind(0d0)), intent(IN) :: rho, gamma, pi_inf

src/common/include/macros.fpp

Lines changed: 4 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -33,11 +33,11 @@
3333
#:for arg in args
3434
${re.sub('\(.*\)','',arg)}$ => ${ 'p_' + re.sub('\(.*\)','',arg.strip()) }$
3535
#:endfor
36-
!$acc enter data create(${', '.join(('p_' + re.sub('\(.*\)','',arg.strip()) for arg in args))}$) &
37-
!$acc& attach(${', '.join(map(lambda x: re.sub('\(.*\)','',x), args))}$)
36+
!$acc enter data create(${', '.join(('p_' + re.sub('\(.*\)','',arg.strip()) for arg in args))}$) &
37+
!$acc& attach(${', '.join(map(lambda x: re.sub('\(.*\)','',x), args))}$)
3838
#else
3939
allocate (${', '.join(args)}$)
40-
!$acc enter data create(${', '.join(args)}$)
40+
!$acc enter data create(${', '.join(args)}$)
4141
#endif
4242

4343
#:enddef ALLOCATE_GLOBAL
@@ -53,7 +53,7 @@
5353
deallocate (${', '.join(('p_' + arg.strip() for arg in args))}$)
5454
#else
5555
deallocate (${', '.join(args)}$)
56-
!$acc exit data delete(${', '.join(args)}$)
56+
!$acc exit data delete(${', '.join(args)}$)
5757
#endif
5858

5959
#:enddef DEALLOCATE_GLOBAL

src/common/m_variables_conversion.fpp

Lines changed: 5 additions & 5 deletions
Original file line numberDiff line numberDiff line change
@@ -86,19 +86,19 @@ module m_variables_conversion
8686
!! In simulation, gammas, pi_infs, and qvs are already declared in m_global_variables
8787
#ifndef MFC_SIMULATION
8888
real(kind(0d0)), allocatable, public, dimension(:) :: gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps
89-
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
89+
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
9090
#endif
9191

9292
#ifdef CRAY_ACC_WAR
9393
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), Gs)
9494
@:CRAY_DECLARE_GLOBAL(integer, dimension(:), bubrs)
9595
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), Res)
96-
!$acc declare link(bubrs, Gs, Res)
96+
!$acc declare link(bubrs, Gs, Res)
9797
#else
9898
real(kind(0d0)), allocatable, dimension(:) :: Gs
9999
integer, allocatable, dimension(:) :: bubrs
100100
real(kind(0d0)), allocatable, dimension(:, :) :: Res
101-
!$acc declare create(bubrs, Gs, Res)
101+
!$acc declare create(bubrs, Gs, Res)
102102
#endif
103103
integer :: is1b, is2b, is3b, is1e, is2e, is3e
104104
!$acc declare create(is1b, is2b, is3b, is1e, is2e, is3e)
@@ -458,7 +458,7 @@ contains
458458
#ifdef CRAY_ACC_WAR
459459
!DIR$ INLINEALWAYS s_convert_species_to_mixture_variables_acc
460460
#else
461-
!$acc routine seq
461+
!$acc routine seq
462462
#endif
463463

464464
real(kind(0d0)), intent(OUT) :: rho_K, gamma_K, pi_inf_K, qv_K
@@ -540,7 +540,7 @@ contains
540540
#ifdef CRAY_ACC_WAR
541541
!DIR$ INLINEALWAYS s_convert_species_to_mixture_variables_bubbles_acc
542542
#else
543-
!$acc routine seq
543+
!$acc routine seq
544544
#endif
545545

546546
real(kind(0d0)), intent(INOUT) :: rho_K, gamma_K, pi_inf_K, qv_K

src/simulation/m_bubbles.fpp

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -40,7 +40,7 @@ module m_bubbles
4040
!$acc declare create(divu)
4141

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

5252
integer, allocatable, dimension(:) :: rs, vs, ms, ps
53-
!$acc declare create(rs, vs, ms, ps)
53+
!$acc declare create(rs, vs, ms, ps)
5454
#endif
5555

5656
contains

src/simulation/m_cbc.fpp

Lines changed: 7 additions & 7 deletions
Original file line numberDiff line numberDiff line change
@@ -44,7 +44,7 @@ module m_cbc
4444
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsx_vf)
4545
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsy_vf)
4646
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), q_prim_rsz_vf)
47-
!$acc declare link(q_prim_rsx_vf, q_prim_rsy_vf, q_prim_rsz_vf)
47+
!$acc declare link(q_prim_rsx_vf, q_prim_rsy_vf, q_prim_rsz_vf)
4848
#else
4949
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: q_prim_rsx_vf
5050
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: q_prim_rsy_vf
@@ -53,7 +53,7 @@ module m_cbc
5353

5454
#ifdef CRAY_ACC_WAR
5555
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:), F_rs_vf, F_src_rs_vf)
56-
!$acc declare link(F_rs_vf, F_src_rs_vf)
56+
!$acc declare link(F_rs_vf, F_src_rs_vf)
5757
#else
5858
type(scalar_field), allocatable, dimension(:) :: F_rs_vf, F_src_rs_vf !<
5959
#endif
@@ -64,7 +64,7 @@ module m_cbc
6464
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsx_vf, F_src_rsx_vf)
6565
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsy_vf, F_src_rsy_vf)
6666
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), F_rsz_vf, F_src_rsz_vf)
67-
!$acc declare link(F_rsx_vf, F_src_rsx_vf, F_rsy_vf, F_src_rsy_vf, F_rsz_vf, F_src_rsz_vf)
67+
!$acc declare link(F_rsx_vf, F_src_rsx_vf, F_rsy_vf, F_src_rsy_vf, F_rsz_vf, F_src_rsz_vf)
6868
#else
6969
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: F_rsx_vf, F_src_rsx_vf !<
7070
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: F_rsy_vf, F_src_rsy_vf !<
@@ -75,7 +75,7 @@ module m_cbc
7575
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsx_vf, flux_src_rsx_vf)
7676
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsy_vf, flux_src_rsy_vf)
7777
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :, :), flux_rsz_vf, flux_src_rsz_vf)
78-
!$acc declare link(flux_rsx_vf, flux_src_rsx_vf, flux_rsy_vf, flux_src_rsy_vf, flux_rsz_vf, flux_src_rsz_vf)
78+
!$acc declare link(flux_rsx_vf, flux_src_rsx_vf, flux_rsy_vf, flux_src_rsy_vf, flux_rsz_vf, flux_src_rsz_vf)
7979
#else
8080
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: flux_rsx_vf, flux_src_rsx_vf !<
8181
real(kind(0d0)), allocatable, dimension(:, :, :, :) :: flux_rsy_vf, flux_src_rsy_vf
@@ -90,7 +90,7 @@ module m_cbc
9090
!$acc declare create(dpres_ds)
9191
#ifdef CRAY_ACC_WAR
9292
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), ds)
93-
!$acc declare link(ds)
93+
!$acc declare link(ds)
9494
#else
9595
real(kind(0d0)), allocatable, dimension(:) :: ds !< Cell-width distribution in the s-direction
9696
#endif
@@ -100,7 +100,7 @@ module m_cbc
100100
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_x)
101101
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_y)
102102
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :), fd_coef_z)
103-
!$acc declare link(fd_coef_x, fd_coef_y, fd_coef_z)
103+
!$acc declare link(fd_coef_x, fd_coef_y, fd_coef_z)
104104
#else
105105
real(kind(0d0)), allocatable, dimension(:, :) :: fd_coef_x !< Finite diff. coefficients x-dir
106106
real(kind(0d0)), allocatable, dimension(:, :) :: fd_coef_y !< Finite diff. coefficients y-dir
@@ -115,7 +115,7 @@ module m_cbc
115115
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_x)
116116
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_y)
117117
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), pi_coef_z)
118-
!$acc declare link(pi_coef_x, pi_coef_y, pi_coef_z)
118+
!$acc declare link(pi_coef_x, pi_coef_y, pi_coef_z)
119119
#else
120120
real(kind(0d0)), allocatable, dimension(:, :, :) :: pi_coef_x !< Polynominal interpolant coefficients in x-dir
121121
real(kind(0d0)), allocatable, dimension(:, :, :) :: pi_coef_y !< Polynominal interpolant coefficients in y-dir

src/simulation/m_compute_cbc.fpp

Lines changed: 8 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -31,7 +31,7 @@ contains
3131
#ifdef CRAY_ACC_WAR
3232
!DIR$ INLINEALWAYS s_compute_slip_wall_L
3333
#else
34-
!$acc routine seq
34+
!$acc routine seq
3535
#endif
3636
real(kind(0d0)), dimension(3), intent(IN) :: lambda
3737
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -59,7 +59,7 @@ contains
5959
#ifdef CRAY_ACC_WAR
6060
!DIR$ INLINEALWAYS s_compute_nonreflecting_subsonic_buffer_L
6161
#else
62-
!$acc routine seq
62+
!$acc routine seq
6363
#endif
6464
real(kind(0d0)), dimension(3), intent(IN) :: lambda
6565
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -100,7 +100,7 @@ contains
100100
#ifdef CRAY_ACC_WAR
101101
!DIR$ INLINEALWAYS ss_compute_nonreflecting_subsonic_inflow_L
102102
#else
103-
!$acc routine seq
103+
!$acc routine seq
104104
#endif
105105
real(kind(0d0)), dimension(3), intent(IN) :: lambda
106106
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -126,7 +126,7 @@ contains
126126
#ifdef CRAY_ACC_WAR
127127
!DIR$ INLINEALWAYS s_compute_nonreflecting_subsonic_outflow_L
128128
#else
129-
!$acc routine seq
129+
!$acc routine seq
130130
#endif
131131
real(kind(0d0)), dimension(3), intent(IN) :: lambda
132132
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -166,7 +166,7 @@ contains
166166
#ifdef CRAY_ACC_WAR
167167
!DIR$ INLINEALWAYS s_compute_force_free_subsonic_outflow_L
168168
#else
169-
!$acc routine seq
169+
!$acc routine seq
170170
#endif
171171
real(kind(0d0)), dimension(3), intent(IN) :: lambda
172172
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -202,7 +202,7 @@ contains
202202
#ifdef CRAY_ACC_WAR
203203
!DIR$ INLINEALWAYS s_compute_constant_pressure_subsonic_outflow_L
204204
#else
205-
!$acc routine seq
205+
!$acc routine seq
206206
#endif
207207
real(kind(0d0)), dimension(3), intent(IN) :: lambda
208208
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -239,7 +239,7 @@ contains
239239
#ifdef CRAY_ACC_WAR
240240
!DIR$ INLINEALWAYS s_compute_supersonic_inflow_L
241241
#else
242-
!$acc routine seq
242+
!$acc routine seq
243243
#endif
244244
real(kind(0d0)), dimension(3), intent(IN) :: lambda
245245
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds
@@ -263,7 +263,7 @@ contains
263263
#ifdef CRAY_ACC_WAR
264264
!DIR$ INLINEALWAYS s_compute_supersonic_outflow_L
265265
#else
266-
!$acc routine seq
266+
!$acc routine seq
267267
#endif
268268
real(kind(0d0)), dimension(3), intent(IN) :: lambda
269269
real(kind(0d0)), dimension(num_fluids), intent(IN) :: mf, dalpha_rho_ds, dadv_ds

src/simulation/m_data_output.fpp

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -72,13 +72,13 @@ module m_data_output
7272
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), vcfl_sf)
7373
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), ccfl_sf)
7474
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), Rc_sf)
75-
!$acc declare link(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
75+
!$acc declare link(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
7676
#else
7777
real(kind(0d0)), allocatable, dimension(:, :, :) :: icfl_sf !< ICFL stability criterion
7878
real(kind(0d0)), allocatable, dimension(:, :, :) :: vcfl_sf !< VCFL stability criterion
7979
real(kind(0d0)), allocatable, dimension(:, :, :) :: ccfl_sf !< CCFL stability criterion
8080
real(kind(0d0)), allocatable, dimension(:, :, :) :: Rc_sf !< Rc stability criterion
81-
!$acc declare create(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
81+
!$acc declare create(icfl_sf, vcfl_sf, ccfl_sf, Rc_sf)
8282
#endif
8383

8484
real(kind(0d0)) :: icfl_max_loc, icfl_max_glb !< ICFL stability extrema on local and global grids

src/simulation/m_derived_variables.f90

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -177,7 +177,7 @@ end subroutine s_compute_derived_variables ! ---------------------------
177177
!! @param q_sf Acceleration component
178178
subroutine s_derive_acceleration_component(i, q_prim_vf0, q_prim_vf1, &
179179
q_prim_vf2, q_prim_vf3, q_sf) ! ----------
180-
!DIR$ INLINEALWAYS s_derive_acceleration_component
180+
!DIR$ INLINEALWAYS s_derive_acceleration_component
181181
integer, intent(IN) :: i
182182

183183
type(scalar_field), dimension(sys_size), intent(IN) :: q_prim_vf0

src/simulation/m_fftw.fpp

Lines changed: 4 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -55,12 +55,12 @@ module m_fftw
5555
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), data_real_gpu)
5656
@:CRAY_DECLARE_GLOBAL(complex(kind(0d0)), dimension(:), data_cmplx_gpu)
5757
@:CRAY_DECLARE_GLOBAL(complex(kind(0d0)), dimension(:), data_fltr_cmplx_gpu)
58-
!$acc declare link(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
58+
!$acc declare link(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
5959
#else
6060
real(kind(0d0)), allocatable :: data_real_gpu(:)
6161
complex(kind(0d0)), allocatable :: data_cmplx_gpu(:)
6262
complex(kind(0d0)), allocatable :: data_fltr_cmplx_gpu(:)
63-
!$acc declare create(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
63+
!$acc declare create(data_real_gpu, data_cmplx_gpu, data_fltr_cmplx_gpu)
6464
#endif
6565

6666
#if defined(__PGI)
@@ -99,8 +99,8 @@ contains
9999
gpu_fft_size(1) = real_size;
100100
iembed(1) = 0
101101
oembed(1) = 0
102-
!$acc enter data copyin(real_size, cmplx_size, x_size, sys_size, batch_size, Nfq)
103-
!$acc update device(real_size, cmplx_size, x_size, sys_size, batch_size)
102+
!$acc enter data copyin(real_size, cmplx_size, x_size, sys_size, batch_size, Nfq)
103+
!$acc update device(real_size, cmplx_size, x_size, sys_size, batch_size)
104104
#else
105105
! Allocate input and output DFT data sizes
106106
fftw_real_data = fftw_alloc_real(int(real_size, c_size_t))

src/simulation/m_global_parameters.fpp

Lines changed: 18 additions & 18 deletions
Original file line numberDiff line numberDiff line change
@@ -88,10 +88,10 @@ module m_global_parameters
8888
real(kind(0d0)) :: dt !< Size of the time-step
8989

9090
#ifdef CRAY_ACC_WAR
91-
!$acc declare link(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz)
92-
!$acc declare create(m, n, p, dt)
91+
!$acc declare link(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz)
92+
!$acc declare create(m, n, p, dt)
9393
#else
94-
!$acc declare create(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz, dt, m, n, p)
94+
!$acc declare create(x_cb, y_cb, z_cb, x_cc, y_cc, z_cc, dx, dy, dz, dt, m, n, p)
9595
#endif
9696
!> @name Starting time-step iteration, stopping time-step iteration and the number
9797
!! of time-step iterations between successive solution backups, respectively
@@ -212,10 +212,10 @@ module m_global_parameters
212212
#endif
213213
!> @}
214214
#ifdef CRAY_ACC_WAR
215-
!$acc declare create(Re_size)
216-
!$acc declare link(Re_idx)
215+
!$acc declare create(Re_size)
216+
!$acc declare link(Re_idx)
217217
#else
218-
!$acc declare create(Re_size, Re_idx)
218+
!$acc declare create(Re_size, Re_idx)
219219
#endif
220220

221221
! The WENO average (WA) flag regulates whether the calculation of any cell-
@@ -321,12 +321,12 @@ module m_global_parameters
321321
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), weight)
322322
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), R0)
323323
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), V0)
324-
!$acc declare link(weight, R0, V0)
324+
!$acc declare link(weight, R0, V0)
325325
#else
326326
real(kind(0d0)), dimension(:), allocatable :: weight !< Simpson quadrature weights
327327
real(kind(0d0)), dimension(:), allocatable :: R0 !< Bubble sizes
328328
real(kind(0d0)), dimension(:), allocatable :: V0 !< Bubble velocities
329-
!$acc declare create(weight, R0, V0)
329+
!$acc declare create(weight, R0, V0)
330330
#endif
331331
logical :: bubbles !< Bubbles on/off
332332
logical :: polytropic !< Polytropic switch
@@ -336,10 +336,10 @@ module m_global_parameters
336336
integer :: thermal !< Thermal behavior. 1 = adiabatic, 2 = isotherm, 3 = transfer
337337
#ifdef CRAY_ACC_WAR
338338
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:, :, :), ptil)
339-
!$acc declare link(ptil)
339+
!$acc declare link(ptil)
340340
#else
341341
real(kind(0d0)), allocatable, dimension(:, :, :) :: ptil !< Pressure modification
342-
!$acc declare create(ptil)
342+
!$acc declare create(ptil)
343343
#endif
344344
real(kind(0d0)) :: poly_sigma !< log normal sigma for polydisperse PDF
345345

@@ -358,11 +358,11 @@ module m_global_parameters
358358
#ifdef CRAY_ACC_WAR
359359
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:), mom_sp)
360360
@:CRAY_DECLARE_GLOBAL(type(scalar_field), dimension(:, :, :), mom_3d)
361-
!$acc declare link(mom_sp, mom_3d)
361+
!$acc declare link(mom_sp, mom_3d)
362362
#else
363363
type(scalar_field), allocatable, dimension(:) :: mom_sp
364364
type(scalar_field), allocatable, dimension(:, :, :) :: mom_3d
365-
!$acc declare create(mom_sp, mom_3d)
365+
!$acc declare create(mom_sp, mom_3d)
366366
#endif
367367
!> @}
368368

@@ -373,11 +373,11 @@ module m_global_parameters
373373
#ifdef CRAY_ACC_WAR
374374
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), k_n, k_v, pb0, mass_n0, mass_v0, Pe_T)
375375
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN)
376-
!$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)
376+
!$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)
377377
#else
378378
real(kind(0d0)), dimension(:), allocatable :: k_n, k_v, pb0, mass_n0, mass_v0, Pe_T
379379
real(kind(0d0)), dimension(:), allocatable :: Re_trans_T, Re_trans_c, Im_trans_T, Im_trans_c, omegaN
380-
!$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)
380+
!$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)
381381
#endif
382382
real(kind(0d0)) :: mul0, ss, gamma_v, mu_v
383383
real(kind(0d0)) :: gamma_m, gamma_n, mu_n
@@ -404,10 +404,10 @@ module m_global_parameters
404404

405405
#ifdef CRAY_ACC_WAR
406406
@:CRAY_DECLARE_GLOBAL(real(kind(0d0)), dimension(:), gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
407-
!$acc declare link(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
407+
!$acc declare link(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
408408
#else
409409
real(kind(0d0)), allocatable, dimension(:) :: gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps
410-
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
410+
!$acc declare create(gammas, gs_min, pi_infs, ps_inf, cvs, qvs, qvps)
411411
#endif
412412

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

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

422-
!$acc declare link(pb_ts, mv_ts)
422+
!$acc declare link(pb_ts, mv_ts)
423423
#else
424424
type(pres_field), allocatable, dimension(:) :: pb_ts
425425

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

428-
!$acc declare create(pb_ts, mv_ts)
428+
!$acc declare create(pb_ts, mv_ts)
429429
#endif
430430
! ======================================================================
431431

0 commit comments

Comments
 (0)