Skip to content

Commit ead643f

Browse files
author
Anand
committed
Removing verbose code
1 parent e74ddf0 commit ead643f

File tree

22 files changed

+1085
-115
lines changed

22 files changed

+1085
-115
lines changed

docs/documentation/case.md

Lines changed: 3 additions & 4 deletions
Original file line numberDiff line numberDiff line change
@@ -822,15 +822,14 @@ The entries labeled "Characteristic." are characteristic boundary conditions bas
822822
| `bc_[x,y,z]%grcbc_in` | Logical | Enable grcbc for subsonic inflow |
823823
| `bc_[x,y,z]%grcbc_out` | Logical | Enable grcbc for subsonic outflow (pressure)|
824824
| `bc_[x,y,z]%grcbc_vel_out` | Logical | Enable grcbc for subsonic outflow (pressure + normal velocity) |
825-
| `bc_[x,y,z]%[u, v, w]_in` | Real | Inflow velocities in x, y and z directions |
826-
| `bc_[x,y,z]%[u, v, w]_out` | Real | Outflow velocities in x, y and z directions |
825+
| `bc_[x,y,z]%vel_in` | Real Array | Inflow velocities in x, y and z directions |
826+
| `bc_[x,y,z]%vel_out` | Real Array | Outflow velocities in x, y and z directions |
827827
| `bc_[x,y,z]%pres_in` | Real | Inflow pressure |
828828
| `bc_[x,y,z]%pres_out` | Real | Outflow pressure |
829829
| `bc_[x,y,z]%alpha_rho_in` | Real Array | Inflow density |
830830
| `bc_[x,y,z]%alpha_in` | Real Array | Inflow void fraction |
831831

832-
*: This boundary condition can be used for subsonic inflow (`bc_[x,y,z]%[beg,end]` = -7) and subsonic outflow (`bc_[x,y,z]%[beg,end]` = -8) characteristic boundary conditions. These are based on [Pirozzoli (2013)](references.md#Pirozzoli13). This enables to provide inflow and outflow conditions outside the computational domain. The parameters associated with this feature are listed in table [Generalized Characteristic Boundary conditions](#generalized-characteristic-boundary-conditions).
833-
832+
This boundary condition can be used for subsonic inflow (`bc_[x,y,z]%[beg,end]` = -7) and subsonic outflow (`bc_[x,y,z]%[beg,end]` = -8) characteristic boundary conditions. These are based on [Pirozzoli (2013)](references.md#Pirozzoli13). This enables to provide inflow and outflow conditions outside the computational domain.
834833

835834
### Patch types
836835

examples/2D_ibm_steady_shock/case.py

Lines changed: 6 additions & 6 deletions
Original file line numberDiff line numberDiff line change
@@ -142,15 +142,15 @@
142142
'bc_x%grcbc_in' : 'T',
143143
'bc_x%grcbc_out' : 'F',
144144
'bc_x%grcbc_vel_out' : 'F',
145-
'bc_x%u_in' : vel,
146-
'bc_x%v_in' : 0,
147-
'bc_x%w_in' : 0,
145+
'bc_x%vel_in(1)' : vel,
146+
'bc_x%vel_in(2)' : 0,
147+
'bc_x%vel_in(3)' : 0,
148148
'bc_x%pres_in' : delta*patm,
149149
'bc_x%alpha_rho_in(1)' : beta*rhoatm,
150150
'bc_x%alpha_in(1)' : 1,
151-
'bc_x%u_out' : vel,
152-
'bc_x%v_out' : 0,
153-
'bc_x%w_out' : 0,
151+
'bc_x%vel_out(1)' : vel,
152+
'bc_x%vel_out(2)' : 0,
153+
'bc_x%vel_out(3)' : 0,
154154
'bc_x%pres_out' : 1.,
155155
# # ========================================================================
156156

examples/2D_zero_circ_vortex/case.py

Lines changed: 6 additions & 6 deletions
Original file line numberDiff line numberDiff line change
@@ -101,15 +101,15 @@
101101
'bc_x%grcbc_in' : 'T',
102102
'bc_x%grcbc_out' : 'T',
103103
'bc_x%grcbc_vel_out' : 'T',
104-
'bc_x%u_in' : u_inf,
105-
'bc_x%v_in' : 0,
106-
'bc_x%w_in' : 0,
104+
'bc_x%vel_in(1)' : u_inf,
105+
'bc_x%vel_in(2)' : 0,
106+
'bc_x%vel_in(3)' : 0,
107107
'bc_x%pres_in' : p_inf,
108108
'bc_x%alpha_rho_in(1)' : rho_inf,
109109
'bc_x%alpha_in(1)' : 1,
110-
'bc_x%u_out' : u_inf,
111-
'bc_x%v_out' : 0,
112-
'bc_x%w_out' : 0,
110+
'bc_x%vel_out(1)' : u_inf,
111+
'bc_x%vel_out(2)' : 0,
112+
'bc_x%vel_out(3)' : 0,
113113
'bc_x%pres_out' : p_inf,
114114
# # ========================================================================
115115

src/common/m_derived_types.fpp

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -79,10 +79,10 @@ module m_derived_types
7979
real(kind(0d0)) :: ve1
8080
real(kind(0d0)) :: ve2
8181
real(kind(0d0)) :: ve3
82-
real(kind(0d0)) :: u_in, v_in, w_in, u_out, v_out, w_out, pres_in, pres_out
82+
real(kind(0d0)) :: pres_in, pres_out
83+
real(kind(0d0)), dimension(3) :: vel_in, vel_out
8384
real(kind(0d0)), dimension(num_fluids_max) :: alpha_rho_in, alpha_in
8485
logical :: grcbc_in, grcbc_out, grcbc_vel_out
85-
8686
end type int_bounds_info
8787

8888
!> Derived type adding beginning (beg) and end bounds info as attributes

src/simulation/m_cbc.fpp

Lines changed: 47 additions & 61 deletions
Original file line numberDiff line numberDiff line change
@@ -102,17 +102,16 @@ module m_cbc
102102
integer :: cbc_dir, cbc_loc
103103
!$acc declare create(dj, bcxb, bcxe, bcyb, bcye, bczb, bcze, cbc_dir, cbc_loc)
104104
105-
real(kind(0d0)) :: ux_in, ux_out, vx_in, vx_out, wx_in, wx_out, presx_in, presx_out, Delx_in, Delx_out
106-
real(kind(0d0)) :: uy_in, uy_out, vy_in, vy_out, wy_in, wy_out, presy_in, presy_out, Dely_in, Dely_out
107-
real(kind(0d0)) :: uz_in, uz_out, vz_in, vz_out, wz_in, wz_out, presz_in, presz_out, Delz_in, Delz_out
108-
!$acc declare create(ux_in, ux_out, vx_in, vx_out, wx_in, wx_out, presx_in, presx_out, Delx_in, Delx_out)
109-
!$acc declare create(uy_in, uy_out, vy_in, vy_out, wy_in, wy_out, presy_in, presy_out, Dely_in, Dely_out)
110-
!$acc declare create(uz_in, uz_out, vz_in, vz_out, wz_in, wz_out, presz_in, presz_out, Delz_in, Delz_out)
111-
112-
real(kind(0d0)), allocatable, dimension(:) :: alpha_rhox_in, alphax_in
113-
real(kind(0d0)), allocatable, dimension(:) :: alpha_rhoy_in, alphay_in
114-
real(kind(0d0)), allocatable, dimension(:) :: alpha_rhoz_in, alphaz_in
115-
!$acc declare create(alpha_rhox_in, alphax_in, alpha_rhoy_in, alphay_in, alpha_rhoz_in, alphaz_in)
105+
!! GRCBC inputs for subsonic inflow and outflow conditions consisting of
106+
!! inflow velocities, pressure, density and void fraction as well as
107+
!! outflow velocities and pressure
108+
109+
real(kind(0d0)), allocatable, dimension(:) :: pres_in, pres_out, Del_in, Del_out
110+
real(kind(0d0)), allocatable, dimension(:, :) :: vel_in, vel_out
111+
real(kind(0d0)), allocatable, dimension(:, :) :: alpha_rho_in, alpha_in
112+
!$acc declare create(pres_in, pres_out, Del_in, Del_out)
113+
!$acc declare create(vel_in, vel_out)
114+
!$acc declare create(alpha_rho_in, alpha_in)
116115
117116
!$acc declare create(q_prim_rsx_vf, q_prim_rsy_vf, q_prim_rsz_vf, F_rsx_vf, F_src_rsx_vf,flux_rsx_vf_l, flux_src_rsx_vf_l, &
118117
!$acc F_rsy_vf, F_src_rsy_vf,flux_rsy_vf_l, flux_src_rsy_vf_l, F_rsz_vf, F_src_rsz_vf,flux_rsz_vf_l, flux_src_rsz_vf_l, &
@@ -404,52 +403,36 @@ contains
404403
!$acc update device(bczb, bcze)
405404
end if
406405
407-
@:ALLOCATE_GLOBAL(alpha_rhox_in(1:num_fluids), alpha_rhoy_in(1:num_fluids), alpha_rhoz_in(1:num_fluids))
408-
@:ALLOCATE_GLOBAL(alphax_in(1:num_fluids), alphay_in(1:num_fluids), alphaz_in(1:num_fluids))
406+
! Allocate GRCBC inputs
407+
@:ALLOCATE(pres_in(1:num_dims), pres_out(1:num_dims))
408+
@:ALLOCATE(Del_in(1:num_dims), Del_out(1:num_dims))
409+
@:ALLOCATE(vel_in(1:num_dims, 1:num_dims), vel_out(1:num_dims, 1:num_dims))
410+
@:ALLOCATE(alpha_rho_in(1:num_fluids, 1:num_dims), alpha_in(1:num_fluids, 1:num_dims))
409411
412+
! Assign and update GRCBC inputs
410413
#:for CBC_DIR, XYZ in [(1, 'x'), (2, 'y'), (3, 'z')]
411-
if (${CBC_DIR}$ == 1) then
412-
u${XYZ}$_in = bc_${XYZ}$%u_in
413-
v${XYZ}$_in = bc_${XYZ}$%v_in
414-
w${XYZ}$_in = bc_${XYZ}$%w_in
415-
u${XYZ}$_out = bc_${XYZ}$%u_out
416-
v${XYZ}$_out = bc_${XYZ}$%v_out
417-
w${XYZ}$_out = bc_${XYZ}$%w_out
418-
Del${XYZ}$_in = maxval(dx)
419-
Del${XYZ}$_out = maxval(dx)
420-
else if (${CBC_DIR}$ == 2) then
421-
u${XYZ}$_in = bc_${XYZ}$%v_in
422-
v${XYZ}$_in = bc_${XYZ}$%u_in
423-
w${XYZ}$_in = bc_${XYZ}$%w_in
424-
u${XYZ}$_out = bc_${XYZ}$%v_out
425-
v${XYZ}$_out = bc_${XYZ}$%u_out
426-
w${XYZ}$_out = bc_${XYZ}$%w_out
414+
if (${CBC_DIR}$ <= num_dims) then
415+
vel_in(${CBC_DIR}$, 1) = bc_${XYZ}$%vel_in(1)
416+
vel_out(${CBC_DIR}$, 1) = bc_${XYZ}$%vel_out(1)
427417
if (n > 0) then
428-
Del${XYZ}$_in = maxval(dy)
429-
Del${XYZ}$_out = maxval(dy)
430-
end if
431-
else if (${CBC_DIR}$ == 3) then
432-
u${XYZ}$_in = bc_${XYZ}$%w_in
433-
v${XYZ}$_in = bc_${XYZ}$%u_in
434-
w${XYZ}$_in = bc_${XYZ}$%v_in
435-
u${XYZ}$_out = bc_${XYZ}$%w_out
436-
v${XYZ}$_out = bc_${XYZ}$%u_out
437-
w${XYZ}$_out = bc_${XYZ}$%v_out
438-
if (p > 0) then
439-
Del${XYZ}$_in = maxval(dz)
440-
Del${XYZ}$_out = maxval(dz)
418+
vel_in(${CBC_DIR}$, 2) = bc_${XYZ}$%vel_in(2)
419+
vel_out(${CBC_DIR}$, 2) = bc_${XYZ}$%vel_out(2)
420+
if (p > 0) then
421+
vel_in(${CBC_DIR}$, 3) = bc_${XYZ}$%vel_in(3)
422+
vel_out(${CBC_DIR}$, 3) = bc_${XYZ}$%vel_out(3)
423+
end if
441424
end if
425+
Del_in(${CBC_DIR}$) = maxval(d${XYZ}$)
426+
Del_out(${CBC_DIR}$) = maxval(d${XYZ}$)
427+
pres_in(${CBC_DIR}$) = bc_${XYZ}$%pres_in
428+
pres_out(${CBC_DIR}$) = bc_${XYZ}$%pres_out
429+
do i = 1, num_fluids
430+
alpha_rho_in(i, ${CBC_DIR}$) = bc_${XYZ}$%alpha_rho_in(i)
431+
alpha_in(i, ${CBC_DIR}$) = bc_${XYZ}$%alpha_in(i)
432+
end do
442433
end if
443-
pres${XYZ}$_in = bc_${XYZ}$%pres_in
444-
pres${XYZ}$_out = bc_${XYZ}$%pres_out
445-
do i = 1, num_fluids
446-
alpha_rho${XYZ}$_in(i) = bc_${XYZ}$%alpha_rho_in(i)
447-
alpha${XYZ}$_in(i) = bc_${XYZ}$%alpha_in(i)
448-
end do
449-
!$acc update device(u${XYZ}$_in, v${XYZ}$_in, w${XYZ}$_in, u${XYZ}$_out, v${XYZ}$_out, w${XYZ}$_out)
450-
!$acc update device(pres${XYZ}$_in, pres${XYZ}$_out, alpha_rho${XYZ}$_in, alpha${XYZ}$_in)
451-
!$acc update device(Del${XYZ}$_in, Del${XYZ}$_out)
452434
#:endfor
435+
!$acc update device(vel_in, vel_out, pres_in, pres_out, Del_in, Del_out, alpha_rho_in, alpha_in)
453436
454437
end subroutine s_initialize_cbc_module
455438
@@ -895,33 +878,33 @@ contains
895878
call s_compute_nonreflecting_subsonic_buffer_L(lambda, L, rho, c, mf, dalpha_rho_ds, dpres_ds, dvel_ds, dadv_ds)
896879
else if ((cbc_loc == -1 .and. bc${XYZ}$b == -7) .or. (cbc_loc == 1 .and. bc${XYZ}$e == -7)) then
897880
call s_compute_nonreflecting_subsonic_inflow_L(lambda, L, rho, c, mf, dalpha_rho_ds, dpres_ds, dvel_ds, dadv_ds)
898-
!Add GRCBC for Subsonic Inflow
881+
! Add GRCBC for Subsonic Inflow
899882
if (bc_${XYZ}$%grcbc_in) then
900883
!$acc loop seq
901884
do i = 2, momxb
902-
L(2) = c**3d0*Ma*(alpha_rho(i - 1) - alpha_rho${XYZ}$_in(i - 1))/Del${XYZ}$_in - c*Ma*(pres - pres${XYZ}$_in)/Del${XYZ}$_in
885+
L(2) = c**3d0*Ma*(alpha_rho(i - 1) - alpha_rho_in(i - 1, ${CBC_DIR}$))/Del_in(${CBC_DIR}$) - c*Ma*(pres - pres_in(${CBC_DIR}$))/Del_in(${CBC_DIR}$)
903886
end do
904887
if (n > 0) then
905-
L(momxb + 1) = c*Ma*(vel(dir_idx(2)) - v${XYZ}$_in)/Del${XYZ}$_in
888+
L(momxb + 1) = c*Ma*(vel(dir_idx(2)) - vel_in(${CBC_DIR}$, dir_idx(2)))/Del_in(${CBC_DIR}$)
906889
if (p > 0) then
907-
L(momxb + 2) = c*Ma*(vel(dir_idx(3)) - w${XYZ}$_in)/Del${XYZ}$_in
890+
L(momxb + 2) = c*Ma*(vel(dir_idx(3)) - vel_in(${CBC_DIR}$, dir_idx(3)))/Del_in(${CBC_DIR}$)
908891
end if
909892
end if
910893
!$acc loop seq
911894
do i = E_idx, advxe - 1
912-
L(i) = c*Ma*(adv(i + 1 - E_idx) - alpha${XYZ}$_in(i + 1 - E_idx))/Del${XYZ}$_in
895+
L(i) = c*Ma*(adv(i + 1 - E_idx) - alpha_in(i + 1 - E_idx, ${CBC_DIR}$))/Del_in(${CBC_DIR}$)
913896
end do
914-
L(advxe) = rho*c**2d0*(1d0 + Ma)*(vel(dir_idx(1)) + u${XYZ}$_in*sign(1, cbc_loc))/Del${XYZ}$_in + c*(1d0 + Ma)*(pres - pres${XYZ}$_in)/Del${XYZ}$_in
897+
L(advxe) = rho*c**2d0*(1d0 + Ma)*(vel(dir_idx(1)) + vel_in(${CBC_DIR}$, dir_idx(1))*sign(1, cbc_loc))/Del_in(${CBC_DIR}$) + c*(1d0 + Ma)*(pres - pres_in(${CBC_DIR}$))/Del_in(${CBC_DIR}$)
915898
end if
916899
else if ((cbc_loc == -1 .and. bc${XYZ}$b == -8) .or. (cbc_loc == 1 .and. bc${XYZ}$e == -8)) then
917900
call s_compute_nonreflecting_subsonic_outflow_L(lambda, L, rho, c, mf, dalpha_rho_ds, dpres_ds, dvel_ds, dadv_ds)
918-
!Add GRCBC for Subsonic Outflow (Pressure)
901+
! Add GRCBC for Subsonic Outflow (Pressure)
919902
if (bc_${XYZ}$%grcbc_out) then
920-
L(advxe) = c*(1d0 - Ma)*(pres - pres${XYZ}$_out)/Del${XYZ}$_out
903+
L(advxe) = c*(1d0 - Ma)*(pres - pres_out(${CBC_DIR}$))/Del_out(${CBC_DIR}$)
921904
922-
!Add GRCBC for Subsonic Outflow (Normal Velocity)
905+
! Add GRCBC for Subsonic Outflow (Normal Velocity)
923906
if (bc_${XYZ}$%grcbc_vel_out) then
924-
L(advxe) = L(advxe) + rho*c**2d0*(1d0 - Ma)*(vel(dir_idx(1)) + u${XYZ}$_out*sign(1, cbc_loc))/Del${XYZ}$_out
907+
L(advxe) = L(advxe) + rho*c**2d0*(1d0 - Ma)*(vel(dir_idx(1)) + vel_out(${CBC_DIR}$, dir_idx(1))*sign(1, cbc_loc))/Del_out(${CBC_DIR}$)
925908
end if
926909
end if
927910
else if ((cbc_loc == -1 .and. bc${XYZ}$b == -9) .or. (cbc_loc == 1 .and. bc${XYZ}$e == -9)) then
@@ -1582,6 +1565,9 @@ contains
15821565
! Deallocating the cell-width distribution in the s-direction
15831566
@:DEALLOCATE(ds)
15841567
1568+
! Deallocating GRCBC inputs
1569+
@:DEALLOCATE(vel_in, vel_out, pres_in, pres_out, Del_in, Del_out, alpha_rho_in, alpha_in)
1570+
15851571
! Deallocating CBC Coefficients in x-direction =====================
15861572
if (any((/bc_x%beg, bc_x%end/) <= -5) .and. any((/bc_x%beg, bc_x%end/) >= -13)) then
15871573
@:DEALLOCATE(fd_coef_x)

src/simulation/m_global_parameters.fpp

Lines changed: 6 additions & 11 deletions
Original file line numberDiff line numberDiff line change
@@ -670,17 +670,12 @@ contains
670670
integral(i)%ymax = dflt_real
671671
end do
672672

673-
bc_x%grcbc_in = .false.
674-
bc_x%grcbc_out = .false.
675-
bc_x%grcbc_vel_out = .false.
676-
677-
bc_y%grcbc_in = .false.
678-
bc_y%grcbc_out = .false.
679-
bc_y%grcbc_vel_out = .false.
680-
681-
bc_z%grcbc_in = .false.
682-
bc_z%grcbc_out = .false.
683-
bc_z%grcbc_vel_out = .false.
673+
! GRCBC flags
674+
#:for dir in {'x', 'y', 'z'}
675+
bc_${dir}$%grcbc_in = .false.
676+
bc_${dir}$%grcbc_out = .false.
677+
bc_${dir}$%grcbc_vel_out = .false.
678+
#:endfor
684679

685680
end subroutine s_assign_default_values_to_user_inputs
686681

src/simulation/m_mpi_proxy.fpp

Lines changed: 8 additions & 6 deletions
Original file line numberDiff line numberDiff line change
@@ -215,19 +215,21 @@ contains
215215
#:for VAR in [ 'dt','weno_eps','teno_CT','pref','rhoref','R0ref','Web','Ca', 'sigma', &
216216
& 'Re_inv', 'poly_sigma', 'palpha_eps', 'ptgalpha_eps', 'pi_fac', &
217217
& 'bc_x%vb1','bc_x%vb2','bc_x%vb3','bc_x%ve1','bc_x%ve2','bc_x%ve2', &
218-
& 'bc_x%u_in','bc_x%v_in','bc_x%w_in','bc_x%u_out','bc_x%v_out','bc_x%w_out', &
219-
& 'bc_x%pres_in','bc_x%pres_out', &
220218
& 'bc_y%vb1','bc_y%vb2','bc_y%vb3','bc_y%ve1','bc_y%ve2','bc_y%ve3', &
221-
& 'bc_y%u_in','bc_y%v_in','bc_y%w_in','bc_y%u_out','bc_y%v_out','bc_y%w_out', &
222-
& 'bc_y%pres_in','bc_y%pres_out', &
223219
& 'bc_z%vb1','bc_z%vb2','bc_z%vb3','bc_z%ve1','bc_z%ve2','bc_z%ve3', &
224-
& 'bc_z%u_in','bc_z%v_in','bc_z%w_in','bc_z%u_out','bc_z%v_out','bc_z%w_out', &
225-
& 'bc_z%pres_in','bc_z%pres_out', &
220+
& 'bc_x%pres_in','bc_x%pres_out','bc_y%pres_in','bc_y%pres_out', 'bc_z%pres_in','bc_z%pres_out', &
226221
& 'x_domain%beg', 'x_domain%end', 'y_domain%beg', 'y_domain%end', &
227222
& 'z_domain%beg', 'z_domain%end', 't_stop', 't_save', 'cfl_target']
228223
call MPI_BCAST(${VAR}$, 1, MPI_DOUBLE_PRECISION, 0, MPI_COMM_WORLD, ierr)
229224
#:endfor
230225
226+
do i = 1, 3
227+
#:for VAR in [ 'bc_x%vel_in', 'bc_x%vel_out', 'bc_y%vel_in', 'bc_y%vel_out', &
228+
& 'bc_z%vel_in', 'bc_z%vel_out']
229+
call MPI_BCAST(${VAR}$ (i), 1, MPI_DOUBLE_PRECISION, 0, MPI_COMM_WORLD, ierr)
230+
#:endfor
231+
end do
232+
231233
#:if not MFC_CASE_OPTIMIZATION
232234
call MPI_BCAST(mapped_weno, 1, MPI_LOGICAL, 0, MPI_COMM_WORLD, ierr)
233235
call MPI_BCAST(wenoz, 1, MPI_LOGICAL, 0, MPI_COMM_WORLD, ierr)

src/simulation/m_start_up.fpp

Lines changed: 4 additions & 7 deletions
Original file line numberDiff line numberDiff line change
@@ -1574,13 +1574,10 @@ contains
15741574

15751575
!$acc update device(dx, dy, dz, x_cb, x_cc, y_cb, y_cc, z_cb, z_cc)
15761576

1577-
!$acc update device(bc_x%vb1, bc_x%vb2, bc_x%vb3, bc_x%ve1, bc_x%ve2, bc_x%ve3)
1578-
!$acc update device(bc_y%vb1, bc_y%vb2, bc_y%vb3, bc_y%ve1, bc_y%ve2, bc_y%ve3)
1579-
!$acc update device(bc_z%vb1, bc_z%vb2, bc_z%vb3, bc_z%ve1, bc_z%ve2, bc_z%ve3)
1580-
1581-
!$acc update device(bc_x%grcbc_in, bc_x%grcbc_out, bc_x%grcbc_vel_out)
1582-
!$acc update device(bc_y%grcbc_in, bc_y%grcbc_out, bc_y%grcbc_vel_out)
1583-
!$acc update device(bc_z%grcbc_in, bc_z%grcbc_out, bc_z%grcbc_vel_out)
1577+
#:for VAR in [ 'x','y','z' ]
1578+
!$acc update device(bc_{VAR}%vb1, bc_{VAR}%vb2, bc_{VAR}%vb3, bc_{VAR}%ve1, bc_{VAR}%ve2, bc_{VAR}%ve3)
1579+
!$acc update device(bc_{VAR}%grcbc_in, bc_{VAR}%grcbc_out, bc_{VAR}%grcbc_vel_out)
1580+
#:endfor
15841581

15851582
!$acc update device(relax, relax_model)
15861583
if (relax) then

0 commit comments

Comments
 (0)