27 double precision,
protected :: small_e
29 double precision,
public,
protected ::
small_r_e = 0.d0
38 double precision :: divbdiff = 0.8d0
43 double precision,
public,
protected ::
h_ion_fr=1d0
46 double precision,
public,
protected ::
he_ion_fr=1d0
53 double precision,
public,
protected ::
rr=1d0
55 double precision :: gamma_1, inv_gamma_1
57 double precision :: inv_squared_c0, inv_squared_c
64 integer,
public,
protected ::
rho_
66 integer,
allocatable,
public,
protected ::
mom(:)
68 integer,
public,
protected :: ^
c&m^C_
70 integer,
public,
protected ::
e_
72 integer,
public,
protected ::
r_e
74 integer,
public,
protected :: ^
c&b^C_
76 integer,
public,
protected ::
p_
78 integer,
public,
protected ::
q_
80 integer,
public,
protected ::
psi_
82 integer,
public,
protected ::
te_
87 integer,
allocatable,
public,
protected ::
tracer(:)
95 integer,
parameter :: divb_none = 0
96 integer,
parameter :: divb_multigrid = -1
97 integer,
parameter :: divb_glm = 1
98 integer,
parameter :: divb_powel = 2
99 integer,
parameter :: divb_janhunen = 3
100 integer,
parameter :: divb_linde = 4
101 integer,
parameter :: divb_lindejanhunen = 5
102 integer,
parameter :: divb_lindepowel = 6
103 integer,
parameter :: divb_lindeglm = 7
104 integer,
parameter :: divb_ct = 8
145 logical :: compactres = .false.
163 logical,
protected :: radio_acoustic_filter = .false.
164 integer,
protected :: size_ra_filter = 1
168 logical :: dt_c = .false.
178 logical :: total_energy = .true.
182 logical :: gravity_energy
184 logical :: gravity_rhov = .false.
186 character(len=std_len),
public,
protected ::
typedivbfix =
'linde'
188 character(len=std_len),
public,
protected ::
type_ct =
'uct_contact'
190 character(len=std_len) :: typedivbdiff =
'all'
230 subroutine rmhd_read_params(files)
233 character(len=*),
intent(in) :: files(:)
251 do n = 1,
size(files)
252 open(
unitpar, file=trim(files(n)), status=
"old")
253 read(
unitpar, rmhd_list,
end=111)
257 end subroutine rmhd_read_params
260 subroutine rmhd_write_info(fh)
262 integer,
intent(in) :: fh
264 integer,
parameter :: n_par = 1
265 double precision :: values(n_par)
266 integer,
dimension(MPI_STATUS_SIZE) :: st
267 character(len=name_len) :: names(n_par)
269 call mpi_file_write(fh, n_par, 1, mpi_integer, st, er)
273 call mpi_file_write(fh, values, n_par, mpi_double_precision, st, er)
274 call mpi_file_write(fh, names, n_par * name_len, mpi_character, st, er)
275 end subroutine rmhd_write_info
301 if(
mype==0)
write(*,*)
'WARNING: set rmhd_partial_ionization=F when eq_state_units=F'
307 if(
mype==0)
write(*,*)
'WARNING: turn off parabolic TC when using hyperbolic TC'
310 physics_type =
"rmhd"
325 phys_total_energy=total_energy
327 gravity_energy=.true.
332 gravity_energy=.false.
338 if(
mype==0)
write(*,*)
'WARNING: reset rmhd_trac_type=1 for 1D simulation'
343 if(
mype==0)
write(*,*)
'WARNING: set rmhd_trac_mask==bigdouble for global TRAC method'
352 type_divb = divb_none
355 type_divb = divb_multigrid
357 mg%operator_type = mg_laplacian
364 case (
'powel',
'powell')
365 type_divb = divb_powel
367 type_divb = divb_janhunen
369 type_divb = divb_linde
370 case (
'lindejanhunen')
371 type_divb = divb_lindejanhunen
373 type_divb = divb_lindepowel
377 type_divb = divb_lindeglm
382 call mpistop(
'Unknown divB fix')
385 allocate(start_indices(number_species),stop_indices(number_species))
392 mom(:) = var_set_momentum(
ndir)
398 e_ = var_set_energy()
407 mag(:) = var_set_bfield(
ndir)
411 psi_ = var_set_fluxvar(
'psi',
'psi', need_bc=.false.)
417 r_e = var_set_radiation_energy()
430 tracer(itr) = var_set_fluxvar(
"trc",
"trp", itr, need_bc=.false.)
443 te_ = var_set_auxvar(
'Te',
'Te')
452 stop_indices(1)=nwflux
482 allocate(iw_vector(nvector))
483 iw_vector(1) = mom(1) - 1
484 iw_vector(2) = mag(1) - 1
487 if (.not.
allocated(flux_type))
then
488 allocate(flux_type(
ndir, nwflux))
489 flux_type = flux_default
490 else if (any(shape(flux_type) /= [
ndir, nwflux]))
then
491 call mpistop(
"phys_check error: flux_type has wrong shape")
494 if(nwflux>mag(
ndir))
then
496 flux_type(:,mag(
ndir)+1:nwflux)=flux_hll
501 flux_type(:,
psi_)=flux_special
503 flux_type(idir,mag(idir))=flux_special
507 flux_type(idir,mag(idir))=flux_tvdlf
513 phys_get_dt => rmhd_get_dt
514 phys_get_cmax => rmhd_get_cmax_origin
515 phys_get_a2max => rmhd_get_a2max
516 phys_get_tcutoff => rmhd_get_tcutoff
517 phys_get_h_speed => rmhd_get_h_speed
519 phys_get_cbounds => rmhd_get_cbounds_split_rho
521 phys_get_cbounds => rmhd_get_cbounds
524 phys_to_primitive => rmhd_to_primitive_split_rho
526 phys_to_conserved => rmhd_to_conserved_split_rho
529 phys_to_primitive => rmhd_to_primitive_origin
531 phys_to_conserved => rmhd_to_conserved_origin
535 phys_get_flux => rmhd_get_flux_split
537 phys_get_flux => rmhd_get_flux
541 phys_add_source_geom => rmhd_add_source_geom_split
543 phys_add_source_geom => rmhd_add_source_geom
545 phys_add_source => rmhd_add_source
546 phys_check_params => rmhd_check_params
547 phys_write_info => rmhd_write_info
549 phys_handle_small_values => rmhd_handle_small_values_origin
550 rmhd_handle_small_values => rmhd_handle_small_values_origin
551 phys_check_w => rmhd_check_w_origin
557 phys_get_pthermal => rmhd_get_pthermal_origin
561 phys_set_equi_vars => set_equi_vars_grid
564 if(type_divb==divb_glm)
then
565 phys_modify_wlr => rmhd_modify_wlr
570 rmhd_get_rfactor=>rfactor_from_temperature_ionization
571 phys_update_temperature => rmhd_update_temperature
575 rmhd_get_rfactor=>rfactor_from_constant_ionization
590 phys_get_ct_velocity => rmhd_get_ct_velocity
591 phys_update_faces => rmhd_update_faces
593 phys_modify_wlr => rmhd_modify_wlr
595 phys_boundary_adjust => rmhd_boundary_adjust
604 call rmhd_physical_units()
613 call mpistop(
'Radiation formalism unknown')
620 call mpistop(
"thermal conduction needs rmhd_energy=T")
623 call mpistop(
"hyperbolic thermal conduction needs rmhd_energy=T")
633 call add_sts_method(rmhd_get_tc_dt_rmhd,rmhd_sts_set_source_tc_rmhd,e_,1,e_,1,.false.)
635 tc_fl%get_temperature_from_conserved => rmhd_get_temperature_from_etot_with_equi
637 tc_fl%get_temperature_from_conserved => rmhd_get_temperature_from_etot
640 tc_fl%get_temperature_from_eint => rmhd_get_temperature_from_eint_with_equi
642 tc_fl%has_equi = .true.
643 tc_fl%get_temperature_equi => rmhd_get_temperature_equi
644 tc_fl%get_rho_equi => rmhd_get_rho_equi
646 tc_fl%has_equi = .false.
649 tc_fl%get_temperature_from_eint => rmhd_get_temperature_from_eint
661 te_fl_rmhd%get_var_Rfactor => rmhd_get_rfactor
663 phys_te_images => rmhd_te_images
676 if (particles_eta < zero) particles_eta =
rmhd_eta
677 if (particles_etah < zero) particles_eta =
rmhd_etah
679 write(*,*)
'*****Using particles: with rmhd_eta, rmhd_etah :',
rmhd_eta,
rmhd_etah
680 write(*,*)
'*****Using particles: particles_eta, particles_etah :', particles_eta, particles_etah
692 subroutine rmhd_te_images
697 case(
'EIvtiCCmpi',
'EIvtuCCmpi')
699 case(
'ESvtiCCmpi',
'ESvtuCCmpi')
701 case(
'SIvtiCCmpi',
'SIvtuCCmpi')
703 case(
'WIvtiCCmpi',
'WIvtuCCmpi')
706 call mpistop(
"Error in synthesize emission: Unknown convert_type")
708 end subroutine rmhd_te_images
714 subroutine rmhd_sts_set_source_tc_rmhd(ixI^L,ixO^L,w,x,wres,fix_conserve_at_step,my_dt,igrid,nflux)
718 integer,
intent(in) :: ixi^
l, ixo^
l, igrid, nflux
719 double precision,
intent(in) :: x(ixi^s,1:
ndim)
720 double precision,
intent(inout) :: wres(ixi^s,1:nw), w(ixi^s,1:nw)
721 double precision,
intent(in) :: my_dt
722 logical,
intent(in) :: fix_conserve_at_step
724 end subroutine rmhd_sts_set_source_tc_rmhd
726 function rmhd_get_tc_dt_rmhd(w,ixI^L,ixO^L,dx^D,x)
result(dtnew)
732 integer,
intent(in) :: ixi^
l, ixo^
l
733 double precision,
intent(in) ::
dx^
d, x(ixi^s,1:
ndim)
734 double precision,
intent(in) :: w(ixi^s,1:nw)
735 double precision :: dtnew
738 end function rmhd_get_tc_dt_rmhd
740 subroutine rmhd_tc_handle_small_e(w, x, ixI^L, ixO^L, step)
742 integer,
intent(in) :: ixi^
l,ixo^
l
743 double precision,
intent(inout) :: w(ixi^s,1:nw)
744 double precision,
intent(in) :: x(ixi^s,1:
ndim)
745 integer,
intent(in) :: step
746 character(len=140) :: error_msg
748 write(error_msg,
"(a,i3)")
"Thermal conduction step ", step
749 call rmhd_handle_small_ei(w,x,ixi^
l,ixo^
l,
e_,error_msg)
750 end subroutine rmhd_tc_handle_small_e
753 subroutine tc_params_read_rmhd(fl)
755 type(tc_fluid),
intent(inout) :: fl
756 double precision :: tc_k_para=0d0
757 double precision :: tc_k_perp=0d0
760 logical :: tc_perpendicular=.false.
761 logical :: tc_saturate=.false.
762 character(len=std_len) :: tc_slope_limiter=
"MC"
764 namelist /tc_list/ tc_perpendicular, tc_saturate, tc_slope_limiter, tc_k_para, tc_k_perp
768 read(
unitpar, tc_list,
end=111)
772 fl%tc_perpendicular = tc_perpendicular
773 fl%tc_saturate = tc_saturate
774 fl%tc_k_para = tc_k_para
775 fl%tc_k_perp = tc_k_perp
776 select case(tc_slope_limiter)
778 fl%tc_slope_limiter = 0
781 fl%tc_slope_limiter = 1
784 fl%tc_slope_limiter = 2
787 fl%tc_slope_limiter = 3
790 fl%tc_slope_limiter = 4
792 call mpistop(
"Unknown tc_slope_limiter, choose MC, minmod")
794 end subroutine tc_params_read_rmhd
798 subroutine set_equi_vars_grid_faces(igrid,x,ixI^L,ixO^L)
801 integer,
intent(in) :: igrid, ixi^
l, ixo^
l
802 double precision,
intent(in) :: x(ixi^s,1:
ndim)
803 double precision :: delx(ixi^s,1:
ndim)
804 double precision :: xc(ixi^s,1:
ndim),xshift^
d
805 integer :: idims, ixc^
l, hxo^
l, ix, idims2
811 delx(ixi^s,1:
ndim)=ps(igrid)%dx(ixi^s,1:
ndim)
815 hxo^
l=ixo^
l-
kr(idims,^
d);
821 ixcmax^
d=ixomax^
d; ixcmin^
d=hxomin^
d;
824 xshift^
d=half*(one-
kr(^
d,idims));
831 xc(ix^
d%ixC^s,^
d)=x(ix^
d%ixC^s,^
d)+(half-xshift^
d)*delx(ix^
d%ixC^s,^
d)
835 call usr_set_equi_vars(ixi^l,ixc^l,xc,ps(igrid)%equi_vars(ixi^s,1:number_equi_vars,idims))
837 end subroutine set_equi_vars_grid_faces
840 subroutine set_equi_vars_grid(igrid)
843 integer,
intent(in) :: igrid
849 call set_equi_vars_grid_faces(igrid,ps(igrid)%x,ixg^
ll,
ixm^
ll)
850 end subroutine set_equi_vars_grid
853 function convert_vars_splitting(ixI^L,ixO^L, w, x, nwc)
result(wnew)
855 integer,
intent(in) :: ixi^
l,ixo^
l, nwc
856 double precision,
intent(in) :: w(ixi^s, 1:nw)
857 double precision,
intent(in) :: x(ixi^s,1:
ndim)
858 double precision :: wnew(ixo^s, 1:nwc)
865 wnew(ixo^s,
mom(:))=w(ixo^s,
mom(:))
871 wnew(ixo^s,mag(1:
ndir))=w(ixo^s,mag(1:
ndir))
875 wnew(ixo^s,
e_)=w(ixo^s,
e_)
879 if(
b0field .and. total_energy)
then
880 wnew(ixo^s,
e_)=wnew(ixo^s,
e_)+0.5d0*sum(
block%B0(ixo^s,:,0)**2,dim=
ndim+1) &
881 + sum(w(ixo^s,mag(:))*
block%B0(ixo^s,:,0),dim=
ndim+1)
884 end function convert_vars_splitting
886 subroutine rmhd_check_params
894 if (
rmhd_gamma <= 0.0d0)
call mpistop (
"Error: rmhd_gamma <= 0")
895 if (
rmhd_adiab < 0.0d0)
call mpistop (
"Error: rmhd_adiab < 0")
899 call mpistop (
"Error: rmhd_gamma <= 0 or rmhd_gamma == 1")
900 inv_gamma_1=1.d0/gamma_1
907 call mpistop(
"usr_set_equi_vars has to be implemented in the user file")
912 if(
mype .eq. 0) print*,
" add conversion method: split -> full "
919 end subroutine rmhd_check_params
933 mg%bc(ib, mg_iphi)%bc_type = mg_bc_neumann
934 mg%bc(ib, mg_iphi)%bc_value = 0.0_dp
937 mg%bc(ib, mg_iphi)%bc_type = mg_bc_dirichlet
938 mg%bc(ib, mg_iphi)%bc_value = 0.0_dp
942 mg%bc(ib, mg_iphi)%bc_type = mg_bc_neumann
943 mg%bc(ib, mg_iphi)%bc_value = 0.0_dp
951 call mpistop(
"divE_multigrid warning: unknown b.c. ")
956 subroutine rmhd_physical_units()
958 double precision :: mp,kb,miu0,c_lightspeed
959 double precision :: a,
b
1024 end subroutine rmhd_physical_units
1026 subroutine rmhd_check_w_origin(primitive,ixI^L,ixO^L,w,flag)
1028 logical,
intent(in) :: primitive
1029 integer,
intent(in) :: ixi^
l, ixo^
l
1030 double precision,
intent(in) :: w(ixi^s,nw)
1031 logical,
intent(inout) :: flag(ixi^s,1:nw)
1032 double precision :: tmp
1036 {
do ix^db=ixomin^db,ixomax^db\}
1050 tmp=w(ix^
d,
e_)-half*((^
c&w(ix^
d,
m^
c_)**2+)/tmp+(^
c&w(ix^
d,
b^
c_)**2+))
1054 if(tmp<small_e) flag(ix^
d,
e_) = .true.
1059 end subroutine rmhd_check_w_origin
1062 subroutine rmhd_to_conserved_origin(ixI^L,ixO^L,w,x)
1064 integer,
intent(in) :: ixi^
l, ixo^
l
1065 double precision,
intent(inout) :: w(ixi^s, nw)
1066 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1069 {
do ix^db=ixomin^db,ixomax^db\}
1071 w(ix^
d,
e_)=w(ix^
d,
p_)*inv_gamma_1&
1073 +(^
c&w(ix^
d,
b^
c_)**2+))
1077 end subroutine rmhd_to_conserved_origin
1080 subroutine rmhd_to_conserved_split_rho(ixI^L,ixO^L,w,x)
1082 integer,
intent(in) :: ixi^
l, ixo^
l
1083 double precision,
intent(inout) :: w(ixi^s, nw)
1084 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1085 double precision :: rho
1088 {
do ix^db=ixomin^db,ixomax^db\}
1091 w(ix^
d,
e_)=w(ix^
d,
p_)*inv_gamma_1&
1092 +half*((^
c&w(ix^
d,
m^
c_)**2+)*rho&
1093 +(^
c&w(ix^
d,
b^
c_)**2+))
1097 end subroutine rmhd_to_conserved_split_rho
1100 subroutine rmhd_to_primitive_origin(ixI^L,ixO^L,w,x)
1102 integer,
intent(in) :: ixi^
l, ixo^
l
1103 double precision,
intent(inout) :: w(ixi^s, nw)
1104 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1105 double precision :: inv_rho
1110 call rmhd_handle_small_values(.false., w, x, ixi^
l, ixo^
l,
'rmhd_to_primitive_origin')
1113 {
do ix^db=ixomin^db,ixomax^db\}
1114 inv_rho = 1.d0/w(ix^
d,
rho_)
1118 w(ix^
d,
p_)=gamma_1*(w(ix^
d,
e_)&
1120 +(^
c&w(ix^
d,
b^
c_)**2+)))
1122 end subroutine rmhd_to_primitive_origin
1125 subroutine rmhd_to_primitive_split_rho(ixI^L,ixO^L,w,x)
1127 integer,
intent(in) :: ixi^
l, ixo^
l
1128 double precision,
intent(inout) :: w(ixi^s, nw)
1129 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1130 double precision :: inv_rho
1135 call rmhd_handle_small_values(.false., w, x, ixi^
l, ixo^
l,
'rmhd_to_primitive_split_rho')
1138 {
do ix^db=ixomin^db,ixomax^db\}
1143 w(ix^
d,
p_)=gamma_1*(w(ix^
d,
e_)&
1145 (^
c&w(ix^
d,
m^
c_)**2+)+(^
c&w(ix^
d,
b^
c_)**2+)))
1147 end subroutine rmhd_to_primitive_split_rho
1152 integer,
intent(in) :: ixi^
l, ixo^
l
1153 double precision,
intent(inout) :: w(ixi^s, nw)
1154 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1159 {
do ix^db=ixomin^db,ixomax^db\}
1162 +half*((^
c&w(ix^
d,
m^
c_)**2+)/&
1164 +(^
c&w(ix^
d,
b^
c_)**2+))
1167 {
do ix^db=ixomin^db,ixomax^db\}
1169 w(ix^d,
e_)=w(ix^d,
e_)&
1170 +half*((^
c&w(ix^d,
m^
c_)**2+)/w(ix^d,
rho_)&
1171 +(^
c&w(ix^d,
b^
c_)**2+))
1179 integer,
intent(in) :: ixi^
l, ixo^
l
1180 double precision,
intent(inout) :: w(ixi^s, nw)
1181 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1186 {
do ix^db=ixomin^db,ixomax^db\}
1189 -half*((^
c&w(ix^
d,
m^
c_)**2+)/&
1191 +(^
c&w(ix^
d,
b^
c_)**2+))
1194 {
do ix^db=ixomin^db,ixomax^db\}
1196 w(ix^d,
e_)=w(ix^d,
e_)&
1197 -half*((^
c&w(ix^d,
m^
c_)**2+)/w(ix^d,
rho_)&
1198 +(^
c&w(ix^d,
b^
c_)**2+))
1202 if(fix_small_values)
then
1203 call rmhd_handle_small_ei(w,x,ixi^l,ixi^l,
e_,
'rmhd_e_to_ei')
1207 subroutine rmhd_handle_small_values_origin(primitive, w, x, ixI^L, ixO^L, subname)
1210 logical,
intent(in) :: primitive
1211 integer,
intent(in) :: ixi^
l,ixo^
l
1212 double precision,
intent(inout) :: w(ixi^s,1:nw)
1213 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1214 character(len=*),
intent(in) :: subname
1215 double precision :: rho
1216 integer :: idir, ix^
d
1217 logical :: flag(ixi^s,1:nw)
1219 call phys_check_w(primitive, ixi^
l, ixi^
l, w, flag)
1223 {
do ix^db=ixomin^db,ixomax^db\}
1233 if(flag({ix^
d},
rho_)) w({ix^
d},
m^
c_)=0.0d0
1245 w(ix^
d,
e_)=small_e+half*((^
c&w(ix^
d,
m^
c_)**2+)/rho+(^
c&w(ix^
d,
b^
c_)**2+))&
1249 w(ix^
d,
e_)=small_e+half*((^
c&w(ix^
d,
m^
c_)**2+)/rho+(^
c&w(ix^
d,
b^
c_)**2+))
1256 call small_values_average(ixi^l, ixo^l, w, x, flag,
rho_)
1258 call small_values_average(ixi^l, ixo^l, w, x, flag,
p_)
1261 {
do ix^db=iximin^db,iximax^db\}
1267 w(ix^d,
e_)=w(ix^d,
e_)&
1268 -half*((^
c&w(ix^d,
m^
c_)**2+)/rho+(^
c&w(ix^d,
b^
c_)**2+))
1270 call small_values_average(ixi^l, ixo^l, w, x, flag,
e_)
1272 {
do ix^db=iximin^db,iximax^db\}
1278 w(ix^d,
e_)=w(ix^d,
e_)&
1279 +half*((^
c&w(ix^d,
m^
c_)**2+)/rho+(^
c&w(ix^d,
b^
c_)**2+))
1282 call small_values_average(ixi^l, ixo^l, w, x, flag,
r_e)
1284 if(.not.primitive)
then
1287 {
do ix^db=iximin^db,iximax^db\}
1293 ^
c&w(ix^d,
m^
c_)=w(ix^d,
m^
c_)/rho\
1294 w(ix^d,
p_)=gamma_1*(w(ix^d,
e_)&
1295 -half*((^
c&w(ix^d,
m^
c_)**2+)/rho+(^
c&w(ix^d,
b^
c_)**2+)))
1298 call small_values_error(w, x, ixi^l, ixo^l, flag, subname)
1301 end subroutine rmhd_handle_small_values_origin
1306 integer,
intent(in) :: ixi^
l, ixo^
l
1307 double precision,
intent(in) :: w(ixi^s,nw), x(ixi^s,1:
ndim)
1308 double precision,
intent(out) :: v(ixi^s,
ndir)
1309 double precision :: rho(ixi^s)
1313 rho(ixo^s)=1.d0/rho(ixo^s)
1316 v(ixo^s, idir) = w(ixo^s,
mom(idir))*rho(ixo^s)
1321 subroutine rmhd_get_cmax_origin(w,x,ixI^L,ixO^L,idim,cmax)
1323 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1324 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1325 double precision,
intent(inout) :: cmax(ixi^s)
1326 double precision :: rho, inv_rho, cfast2, avmincs2, b2, kmax
1330 {
do ix^db=ixomin^db,ixomax^db \}
1341 cfast2=b2*inv_rho+cmax(ix^
d)
1342 avmincs2=cfast2**2-4.0d0*cmax(ix^
d)*(w(ix^
d,mag(idim))+
block%B0(ix^
d,idim,
b0i))**2*inv_rho
1343 if(avmincs2<zero) avmincs2=zero
1344 cmax(ix^
d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1345 cmax(ix^
d)=abs(w(ix^
d,
mom(idim)))+cmax(ix^
d)
1348 {
do ix^db=ixomin^db,ixomax^db \}
1358 b2=(^
c&w(ix^d,
b^
c_)**2+)
1359 cfast2=b2*inv_rho+cmax(ix^d)
1360 avmincs2=cfast2**2-4.0d0*cmax(ix^d)*w(ix^d,mag(idim))**2*inv_rho
1361 if(avmincs2<zero) avmincs2=zero
1362 cmax(ix^d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1363 cmax(ix^d)=abs(w(ix^d,
mom(idim)))+cmax(ix^d)
1366 end subroutine rmhd_get_cmax_origin
1368 subroutine rmhd_get_a2max(w,x,ixI^L,ixO^L,a2max)
1370 integer,
intent(in) :: ixi^
l, ixo^
l
1371 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1372 double precision,
intent(inout) :: a2max(
ndim)
1373 double precision :: a2(ixi^s,
ndim,nw)
1374 integer :: gxo^
l,hxo^
l,jxo^
l,kxo^
l,i,j
1379 hxo^
l=ixo^
l-
kr(i,^
d);
1380 gxo^
l=hxo^
l-
kr(i,^
d);
1381 jxo^
l=ixo^
l+
kr(i,^
d);
1382 kxo^
l=jxo^
l+
kr(i,^
d);
1383 a2(ixo^s,i,1:nw)=abs(-w(kxo^s,1:nw)+16.d0*w(jxo^s,1:nw)&
1384 -30.d0*w(ixo^s,1:nw)+16.d0*w(hxo^s,1:nw)-w(gxo^s,1:nw))
1385 a2max(i)=maxval(a2(ixo^s,i,1:nw))/12.d0/
dxlevel(i)**2
1387 end subroutine rmhd_get_a2max
1390 subroutine rmhd_get_tcutoff(ixI^L,ixO^L,w,x,Tco_local,Tmax_local)
1393 integer,
intent(in) :: ixi^
l,ixo^
l
1394 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1395 double precision,
intent(out) :: tco_local,tmax_local
1397 double precision,
intent(inout) :: w(ixi^s,1:nw)
1398 double precision,
parameter :: trac_delta=0.25d0
1399 double precision :: tmp1(ixi^s),te(ixi^s),lts(ixi^s)
1400 double precision,
dimension(ixI^S,1:ndir) :: bunitvec
1401 double precision,
dimension(ixI^S,1:ndim) :: gradt
1402 double precision :: bdir(
ndim)
1403 double precision :: ltrc,ltrp,altr(ixi^s)
1404 integer :: idims,jxo^
l,hxo^
l,ixa^
d,ixb^
d,ix^
d
1405 integer :: jxp^
l,hxp^
l,ixp^
l,ixq^
l
1406 logical :: lrlt(ixi^s)
1409 call rmhd_get_temperature_from_te(w,x,ixi^
l,ixi^
l,te)
1411 call rmhd_get_rfactor(w,x,ixi^
l,ixi^
l,te)
1412 te(ixi^s)=w(ixi^s,
p_)/(te(ixi^s)*w(ixi^s,
rho_))
1415 tmax_local=maxval(te(ixo^s))
1425 lts(ixo^s)=0.5d0*abs(te(jxo^s)-te(hxo^s))/te(ixo^s)
1427 where(lts(ixo^s) > trac_delta)
1430 if(any(lrlt(ixo^s)))
then
1431 tco_local=maxval(te(ixo^s), mask=lrlt(ixo^s))
1442 lts(ixp^s)=0.5d0*abs(te(jxp^s)-te(hxp^s))/te(ixp^s)
1443 lts(ixp^s)=max(one, (exp(lts(ixp^s))/ltrc)**ltrp)
1444 lts(ixo^s)=0.25d0*(lts(jxo^s)+two*lts(ixo^s)+lts(hxo^s))
1445 block%wextra(ixo^s,
tcoff_)=te(ixo^s)*lts(ixo^s)**0.4d0
1447 call mpistop(
"rmhd_trac_type not allowed for 1D simulation")
1459 gradt(ixo^s,idims)=tmp1(ixo^s)
1463 bunitvec(ixo^s,:)=w(ixo^s,iw_mag(:))+
block%B0(ixo^s,:,0)
1465 bunitvec(ixo^s,:)=w(ixo^s,iw_mag(:))
1471 ixb^
d=(ixomin^
d+ixomax^
d-1)/2+ixa^
d;
1474 if(sum(bdir(:)**2) .gt. zero)
then
1475 bdir(1:ndim)=bdir(1:ndim)/dsqrt(sum(bdir(:)**2))
1477 block%special_values(3:ndim+2)=bdir(1:ndim)
1479 tmp1(ixo^s)=dsqrt(sum(bunitvec(ixo^s,:)**2,dim=ndim+1))
1480 where(tmp1(ixo^s)/=0.d0)
1481 tmp1(ixo^s)=1.d0/tmp1(ixo^s)
1483 tmp1(ixo^s)=bigdouble
1487 bunitvec(ixo^s,idims)=bunitvec(ixo^s,idims)*tmp1(ixo^s)
1490 lts(ixo^s)=abs(sum(gradt(ixo^s,1:ndim)*bunitvec(ixo^s,1:ndim),dim=ndim+1))/te(ixo^s)
1492 if(slab_uniform)
then
1493 lts(ixo^s)=minval(dxlevel)*lts(ixo^s)
1495 lts(ixo^s)=minval(block%ds(ixo^s,:),dim=ndim+1)*lts(ixo^s)
1498 where(lts(ixo^s) > trac_delta)
1501 if(any(lrlt(ixo^s)))
then
1502 block%special_values(1)=maxval(te(ixo^s), mask=lrlt(ixo^s))
1504 block%special_values(1)=zero
1506 block%special_values(2)=tmax_local
1525 call gradient(te,ixi^l,ixq^l,idims,gradt(ixi^s,idims))
1526 call gradientf(te,x,ixi^l,hxp^l,idims,gradt(ixi^s,idims),nghostcells,.true.)
1527 call gradientf(te,x,ixi^l,jxp^l,idims,gradt(ixi^s,idims),nghostcells,.false.)
1530 {
do ix^db=ixpmin^db,ixpmax^db\}
1532 ^
c&bunitvec(ix^d,^
c)=w(ix^d,iw_mag(^
c))+block%B0(ix^d,^
c,0)\
1534 ^
c&bunitvec(ix^d,^
c)=w(ix^d,iw_mag(^
c))\
1536 tmp1(ix^d)=1.d0/(dsqrt(^
c&bunitvec(ix^d,^
c)**2+)+smalldouble)
1538 ^d&bunitvec({ix^d},^d)=bunitvec({ix^d},^d)*tmp1({ix^d})\
1540 lts(ix^d)=abs(^d&gradt({ix^d},^d)*bunitvec({ix^d},^d)+)/te(ix^d)
1542 if(slab_uniform)
then
1543 lts(ix^d)=min(^d&dxlevel(^d))*lts(ix^d)
1545 lts(ix^d)=min(^d&block%ds({ix^d},^d))*lts(ix^d)
1547 lts(ix^d)=max(one,(exp(lts(ix^d))/ltrc)**ltrp)
1552 hxo^l=ixp^l-kr(idims,^d);
1553 jxo^l=ixp^l+kr(idims,^d);
1555 altr(ixp^s)=0.25d0*(lts(hxo^s)+two*lts(ixp^s)+lts(jxo^s))*bunitvec(ixp^s,idims)**2
1557 altr(ixp^s)=altr(ixp^s)+0.25d0*(lts(hxo^s)+two*lts(ixp^s)+lts(jxo^s))*bunitvec(ixp^s,idims)**2
1560 block%wextra(ixp^s,
tcoff_)=te(ixp^s)*altr(ixp^s)**0.4d0
1564 call mpistop(
"unknown rmhd_trac_type")
1567 end subroutine rmhd_get_tcutoff
1570 subroutine rmhd_get_h_speed(wprim,x,ixI^L,ixO^L,idim,Hspeed)
1573 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1574 double precision,
intent(in) :: wprim(ixi^s, nw)
1575 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1576 double precision,
intent(out) :: hspeed(ixi^s,1:number_species)
1578 double precision :: csound(ixi^s,
ndim)
1579 double precision,
allocatable :: tmp(:^
d&)
1580 integer :: jxc^
l, ixc^
l, ixa^
l, id, ix^
d
1584 allocate(tmp(ixa^s))
1586 call rmhd_get_csound_prim(wprim,x,ixi^
l,ixa^
l,id,tmp)
1587 csound(ixa^s,id)=tmp(ixa^s)
1590 ixcmin^
d=ixomin^
d+
kr(idim,^
d)-1;
1591 jxcmax^
d=ixcmax^
d+
kr(idim,^
d);
1592 jxcmin^
d=ixcmin^
d+
kr(idim,^
d);
1593 hspeed(ixc^s,1)=0.5d0*abs(wprim(jxc^s,
mom(idim))+csound(jxc^s,idim)-wprim(ixc^s,
mom(idim))+csound(ixc^s,idim))
1597 ixamax^
d=ixcmax^
d+
kr(id,^
d);
1598 ixamin^
d=ixcmin^
d+
kr(id,^
d);
1599 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixa^s,
mom(id))+csound(ixa^s,id)-wprim(ixc^s,
mom(id))+csound(ixc^s,id)))
1600 ixamax^
d=ixcmax^
d-
kr(id,^
d);
1601 ixamin^
d=ixcmin^
d-
kr(id,^
d);
1602 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixc^s,
mom(id))+csound(ixc^s,id)-wprim(ixa^s,
mom(id))+csound(ixa^s,id)))
1607 ixamax^
d=jxcmax^
d+
kr(id,^
d);
1608 ixamin^
d=jxcmin^
d+
kr(id,^
d);
1609 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixa^s,
mom(id))+csound(ixa^s,id)-wprim(jxc^s,
mom(id))+csound(jxc^s,id)))
1610 ixamax^
d=jxcmax^
d-
kr(id,^
d);
1611 ixamin^
d=jxcmin^
d-
kr(id,^
d);
1612 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(jxc^s,
mom(id))+csound(jxc^s,id)-wprim(ixa^s,
mom(id))+csound(ixa^s,id)))
1616 end subroutine rmhd_get_h_speed
1619 subroutine rmhd_get_cbounds(wLC,wRC,wLp,wRp,x,ixI^L,ixO^L,idim,Hspeed,cmax,cmin)
1621 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1622 double precision,
intent(in) :: wlc(ixi^s, nw), wrc(ixi^s, nw)
1623 double precision,
intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
1624 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1625 double precision,
intent(inout) :: cmax(ixi^s,1:number_species)
1626 double precision,
intent(inout),
optional :: cmin(ixi^s,1:number_species)
1627 double precision,
intent(in) :: hspeed(ixi^s,1:number_species)
1629 double precision :: wmean(ixi^s,nw), csoundl(ixo^s), csoundr(ixo^s)
1630 double precision :: umean, dmean, tmp1, tmp2, tmp3
1637 call rmhd_get_csound_prim(wlp,x,ixi^
l,ixo^
l,idim,csoundl)
1638 call rmhd_get_csound_prim(wrp,x,ixi^
l,ixo^
l,idim,csoundr)
1639 if(
present(cmin))
then
1640 {
do ix^db=ixomin^db,ixomax^db\}
1641 tmp1=sqrt(wlp(ix^
d,
rho_))
1642 tmp2=sqrt(wrp(ix^
d,
rho_))
1643 tmp3=1.d0/(tmp1+tmp2)
1644 umean=(wlp(ix^
d,
mom(idim))*tmp1+wrp(ix^
d,
mom(idim))*tmp2)*tmp3
1645 dmean=sqrt((tmp1*csoundl(ix^
d)**2+tmp2*csoundr(ix^
d)**2)*tmp3+&
1646 half*tmp1*tmp2*tmp3**2*(wrp(ix^
d,
mom(idim))-wlp(ix^
d,
mom(idim)))**2)
1647 cmin(ix^
d,1)=umean-dmean
1648 cmax(ix^
d,1)=umean+dmean
1650 if(h_correction)
then
1651 {
do ix^db=ixomin^db,ixomax^db\}
1652 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1653 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1657 {
do ix^db=ixomin^db,ixomax^db\}
1658 tmp1=sqrt(wlp(ix^d,
rho_))
1659 tmp2=sqrt(wrp(ix^d,
rho_))
1660 tmp3=1.d0/(tmp1+tmp2)
1661 umean=(wlp(ix^d,
mom(idim))*tmp1+wrp(ix^d,
mom(idim))*tmp2)*tmp3
1662 dmean=sqrt((tmp1*csoundl(ix^d)**2+tmp2*csoundr(ix^d)**2)*tmp3+&
1663 half*tmp1*tmp2*tmp3**2*(wrp(ix^d,
mom(idim))-wlp(ix^d,
mom(idim)))**2)
1664 cmax(ix^d,1)=abs(umean)+dmean
1668 wmean(ixo^s,1:nwflux)=0.5d0*(wlp(ixo^s,1:nwflux)+wrp(ixo^s,1:nwflux))
1669 call rmhd_get_csound_prim(wmean,x,ixi^l,ixo^l,idim,csoundr)
1670 if(
present(cmin))
then
1671 {
do ix^db=ixomin^db,ixomax^db\}
1672 cmax(ix^d,1)=max(wmean(ix^d,
mom(idim))+csoundr(ix^d),zero)
1673 cmin(ix^d,1)=min(wmean(ix^d,
mom(idim))-csoundr(ix^d),zero)
1675 if(h_correction)
then
1676 {
do ix^db=ixomin^db,ixomax^db\}
1677 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1678 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1682 cmax(ixo^s,1)=abs(wmean(ixo^s,
mom(idim)))+csoundr(ixo^s)
1686 call rmhd_get_csound_prim(wlp,x,ixi^l,ixo^l,idim,csoundl)
1687 call rmhd_get_csound_prim(wrp,x,ixi^l,ixo^l,idim,csoundr)
1688 if(
present(cmin))
then
1689 {
do ix^db=ixomin^db,ixomax^db\}
1690 csoundl(ix^d)=max(csoundl(ix^d),csoundr(ix^d))
1691 cmin(ix^d,1)=min(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))-csoundl(ix^d)
1692 cmax(ix^d,1)=max(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))+csoundl(ix^d)
1694 if(h_correction)
then
1695 {
do ix^db=ixomin^db,ixomax^db\}
1696 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1697 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1701 {
do ix^db=ixomin^db,ixomax^db\}
1702 csoundl(ix^d)=max(csoundl(ix^d),csoundr(ix^d))
1703 cmax(ix^d,1)=max(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))+csoundl(ix^d)
1707 end subroutine rmhd_get_cbounds
1710 subroutine rmhd_get_cbounds_split_rho(wLC,wRC,wLp,wRp,x,ixI^L,ixO^L,idim,Hspeed,cmax,cmin)
1712 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1713 double precision,
intent(in) :: wlc(ixi^s, nw), wrc(ixi^s, nw)
1714 double precision,
intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
1715 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1716 double precision,
intent(inout) :: cmax(ixi^s,1:number_species)
1717 double precision,
intent(inout),
optional :: cmin(ixi^s,1:number_species)
1718 double precision,
intent(in) :: hspeed(ixi^s,1:number_species)
1719 double precision :: wmean(ixi^s,nw), csoundl(ixo^s), csoundr(ixo^s)
1720 double precision :: umean, dmean, tmp1, tmp2, tmp3
1727 call rmhd_get_csound_prim_split(wlp,x,ixi^
l,ixo^
l,idim,csoundl)
1728 call rmhd_get_csound_prim_split(wrp,x,ixi^
l,ixo^
l,idim,csoundr)
1729 if(
present(cmin))
then
1730 {
do ix^db=ixomin^db,ixomax^db\}
1733 tmp3=1.d0/(tmp1+tmp2)
1734 umean=(wlp(ix^
d,
mom(idim))*tmp1+wrp(ix^
d,
mom(idim))*tmp2)*tmp3
1735 dmean=sqrt((tmp1*csoundl(ix^
d)**2+tmp2*csoundr(ix^
d)**2)*tmp3+&
1736 half*tmp1*tmp2*tmp3**2*(wrp(ix^
d,
mom(idim))-wlp(ix^
d,
mom(idim)))**2)
1737 cmin(ix^
d,1)=umean-dmean
1738 cmax(ix^
d,1)=umean+dmean
1740 if(h_correction)
then
1741 {
do ix^db=ixomin^db,ixomax^db\}
1742 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1743 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1747 {
do ix^db=ixomin^db,ixomax^db\}
1750 tmp3=1.d0/(tmp1+tmp2)
1751 umean=(wlp(ix^d,
mom(idim))*tmp1+wrp(ix^d,
mom(idim))*tmp2)*tmp3
1752 dmean=sqrt((tmp1*csoundl(ix^d)**2+tmp2*csoundr(ix^d)**2)*tmp3+&
1753 half*tmp1*tmp2*tmp3**2*(wrp(ix^d,
mom(idim))-wlp(ix^d,
mom(idim)))**2)
1754 cmax(ix^d,1)=abs(umean)+dmean
1758 wmean(ixo^s,1:nwflux)=0.5d0*(wlp(ixo^s,1:nwflux)+wrp(ixo^s,1:nwflux))
1759 call rmhd_get_csound_prim_split(wmean,x,ixi^l,ixo^l,idim,csoundr)
1760 if(
present(cmin))
then
1761 {
do ix^db=ixomin^db,ixomax^db\}
1762 cmax(ix^d,1)=max(wmean(ix^d,
mom(idim))+csoundr(ix^d),zero)
1763 cmin(ix^d,1)=min(wmean(ix^d,
mom(idim))-csoundr(ix^d),zero)
1765 if(h_correction)
then
1766 {
do ix^db=ixomin^db,ixomax^db\}
1767 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1768 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1772 cmax(ixo^s,1)=abs(wmean(ixo^s,
mom(idim)))+csoundr(ixo^s)
1776 call rmhd_get_csound_prim_split(wlp,x,ixi^l,ixo^l,idim,csoundl)
1777 call rmhd_get_csound_prim_split(wrp,x,ixi^l,ixo^l,idim,csoundr)
1778 if(
present(cmin))
then
1779 {
do ix^db=ixomin^db,ixomax^db\}
1780 csoundl(ix^d)=max(csoundl(ix^d),csoundr(ix^d))
1781 cmin(ix^d,1)=min(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))-csoundl(ix^d)
1782 cmax(ix^d,1)=max(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))+csoundl(ix^d)
1784 if(h_correction)
then
1785 {
do ix^db=ixomin^db,ixomax^db\}
1786 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
1787 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
1791 {
do ix^db=ixomin^db,ixomax^db\}
1792 csoundl(ix^d)=max(csoundl(ix^d),csoundr(ix^d))
1793 cmax(ix^d,1)=max(wlp(ix^d,
mom(idim)),wrp(ix^d,
mom(idim)))+csoundl(ix^d)
1797 end subroutine rmhd_get_cbounds_split_rho
1800 subroutine rmhd_get_ct_velocity(vcts,wLp,wRp,ixI^L,ixO^L,idim,cmax,cmin)
1802 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1803 double precision,
intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
1804 double precision,
intent(in) :: cmax(ixi^s)
1805 double precision,
intent(in),
optional :: cmin(ixi^s)
1806 type(ct_velocity),
intent(inout) :: vcts
1807 integer :: idime,idimn
1813 if(.not.
allocated(vcts%vnorm))
allocate(vcts%vnorm(ixi^s,1:
ndim))
1815 vcts%vnorm(ixo^s,idim)=0.5d0*(wlp(ixo^s,
mom(idim))+wrp(ixo^s,
mom(idim)))
1817 if(.not.
allocated(vcts%vbarC))
then
1818 allocate(vcts%vbarC(ixi^s,1:
ndir,2),vcts%vbarLC(ixi^s,1:
ndir,2),vcts%vbarRC(ixi^s,1:
ndir,2))
1819 allocate(vcts%cbarmin(ixi^s,1:
ndim),vcts%cbarmax(ixi^s,1:
ndim))
1822 if(
present(cmin))
then
1823 vcts%cbarmin(ixo^s,idim)=max(-cmin(ixo^s),zero)
1824 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
1826 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
1827 vcts%cbarmin(ixo^s,idim)=vcts%cbarmax(ixo^s,idim)
1830 idimn=mod(idim,
ndir)+1
1831 idime=mod(idim+1,
ndir)+1
1833 vcts%vbarLC(ixo^s,idim,1)=wlp(ixo^s,
mom(idimn))
1834 vcts%vbarRC(ixo^s,idim,1)=wrp(ixo^s,
mom(idimn))
1835 vcts%vbarC(ixo^s,idim,1)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,1) &
1836 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
1837 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
1838 vcts%vbarLC(ixo^s,idim,2)=wlp(ixo^s,
mom(idime))
1839 vcts%vbarRC(ixo^s,idim,2)=wrp(ixo^s,
mom(idime))
1840 vcts%vbarC(ixo^s,idim,2)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,2) &
1841 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
1842 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
1844 call mpistop(
'choose average, uct_contact,or uct_hll for type_ct!')
1846 end subroutine rmhd_get_ct_velocity
1849 subroutine rmhd_get_csound_prim(w,x,ixI^L,ixO^L,idim,csound)
1851 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1852 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1853 double precision,
intent(out):: csound(ixo^s)
1854 double precision :: inv_rho, cfast2, avmincs2, b2, kmax
1855 double precision :: prad_tensor(ixo^s, 1:
ndim, 1:
ndim)
1856 double precision :: prad_max(ixo^s)
1861 if(radio_acoustic_filter)
then
1862 call rmhd_radio_acoustic_filter(x, ixi^
l, ixo^
l, prad_max)
1866 {
do ix^db=ixomin^db,ixomax^db \}
1867 inv_rho=1.d0/w(ix^
d,
rho_)
1868 prad_max(ix^
d) = maxval(prad_tensor(ix^
d,:,:))
1870 csound(ix^
d)=max(
rmhd_gamma,4.d0/3.d0)*(w(ix^
d,
p_)+prad_max(ix^
d))*inv_rho
1875 cfast2=b2*inv_rho+csound(ix^
d)
1876 avmincs2=cfast2**2-4.0d0*csound(ix^
d)*(w(ix^
d,mag(idim))+&
1878 if(avmincs2<zero) avmincs2=zero
1879 csound(ix^
d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1882 {
do ix^db=ixomin^db,ixomax^db \}
1883 inv_rho=1.d0/w(ix^d,
rho_)
1884 prad_max(ix^d)=maxval(prad_tensor(ix^d,:,:))
1886 csound(ix^d)=max(
rmhd_gamma,4.d0/3.d0)*(w(ix^d,
p_)+prad_max(ix^d))*inv_rho
1890 b2=(^
c&w(ix^d,
b^
c_)**2+)
1891 cfast2=b2*inv_rho+csound(ix^d)
1892 avmincs2=cfast2**2-4.0d0*csound(ix^d)*w(ix^d,mag(idim))**2*inv_rho
1893 if(avmincs2<zero) avmincs2=zero
1894 csound(ix^d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1897 end subroutine rmhd_get_csound_prim
1900 subroutine rmhd_get_csound_prim_split(w,x,ixI^L,ixO^L,idim,csound)
1902 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1903 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1904 double precision,
intent(out):: csound(ixo^s)
1905 double precision :: rho, inv_rho, cfast2, avmincs2, b2, kmax
1906 double precision :: prad_tensor(ixo^s, 1:
ndim, 1:
ndim)
1907 double precision :: prad_max(ixo^s)
1912 if (radio_acoustic_filter)
then
1913 call rmhd_radio_acoustic_filter(x, ixi^
l, ixo^
l, prad_max)
1918 {
do ix^db=ixomin^db,ixomax^db \}
1921 prad_max(ix^
d) = maxval(prad_tensor(ix^
d,:,:))
1926 cfast2=b2*inv_rho+csound(ix^
d)
1927 avmincs2=cfast2**2-4.0d0*csound(ix^
d)*(w(ix^
d,mag(idim))+&
1929 if(avmincs2<zero) avmincs2=zero
1930 csound(ix^
d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1933 {
do ix^db=ixomin^db,ixomax^db \}
1936 prad_max(ix^d) = maxval(prad_tensor(ix^d,:,:))
1938 csound(ix^d)=max(
rmhd_gamma,4.d0/3.d0)*(w(ix^d,
p_)+block%equi_vars(ix^d,
equi_pe0_,b0i)+prad_max(ix^d))*inv_rho
1940 b2=(^
c&w(ix^d,
b^
c_)**2+)
1941 cfast2=b2*inv_rho+csound(ix^d)
1942 avmincs2=cfast2**2-4.0d0*csound(ix^d)*w(ix^d,mag(idim))**2*inv_rho
1943 if(avmincs2<zero) avmincs2=zero
1944 csound(ix^d)=sqrt(half*(cfast2+sqrt(avmincs2)))
1947 end subroutine rmhd_get_csound_prim_split
1950 subroutine rmhd_get_pthermal_origin(w,x,ixI^L,ixO^L,pth)
1954 integer,
intent(in) :: ixi^
l, ixo^
l
1955 double precision,
intent(in) :: w(ixi^s,nw)
1956 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1957 double precision,
intent(out):: pth(ixi^s)
1961 {
do ix^db=ixomin^db,ixomax^db\}
1966 pth(ix^
d)=gamma_1*(w(ix^
d,
e_)-half*((^
c&w(ix^
d,
m^
c_)**2+)/w(ix^
d,
rho_)&
1967 +(^
c&w(ix^
d,
b^
c_)**2+)))
1972 if(check_small_values.and..not.fix_small_values)
then
1973 {
do ix^db=ixomin^db,ixomax^db\}
1974 if(pth(ix^d)<small_pressure)
then
1975 write(*,*)
"Error: small value of gas pressure",pth(ix^d),&
1976 " encountered when call rmhd_get_pthermal"
1977 write(*,*)
"Iteration: ", it,
" Time: ", global_time
1978 write(*,*)
"Location: ", x(ix^d,:)
1979 write(*,*)
"Cell number: ", ix^d
1981 write(*,*) trim(cons_wnames(iw)),
": ",w(ix^d,iw)
1984 if(trace_small_values)
write(*,*) sqrt(pth(ix^d)-bigdouble)
1985 write(*,*)
"Saving status at the previous time step"
1990 end subroutine rmhd_get_pthermal_origin
1993 subroutine rmhd_get_temperature_from_te(w, x, ixI^L, ixO^L, res)
1995 integer,
intent(in) :: ixi^
l, ixo^
l
1996 double precision,
intent(in) :: w(ixi^s, 1:nw)
1997 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1998 double precision,
intent(out):: res(ixi^s)
1999 res(ixo^s) = w(ixo^s,
te_)
2000 end subroutine rmhd_get_temperature_from_te
2003 subroutine rmhd_get_temperature_from_eint(w, x, ixI^L, ixO^L, res)
2005 integer,
intent(in) :: ixi^
l, ixo^
l
2006 double precision,
intent(in) :: w(ixi^s, 1:nw)
2007 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2008 double precision,
intent(out):: res(ixi^s)
2009 double precision :: r(ixi^s)
2011 call rmhd_get_rfactor(w,x,ixi^
l,ixo^
l,r)
2012 res(ixo^s) = gamma_1 * w(ixo^s,
e_)/(w(ixo^s,
rho_)*r(ixo^s))
2013 end subroutine rmhd_get_temperature_from_eint
2016 subroutine rmhd_get_temperature_from_etot(w, x, ixI^L, ixO^L, res)
2018 integer,
intent(in) :: ixi^
l, ixo^
l
2019 double precision,
intent(in) :: w(ixi^s, 1:nw)
2020 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2021 double precision,
intent(out):: res(ixi^s)
2022 double precision :: r(ixi^s)
2024 call rmhd_get_rfactor(w,x,ixi^
l,ixo^
l,r)
2026 res(ixo^s)=res(ixo^s)/(r(ixo^s)*w(ixo^s,
rho_))
2027 end subroutine rmhd_get_temperature_from_etot
2029 subroutine rmhd_get_temperature_from_etot_with_equi(w, x, ixI^L, ixO^L, res)
2031 integer,
intent(in) :: ixi^
l, ixo^
l
2032 double precision,
intent(in) :: w(ixi^s, 1:nw)
2033 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2034 double precision,
intent(out):: res(ixi^s)
2035 double precision :: r(ixi^s)
2037 call rmhd_get_rfactor(w,x,ixi^
l,ixo^
l,r)
2040 end subroutine rmhd_get_temperature_from_etot_with_equi
2042 subroutine rmhd_get_temperature_from_eint_with_equi(w, x, ixI^L, ixO^L, res)
2044 integer,
intent(in) :: ixi^
l, ixo^
l
2045 double precision,
intent(in) :: w(ixi^s, 1:nw)
2046 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2047 double precision,
intent(out):: res(ixi^s)
2048 double precision :: r(ixi^s)
2050 call rmhd_get_rfactor(w,x,ixi^
l,ixo^
l,r)
2053 end subroutine rmhd_get_temperature_from_eint_with_equi
2055 subroutine rmhd_get_temperature_equi(w,x, ixI^L, ixO^L, res)
2057 integer,
intent(in) :: ixi^
l, ixo^
l
2058 double precision,
intent(in) :: w(ixi^s, 1:nw)
2059 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2060 double precision,
intent(out):: res(ixi^s)
2061 double precision :: r(ixi^s)
2063 call rmhd_get_rfactor(w,x,ixi^
l,ixo^
l,r)
2065 end subroutine rmhd_get_temperature_equi
2067 subroutine rmhd_get_rho_equi(w, x, ixI^L, ixO^L, res)
2069 integer,
intent(in) :: ixi^
l, ixo^
l
2070 double precision,
intent(in) :: w(ixi^s, 1:nw)
2071 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2072 double precision,
intent(out):: res(ixi^s)
2074 end subroutine rmhd_get_rho_equi
2076 subroutine rmhd_get_pe_equi(w,x, ixI^L, ixO^L, res)
2078 integer,
intent(in) :: ixi^
l, ixo^
l
2079 double precision,
intent(in) :: w(ixi^s, 1:nw)
2080 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2081 double precision,
intent(out):: res(ixi^s)
2083 end subroutine rmhd_get_pe_equi
2086 subroutine rmhd_get_p_total(w,x,ixI^L,ixO^L,p)
2088 integer,
intent(in) :: ixi^
l, ixo^
l
2089 double precision,
intent(in) :: w(ixi^s,nw)
2090 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2091 double precision,
intent(out) :: p(ixi^s)
2094 p(ixo^s) = p(ixo^s) + 0.5d0 * sum(w(ixo^s, mag(:))**2, dim=
ndim+1)
2095 end subroutine rmhd_get_p_total
2102 integer,
intent(in) :: ixi^
l, ixo^
l, nth
2103 double precision,
intent(in) :: w(ixi^s, 1:nw)
2104 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2105 double precision,
intent(out):: prad(ixo^s, 1:
ndim, 1:
ndim)
2113 call mpistop(
'Radiation formalism unknown')
2120 integer,
intent(in) :: ixi^
l, ixo^
l
2121 double precision,
intent(in) :: w(ixi^s, 1:nw)
2122 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2123 double precision :: pth(ixi^s)
2124 double precision :: prad_tensor(ixo^s, 1:
ndim, 1:
ndim)
2125 double precision :: prad_max(ixo^s)
2126 double precision,
intent(out) :: pth_plus_prad(ixi^s)
2131 {
do ix^
d = ixomin^
d,ixomax^
d\}
2132 prad_max(ix^
d) = maxval(prad_tensor(ix^
d,:,:))
2135 if (radio_acoustic_filter)
then
2136 call rmhd_radio_acoustic_filter(x, ixi^
l, ixo^
l, prad_max)
2138 pth_plus_prad(ixo^s) = pth(ixo^s) + prad_max(ixo^s)
2142 subroutine rmhd_radio_acoustic_filter(x, ixI^L, ixO^L, prad_max)
2144 integer,
intent(in) :: ixi^
l, ixo^
l
2145 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2146 double precision,
intent(inout) :: prad_max(ixo^s)
2147 double precision :: tmp_prad(ixi^s)
2148 integer :: ix^
d, filter, idim
2150 if (size_ra_filter .lt. 1)
call mpistop(
"ra filter of size < 1 makes no sense")
2151 if (size_ra_filter .gt.
nghostcells)
call mpistop(
"ra filter of size < nghostcells makes no sense")
2153 tmp_prad(ixi^s) = zero
2154 tmp_prad(ixo^s) = prad_max(ixo^s)
2155 do filter = 1,size_ra_filter
2158 {
do ix^
d = ixomin^
d,ixomax^
d\}
2159 prad_max(ix^
d) = min(tmp_prad(ix^
d),tmp_prad(ix^
d+filter*
kr(idim,^
d)))
2160 prad_max(ix^
d) = min(tmp_prad(ix^
d),tmp_prad(ix^
d-filter*
kr(idim,^
d)))
2164 end subroutine rmhd_radio_acoustic_filter
2169 integer,
intent(in) :: ixi^
l, ixo^
l
2170 double precision,
intent(in) :: w(ixi^s, 1:nw)
2171 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2172 double precision :: pth(ixi^s)
2173 double precision,
intent(out):: tgas(ixi^s)
2176 tgas(ixi^s) = pth(ixi^s)/w(ixi^s,
rho_)
2184 integer,
intent(in) :: ixi^
l, ixo^
l
2185 double precision,
intent(in) :: w(ixi^s, 1:nw)
2186 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
2187 double precision,
intent(out):: trad(ixi^s)
2194 subroutine rmhd_get_flux(wC,w,x,ixI^L,ixO^L,idim,f)
2198 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2200 double precision,
intent(in) :: wc(ixi^s,nw)
2202 double precision,
intent(in) :: w(ixi^s,nw)
2203 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2204 double precision,
intent(out) :: f(ixi^s,nwflux)
2205 double precision :: vhall(ixi^s,1:
ndir)
2206 double precision :: ptotal
2209 {
do ix^db=ixomin^db,ixomax^db\}
2214 ptotal=w(ix^
d,
p_)+half*(^
c&w(ix^
d,
b^
c_)**2+)
2216 f(ix^
d,
mom(idim))=f(ix^
d,
mom(idim))+ptotal
2219 f(ix^
d,
e_)=w(ix^
d,
mom(idim))*(wc(ix^
d,
e_)+ptotal)&
2220 -w(ix^
d,mag(idim))*(^
c&w(ix^
d,
b^
c_)*w(ix^
d,
m^
c_)+)
2225 {
do ix^db=ixomin^db,ixomax^db\}
2226 f(ix^d,mag(idim))=w(ix^d,
psi_)
2228 f(ix^d,
psi_)=cmax_global**2*w(ix^d,mag(idim))
2232 {
do ix^db=ixomin^db,ixomax^db\}
2233 f(ix^d,
r_e)=w(ix^d,
mom(idim))*wc(ix^d,
r_e)
2240 {
do ix^db=ixomin^db,ixomax^db\}
2245 {
do ix^db=ixomin^db,ixomax^db\}
2246 f(ix^d,
e_)=f(ix^d,
e_)+w(ix^d,
q_)*w(ix^d,mag(idim))/(dsqrt(^d&w({ix^d},
b^d_)**2+)+smalldouble)
2250 end subroutine rmhd_get_flux
2253 subroutine rmhd_get_flux_split(wC,w,x,ixI^L,ixO^L,idim,f)
2256 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2258 double precision,
intent(in) :: wc(ixi^s,nw)
2260 double precision,
intent(in) :: w(ixi^s,nw)
2261 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2262 double precision,
intent(out) :: f(ixi^s,nwflux)
2263 double precision :: vhall(ixi^s,1:
ndir)
2264 double precision :: ptotal, btotal(ixo^s,1:
ndir)
2267 {
do ix^db=ixomin^db,ixomax^db\}
2275 ptotal=w(ix^
d,
p_)+half*(^
c&w(ix^
d,
b^
c_)**2+)
2284 ptotal=ptotal+(^
c&w(ix^
d,
b^
c_)*
block%B0(ix^
d,^
c,idim)+)
2288 btotal(ix^
d,idim)*w(ix^
d,
b^
c_)-w(ix^
d,mag(idim))*
block%B0(ix^
d,^
c,idim)\
2289 f(ix^
d,
mom(idim))=f(ix^
d,
mom(idim))+ptotal
2291 ^
c&btotal(ix^
d,^
c)=w(ix^
d,
b^
c_)\
2295 f(ix^
d,
mom(idim))=f(ix^
d,
mom(idim))+ptotal
2298 ^
c&f(ix^
d,
b^
c_)=w(ix^
d,
mom(idim))*btotal(ix^
d,^
c)-btotal(ix^
d,idim)*w(ix^
d,
m^
c_)\
2302 f(ix^
d,
e_)=w(ix^
d,
mom(idim))*(wc(ix^
d,
e_)+ptotal)&
2303 -btotal(ix^
d,idim)*(^
c&w(ix^
d,
b^
c_)*w(ix^
d,
m^
c_)+)
2307 {
do ix^db=ixomin^db,ixomax^db\}
2308 f(ix^d,mag(idim))=w(ix^d,
psi_)
2310 f(ix^d,
psi_) = cmax_global**2*w(ix^d,mag(idim))
2314 {
do ix^db=ixomin^db,ixomax^db\}
2315 f(ix^d,
r_e)=w(ix^d,
mom(idim))*wc(ix^d,
r_e)
2322 {
do ix^db=ixomin^db,ixomax^db\}
2327 {
do ix^db=ixomin^db,ixomax^db\}
2328 f(ix^d,
e_)=f(ix^d,
e_)+w(ix^d,
q_)*btotal(ix^d,idim)/(dsqrt(^
c&btotal(ix^d,^
c)**2+)+smalldouble)
2332 end subroutine rmhd_get_flux_split
2336 subroutine get_flux_on_cell_face(ixI^L,ixO^L,ff,src)
2339 integer,
intent(in) :: ixi^
l, ixo^
l
2340 double precision,
dimension(:^D&,:),
intent(inout) :: ff
2341 double precision,
intent(out) :: src(ixi^s)
2343 double precision :: ffc(ixi^s,1:
ndim)
2344 double precision :: dxinv(
ndim)
2345 integer :: idims, ix^
d, ixa^
l, ixb^
l, ixc^
l
2351 ixcmax^
d=ixomax^
d; ixcmin^
d=ixomin^
d-1;
2353 ixbmin^
d=ixcmin^
d+ix^
d;
2354 ixbmax^
d=ixcmax^
d+ix^
d;
2357 ffc(ixc^s,1:ndim)=0.5d0**ndim*ffc(ixc^s,1:ndim)
2359 ff(ixi^s,1:ndim)=0.d0
2361 ixb^l=ixo^l-kr(idims,^d);
2362 ixcmax^d=ixomax^d; ixcmin^d=ixbmin^d;
2364 if({ ix^d==0 .and. ^d==idims | .or.})
then
2365 ixbmin^d=ixcmin^d-ix^d;
2366 ixbmax^d=ixcmax^d-ix^d;
2367 ff(ixc^s,idims)=ff(ixc^s,idims)+ffc(ixb^s,idims)
2370 ff(ixc^s,idims)=ff(ixc^s,idims)*0.5d0**(ndim-1)
2373 if(slab_uniform)
then
2375 ff(ixa^s,idims)=dxinv(idims)*ff(ixa^s,idims)
2376 ixb^l=ixo^l-kr(idims,^d);
2377 src(ixo^s)=src(ixo^s)+ff(ixo^s,idims)-ff(ixb^s,idims)
2381 ff(ixa^s,idims)=ff(ixa^s,idims)*block%surfaceC(ixa^s,idims)
2382 ixb^l=ixo^l-kr(idims,^d);
2383 src(ixo^s)=src(ixo^s)+ff(ixo^s,idims)-ff(ixb^s,idims)
2385 src(ixo^s)=src(ixo^s)/block%dvolume(ixo^s)
2387 end subroutine get_flux_on_cell_face
2390 subroutine rmhd_add_source(qdt,dtfactor,ixI^L,ixO^L,wCT,wCTprim,w,x,qsourcesplit,active)
2396 integer,
intent(in) :: ixi^
l, ixo^
l
2397 double precision,
intent(in) :: qdt,dtfactor
2398 double precision,
intent(in) :: wct(ixi^s,1:nw),wctprim(ixi^s,1:nw), x(ixi^s,1:
ndim)
2399 double precision,
intent(inout) :: w(ixi^s,1:nw)
2400 logical,
intent(in) :: qsourcesplit
2401 logical,
intent(inout) :: active
2407 if (.not. qsourcesplit)
then
2410 call add_pe0_divv(qdt,dtfactor,ixi^
l,ixo^
l,wctprim,w,x)
2413 call add_hypertc_source(qdt,ixi^
l,ixo^
l,wct,w,x,wctprim)
2418 call add_source_b0split(qdt,dtfactor,ixi^
l,ixo^
l,wctprim,w,x)
2423 call add_source_res2(qdt,ixi^
l,ixo^
l,wct,w,x)
2427 call add_source_hyperres(qdt,ixi^
l,ixo^
l,wct,w,x)
2433 select case (type_divb)
2438 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
2441 call add_source_glm(qdt,ixi^
l,ixo^
l,wct,w,x)
2444 call add_source_powel(qdt,ixi^
l,ixo^
l,wctprim,w,x)
2445 case (divb_janhunen)
2447 call add_source_janhunen(qdt,ixi^
l,ixo^
l,wctprim,w,x)
2448 case (divb_lindejanhunen)
2450 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
2451 call add_source_janhunen(qdt,ixi^
l,ixo^
l,wctprim,w,x)
2452 case (divb_lindepowel)
2454 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
2455 call add_source_powel(qdt,ixi^
l,ixo^
l,wctprim,w,x)
2456 case (divb_lindeglm)
2458 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
2459 call add_source_glm(qdt,ixi^
l,ixo^
l,wct,w,x)
2460 case (divb_multigrid)
2465 call mpistop(
'Unknown divB fix')
2475 w,x,gravity_energy,gravity_rhov,qsourcesplit,active)
2481 call rmhd_add_radiation_source(qdt,ixi^
l,ixo^
l,wct,w,x,qsourcesplit,active)
2484 if(.not.qsourcesplit)
then
2486 call rmhd_update_temperature(ixi^
l,ixo^
l,wct,w,x)
2489 end subroutine rmhd_add_source
2491 subroutine rmhd_add_radiation_source(qdt,ixI^L,ixO^L,wCT,w,x,qsourcesplit,active)
2497 integer,
intent(in) :: ixi^
l, ixo^
l
2498 double precision,
intent(in) :: qdt, x(ixi^s,1:
ndim)
2499 double precision,
intent(in) :: wct(ixi^s,1:nw)
2500 double precision,
intent(inout) :: w(ixi^s,1:nw)
2501 logical,
intent(in) :: qsourcesplit
2502 logical,
intent(inout) :: active
2503 double precision :: cmax(ixi^s)
2510 call rmhd_handle_small_values(.true., w, x, ixi^
l, ixo^
l,
'fld_e_interact')
2515 call rmhd_handle_small_values(.true., w, x, ixi^
l, ixo^
l,
'fld_e_interact')
2521 call mpistop(
'Radiation formalism unknown')
2523 end subroutine rmhd_add_radiation_source
2525 subroutine add_pe0_divv(qdt,dtfactor,ixI^L,ixO^L,wCT,w,x)
2528 integer,
intent(in) :: ixi^
l, ixo^
l
2529 double precision,
intent(in) :: qdt,dtfactor
2530 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2531 double precision,
intent(inout) :: w(ixi^s,1:nw)
2532 double precision :: divv(ixi^s)
2548 end subroutine add_pe0_divv
2550 subroutine get_tau(ixI^L,ixO^L,w,Te,tau,sigT5)
2552 integer,
intent(in) :: ixi^
l, ixo^
l
2553 double precision,
dimension(ixI^S,1:nw),
intent(in) :: w
2554 double precision,
dimension(ixI^S),
intent(in) :: te
2555 double precision,
dimension(ixI^S),
intent(out) :: tau,sigt5
2556 double precision :: dxmin,taumin
2557 double precision,
dimension(ixI^S) :: sigt7,eint
2565 sigt7(ixo^s)=sigt5(ixo^s)*
block%wextra(ixo^s,
tcoff_)
2568 sigt7(ixo^s)=sigt5(ixo^s)*te(ixo^s)
2572 sigt7(ixo^s)=sigt5(ixo^s)*te(ixo^s)
2575 tau(ixo^s)=max(taumin*
dt,sigt7(ixo^s)/eint(ixo^s)/
cmax_global**2)
2576 end subroutine get_tau
2578 subroutine add_hypertc_source(qdt,ixI^L,ixO^L,wCT,w,x,wCTprim)
2580 integer,
intent(in) :: ixi^
l,ixo^
l
2581 double precision,
intent(in) :: qdt
2582 double precision,
dimension(ixI^S,1:ndim),
intent(in) :: x
2583 double precision,
dimension(ixI^S,1:nw),
intent(in) :: wct,wctprim
2584 double precision,
dimension(ixI^S,1:nw),
intent(inout) :: w
2585 double precision :: invdx
2586 double precision,
dimension(ixI^S) :: te,tau,sigt,htc_qsrc,tface,r
2587 double precision,
dimension(ixI^S) :: htc_esrc,bsum,bunit
2588 double precision,
dimension(ixI^S,1:ndim) :: btot
2590 integer :: hxc^
l,hxo^
l,ixc^
l,jxc^
l,jxo^
l,kxc^
l
2592 call rmhd_get_rfactor(wctprim,x,ixi^
l,ixi^
l,r)
2594 te(ixi^s)=wctprim(ixi^s,
p_)/(r(ixi^s)*w(ixi^s,
rho_))
2595 call get_tau(ixi^
l,ixo^
l,wctprim,te,tau,sigt)
2599 btot(ixo^s,idims)=wct(ixo^s,mag(idims))+
block%B0(ixo^s,idims,0)
2601 btot(ixo^s,idims)=wct(ixo^s,mag(idims))
2604 bsum(ixo^s)=sqrt(sum(btot(ixo^s,:)**2,dim=
ndim+1))+smalldouble
2608 ixcmin^
d=ixomin^
d-
kr(idims,^
d);ixcmax^
d=ixomax^
d;
2609 jxc^
l=ixc^
l+
kr(idims,^
d);
2610 kxc^
l=jxc^
l+
kr(idims,^
d);
2611 hxc^
l=ixc^
l-
kr(idims,^
d);
2612 hxo^
l=ixo^
l-
kr(idims,^
d);
2613 tface(ixc^s)=(7.d0*(te(ixc^s)+te(jxc^s))-(te(hxc^s)+te(kxc^s)))/12.d0
2614 bunit(ixo^s)=btot(ixo^s,idims)/bsum(ixo^s)
2615 htc_qsrc(ixo^s)=htc_qsrc(ixo^s)+sigt(ixo^s)*bunit(ixo^s)*(tface(ixo^s)-tface(hxo^s))*invdx
2617 htc_qsrc(ixo^s)=(htc_qsrc(ixo^s)+wct(ixo^s,
q_))/tau(ixo^s)
2618 w(ixo^s,
q_)=w(ixo^s,
q_)-qdt*htc_qsrc(ixo^s)
2619 end subroutine add_hypertc_source
2622 subroutine get_lorentz_force(ixI^L,ixO^L,w,JxB)
2624 integer,
intent(in) :: ixi^
l, ixo^
l
2625 double precision,
intent(in) :: w(ixi^s,1:nw)
2626 double precision,
intent(inout) :: jxb(ixi^s,3)
2627 double precision :: a(ixi^s,3),
b(ixi^s,3)
2629 double precision :: current(ixi^s,7-2*
ndir:3)
2630 integer :: idir, idirmin
2635 b(ixo^s, idir) = w(ixo^s,mag(idir))+
block%B0(ixo^s,idir,0)
2639 b(ixo^s, idir) = w(ixo^s,mag(idir))
2646 a(ixo^s,idir)=current(ixo^s,idir)
2649 end subroutine get_lorentz_force
2653 subroutine rmhd_gamma2_alfven(ixI^L, ixO^L, w, gamma_A2)
2655 integer,
intent(in) :: ixi^
l, ixo^
l
2656 double precision,
intent(in) :: w(ixi^s, nw)
2657 double precision,
intent(out) :: gamma_a2(ixo^s)
2658 double precision :: rho(ixi^s)
2664 rho(ixo^s) = w(ixo^s,
rho_)
2667 gamma_a2(ixo^s) = 1.0d0/(1.0d0+
rmhd_mag_en_all(w, ixi^
l, ixo^
l)/rho(ixo^s)*inv_squared_c)
2668 end subroutine rmhd_gamma2_alfven
2672 function rmhd_gamma_alfven(w, ixI^L, ixO^L)
result(gamma_A)
2674 integer,
intent(in) :: ixi^
l, ixo^
l
2675 double precision,
intent(in) :: w(ixi^s, nw)
2676 double precision :: gamma_a(ixo^s)
2678 call rmhd_gamma2_alfven(ixi^
l, ixo^
l, w, gamma_a)
2679 gamma_a = sqrt(gamma_a)
2680 end function rmhd_gamma_alfven
2684 integer,
intent(in) :: ixi^
l, ixo^
l
2685 double precision,
intent(in) :: w(ixi^s,1:nw),x(ixi^s,1:
ndim)
2686 double precision,
intent(out) :: rho(ixi^s)
2691 rho(ixo^s) = w(ixo^s,
rho_)
2696 subroutine rmhd_handle_small_ei(w, x, ixI^L, ixO^L, ie, subname)
2699 integer,
intent(in) :: ixi^
l,ixo^
l, ie
2700 double precision,
intent(inout) :: w(ixi^s,1:nw)
2701 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2702 character(len=*),
intent(in) :: subname
2703 double precision :: rho(ixi^s)
2705 logical :: flag(ixi^s,1:nw)
2709 where(w(ixo^s,ie)+
block%equi_vars(ixo^s,
equi_pe0_,0)*inv_gamma_1<small_e)&
2710 flag(ixo^s,ie)=.true.
2712 where(w(ixo^s,ie)<small_e) flag(ixo^s,ie)=.true.
2714 if(any(flag(ixo^s,ie)))
then
2718 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e - &
2721 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e
2727 w(ixo^s,
e_)=w(ixo^s,
e_)*gamma_1
2730 w(ixo^s,
mom(idir)) = w(ixo^s,
mom(idir))/rho(ixo^s)
2735 end subroutine rmhd_handle_small_ei
2737 subroutine rmhd_update_temperature(ixI^L,ixO^L,wCT,w,x)
2741 integer,
intent(in) :: ixi^
l, ixo^
l
2742 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2743 double precision,
intent(inout) :: w(ixi^s,1:nw)
2745 double precision :: iz_h(ixo^s),iz_he(ixo^s), pth(ixi^s)
2753 end subroutine rmhd_update_temperature
2756 subroutine add_source_b0split(qdt,dtfactor,ixI^L,ixO^L,wCT,w,x)
2758 integer,
intent(in) :: ixi^
l, ixo^
l
2759 double precision,
intent(in) :: qdt, dtfactor,wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2760 double precision,
intent(inout) :: w(ixi^s,1:nw)
2761 double precision :: a(ixi^s,3),
b(ixi^s,3), axb(ixi^s,3)
2772 a(ixo^s,idir)=
block%J0(ixo^s,idir)
2777 axb(ixo^s,idir)=axb(ixo^s,idir)*
block%dt(ixo^s)*dtfactor
2780 axb(ixo^s,:)=axb(ixo^s,:)*qdt
2785 if(total_energy)
then
2788 b(ixo^s,:)=wct(ixo^s,mag(:))
2797 axb(ixo^s,idir)=axb(ixo^s,idir)*
block%dt(ixo^s)*dtfactor
2800 axb(ixo^s,:)=axb(ixo^s,:)*qdt
2804 w(ixo^s,
e_)=w(ixo^s,
e_)-axb(ixo^s,idir)*
block%J0(ixo^s,idir)
2807 if (
fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_B0')
2808 end subroutine add_source_b0split
2814 subroutine add_source_res1(qdt,ixI^L,ixO^L,wCT,w,x)
2818 integer,
intent(in) :: ixi^
l, ixo^
l
2819 double precision,
intent(in) :: qdt
2820 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2821 double precision,
intent(inout) :: w(ixi^s,1:nw)
2822 integer :: ixa^
l,idir,jdir,kdir,idirmin,idim,jxo^
l,hxo^
l,ix
2823 integer :: lxo^
l, kxo^
l
2824 double precision :: tmp(ixi^s),tmp2(ixi^s)
2826 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s)
2827 double precision :: gradeta(ixi^s,1:
ndim), bf(ixi^s,1:
ndir)
2835 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
2836 call mpistop(
"Error in add_source_res1: Non-conforming input limits")
2841 gradeta(ixo^s,1:
ndim)=zero
2847 gradeta(ixo^s,idim)=tmp(ixo^s)
2853 bf(ixi^s,1:
ndir)=wct(ixi^s,mag(1:
ndir))
2859 tmp2(ixi^s)=bf(ixi^s,idir)
2861 lxo^
l=ixo^
l+2*
kr(idim,^
d);
2862 jxo^
l=ixo^
l+
kr(idim,^
d);
2863 hxo^
l=ixo^
l-
kr(idim,^
d);
2864 kxo^
l=ixo^
l-2*
kr(idim,^
d);
2865 tmp(ixo^s)=tmp(ixo^s)+&
2866 (-tmp2(lxo^s)+16.0d0*tmp2(jxo^s)-30.0d0*tmp2(ixo^s)+16.0d0*tmp2(hxo^s)-tmp2(kxo^s)) &
2871 tmp2(ixi^s)=bf(ixi^s,idir)
2873 jxo^
l=ixo^
l+
kr(idim,^
d);
2874 hxo^
l=ixo^
l-
kr(idim,^
d);
2875 tmp(ixo^s)=tmp(ixo^s)+&
2876 (tmp2(jxo^s)-2.0d0*tmp2(ixo^s)+tmp2(hxo^s))/
dxlevel(idim)**2
2880 tmp(ixo^s)=tmp(ixo^s)*eta(ixo^s)
2883 do jdir=1,
ndim;
do kdir=idirmin,3
2884 if (
lvc(idir,jdir,kdir)/=0)
then
2885 if (
lvc(idir,jdir,kdir)==1)
then
2886 tmp(ixo^s)=tmp(ixo^s)-gradeta(ixo^s,jdir)*current(ixo^s,kdir)
2888 tmp(ixo^s)=tmp(ixo^s)+gradeta(ixo^s,jdir)*current(ixo^s,kdir)
2894 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))+qdt*tmp(ixo^s)
2895 if(total_energy)
then
2896 w(ixo^s,
e_)=w(ixo^s,
e_)+qdt*tmp(ixo^s)*bf(ixo^s,idir)
2901 w(ixo^s,
e_)=w(ixo^s,
e_)+qdt*eta(ixo^s)*sum(current(ixo^s,:)**2,dim=ndim+1)
2903 if (fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_res1')
2904 end subroutine add_source_res1
2908 subroutine add_source_res2(qdt,ixI^L,ixO^L,wCT,w,x)
2912 integer,
intent(in) :: ixi^
l, ixo^
l
2913 double precision,
intent(in) :: qdt
2914 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2915 double precision,
intent(inout) :: w(ixi^s,1:nw)
2917 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s),curlj(ixi^s,1:3)
2918 double precision :: tmpvec(ixi^s,1:3),tmp(ixo^s)
2919 integer :: ixa^
l,idir,idirmin,idirmin1
2922 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
2923 call mpistop(
"Error in add_source_res2: Non-conforming input limits")
2931 tmpvec(ixa^s,idir)=current(ixa^s,idir)*
rmhd_eta
2936 tmpvec(ixa^s,idir)=current(ixa^s,idir)*eta(ixa^s)
2944 w(ixo^s,mag(
ndir)) = w(ixo^s,mag(
ndir))-qdt*curlj(ixo^s,
ndir)
2947 w(ixo^s,mag(1:
ndir)) = w(ixo^s,mag(1:
ndir))-qdt*curlj(ixo^s,1:
ndir)
2951 tmp(ixo^s)=qdt*
rmhd_eta*sum(current(ixo^s,:)**2,dim=
ndim+1)
2953 tmp(ixo^s)=qdt*eta(ixo^s)*sum(current(ixo^s,:)**2,dim=
ndim+1)
2955 if(total_energy)
then
2958 w(ixo^s,
e_)=w(ixo^s,
e_)+tmp(ixo^s)-&
2959 qdt*sum(wct(ixo^s,mag(1:
ndir))*curlj(ixo^s,1:
ndir),dim=
ndim+1)
2962 w(ixo^s,
e_)=w(ixo^s,
e_)+tmp(ixo^s)
2965 if (
fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_res2')
2966 end subroutine add_source_res2
2970 subroutine add_source_hyperres(qdt,ixI^L,ixO^L,wCT,w,x)
2973 integer,
intent(in) :: ixi^
l, ixo^
l
2974 double precision,
intent(in) :: qdt
2975 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
2976 double precision,
intent(inout) :: w(ixi^s,1:nw)
2978 double precision :: current(ixi^s,7-2*
ndir:3)
2979 double precision :: tmpvec(ixi^s,1:3),tmpvec2(ixi^s,1:3),tmp(ixi^s),ehyper(ixi^s,1:3)
2980 integer :: ixa^
l,idir,jdir,kdir,idirmin,idirmin1
2983 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
2984 call mpistop(
"Error in add_source_hyperres: Non-conforming input limits")
2986 tmpvec(ixa^s,1:
ndir)=zero
2988 tmpvec(ixa^s,jdir)=current(ixa^s,jdir)
2991 call curlvector(tmpvec,ixi^
l,ixa^
l,tmpvec2,idirmin1,1,3)
2993 tmpvec(ixa^s,1:
ndir)=zero
2994 call curlvector(tmpvec2,ixi^
l,ixa^
l,tmpvec,idirmin1,1,3)
2997 tmpvec2(ixa^s,1:
ndir)=zero
2998 call curlvector(ehyper,ixi^
l,ixa^
l,tmpvec2,idirmin1,1,3)
3000 w(ixo^s,mag(idir)) = w(ixo^s,mag(idir))-tmpvec2(ixo^s,idir)*qdt
3002 if(total_energy)
then
3005 tmpvec2(ixa^s,1:
ndir)=zero
3006 do idir=1,
ndir;
do jdir=1,
ndir;
do kdir=idirmin,3
3007 tmpvec2(ixa^s,idir) = tmpvec(ixa^s,idir)&
3008 +
lvc(idir,jdir,kdir)*wct(ixa^s,mag(jdir))*ehyper(ixa^s,kdir)
3009 end do;
end do;
end do
3011 call divvector(tmpvec2,ixi^l,ixo^l,tmp)
3012 w(ixo^s,
e_)=w(ixo^s,
e_)+tmp(ixo^s)*qdt
3014 if (fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_hyperres')
3015 end subroutine add_source_hyperres
3017 subroutine add_source_glm(qdt,ixI^L,ixO^L,wCT,w,x)
3023 integer,
intent(in) :: ixi^
l, ixo^
l
3024 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3025 double precision,
intent(inout) :: w(ixi^s,1:nw)
3026 double precision:: divb(ixi^s), gradpsi(ixi^s), ba(ixo^s,1:
ndir)
3045 ba(ixo^s,1:
ndir)=wct(ixo^s,mag(1:
ndir))
3048 if(total_energy)
then
3057 w(ixo^s,
e_) = w(ixo^s,
e_)-qdt*ba(ixo^s,idir)*gradpsi(ixo^s)
3064 w(ixo^s,
mom(idir))=w(ixo^s,
mom(idir))-qdt*ba(ixo^s,idir)*divb(ixo^s)
3067 if (
fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_glm')
3068 end subroutine add_source_glm
3071 subroutine add_source_powel(qdt,ixI^L,ixO^L,wCT,w,x)
3073 integer,
intent(in) :: ixi^
l, ixo^
l
3074 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3075 double precision,
intent(inout) :: w(ixi^s,1:nw)
3076 double precision :: divb(ixi^s), ba(1:
ndir)
3077 integer :: idir, ix^
d
3082 {
do ix^db=ixomin^db,ixomax^db\}
3087 if (total_energy)
then
3093 {
do ix^db=ixomin^db,ixomax^db\}
3095 ^
c&w(ix^d,
b^
c_)=w(ix^d,
b^
c_)-qdt*wct(ix^d,
m^
c_)*divb(ix^d)\
3097 ^
c&w(ix^d,
m^
c_)=w(ix^d,
m^
c_)-qdt*wct(ix^d,
b^
c_)*divb(ix^d)\
3098 if (total_energy)
then
3100 w(ix^d,
e_)=w(ix^d,
e_)-qdt*(^
c&wct(ix^d,
m^
c_)*wct(ix^d,
b^
c_)+)*divb(ix^d)
3104 if (fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_powel')
3105 end subroutine add_source_powel
3107 subroutine add_source_janhunen(qdt,ixI^L,ixO^L,wCT,w,x)
3111 integer,
intent(in) :: ixi^
l, ixo^
l
3112 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3113 double precision,
intent(inout) :: w(ixi^s,1:nw)
3114 double precision :: divb(ixi^s)
3115 integer :: idir, ix^
d
3119 {
do ix^db=ixomin^db,ixomax^db\}
3123 if (fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_janhunen')
3124 end subroutine add_source_janhunen
3126 subroutine add_source_linde(qdt,ixI^L,ixO^L,wCT,w,x)
3130 integer,
intent(in) :: ixi^
l, ixo^
l
3131 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3132 double precision,
intent(inout) :: w(ixi^s,1:nw)
3133 double precision :: divb(ixi^s),graddivb(ixi^s)
3134 integer :: idim, idir, ixp^
l, i^
d, iside
3135 logical,
dimension(-1:1^D&) :: leveljump
3142 if(i^
d==0|.and.) cycle
3143 if(neighbor_type(i^
d,
block%igrid)==2 .or. neighbor_type(i^
d,
block%igrid)==4)
then
3144 leveljump(i^
d)=.true.
3146 leveljump(i^
d)=.false.
3154 i^dd=kr(^dd,^d)*(2*iside-3);
3155 if (leveljump(i^dd))
then
3157 ixpmin^d=ixomin^d-i^d
3159 ixpmax^d=ixomax^d-i^d
3169 select case(typegrad)
3171 call gradient(divb,ixi^l,ixp^l,idim,graddivb)
3173 call gradientl(divb,ixi^l,ixp^l,idim,graddivb)
3176 if (slab_uniform)
then
3177 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff/(^d&1.0d0/dxlevel(^d)**2+)
3179 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff &
3180 /(^d&1.0d0/block%ds(ixp^s,^d)**2+)
3182 w(ixp^s,mag(idim))=w(ixp^s,mag(idim))+graddivb(ixp^s)
3184 if (typedivbdiff==
'all' .and. total_energy)
then
3186 w(ixp^s,
e_)=w(ixp^s,
e_)+wct(ixp^s,mag(idim))*graddivb(ixp^s)
3189 if (fix_small_values)
call rmhd_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_linde')
3190 end subroutine add_source_linde
3195 integer,
intent(in) :: ixi^
l, ixo^
l
3196 double precision,
intent(in) :: w(ixi^s,1:nw)
3197 double precision :: divb(ixi^s), dsurface(ixi^s)
3198 double precision :: invb(ixo^s)
3199 integer :: ixa^
l,idims
3201 call get_divb(w,ixi^
l,ixo^
l,divb)
3203 where(invb(ixo^s)/=0.d0)
3204 invb(ixo^s)=1.d0/invb(ixo^s)
3207 divb(ixo^s)=0.5d0*abs(divb(ixo^s))*invb(ixo^s)/sum(1.d0/
dxlevel(:))
3209 ixamin^
d=ixomin^
d-1;
3210 ixamax^
d=ixomax^
d-1;
3211 dsurface(ixo^s)= sum(
block%surfaceC(ixo^s,:),dim=
ndim+1)
3213 ixa^
l=ixo^
l-
kr(idims,^
d);
3214 dsurface(ixo^s)=dsurface(ixo^s)+
block%surfaceC(ixa^s,idims)
3216 divb(ixo^s)=abs(divb(ixo^s))*invb(ixo^s)*&
3217 block%dvolume(ixo^s)/dsurface(ixo^s)
3226 integer,
intent(in) :: ixo^
l, ixi^
l
3227 double precision,
intent(in) :: w(ixi^s,1:nw)
3228 integer,
intent(out) :: idirmin
3230 double precision :: current(ixi^s,7-2*
ndir:3)
3231 integer :: idir, idirmin0
3235 if(
b0field) current(ixo^s,idirmin0:3)=current(ixo^s,idirmin0:3)+&
3236 block%J0(ixo^s,idirmin0:3)
3240 subroutine rmhd_get_dt(w,ixI^L,ixO^L,dtnew,dx^D,x)
3248 integer,
intent(in) :: ixi^
l, ixo^
l
3249 double precision,
intent(inout) :: dtnew
3250 double precision,
intent(in) ::
dx^
d
3251 double precision,
intent(in) :: w(ixi^s,1:nw)
3252 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3253 double precision :: dxarr(
ndim)
3254 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s)
3255 integer :: idirmin,idim
3259 if (.not. dt_c)
then
3270 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/dxarr(idim)**2)))
3273 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/
block%ds(ixo^s,idim)**2)))
3291 call mpistop(
'Radiation formalism unknown')
3307 end subroutine rmhd_get_dt
3310 subroutine rmhd_add_source_geom(qdt,dtfactor,ixI^L,ixO^L,wCT,wprim,w,x)
3313 integer,
intent(in) :: ixi^
l, ixo^
l
3314 double precision,
intent(in) :: qdt, dtfactor,x(ixi^s,1:
ndim)
3315 double precision,
intent(inout) :: wct(ixi^s,1:nw),wprim(ixi^s,1:nw),w(ixi^s,1:nw)
3316 double precision :: tmp,tmp1,invr,cot
3318 integer :: mr_,mphi_
3319 integer :: br_,bphi_
3322 br_=mag(1); bphi_=mag(1)-1+
phi_
3325 {
do ix^db=ixomin^db,ixomax^db\}
3328 invr=
block%dt(ix^
d) * dtfactor/x(ix^
d,1)
3333 tmp=wprim(ix^
d,
p_)+half*(^
c&wprim(ix^
d,
b^
c_)**2+)
3338 w(ix^
d,mr_)=w(ix^
d,mr_)+invr*(tmp-&
3339 wprim(ix^
d,bphi_)**2+wprim(ix^
d,mphi_)*wct(ix^
d,mphi_))
3340 w(ix^
d,mphi_)=w(ix^
d,mphi_)+invr*(&
3341 -wct(ix^
d,mphi_)*wprim(ix^
d,mr_) &
3342 +wprim(ix^
d,bphi_)*wprim(ix^
d,br_))
3344 w(ix^
d,bphi_)=w(ix^
d,bphi_)+invr*&
3345 (wprim(ix^
d,bphi_)*wprim(ix^
d,mr_) &
3346 -wprim(ix^
d,br_)*wprim(ix^
d,mphi_))
3349 w(ix^
d,mr_)=w(ix^
d,mr_)+invr*tmp
3354 {
do ix^db=ixomin^db,ixomax^db\}
3356 if(local_timestep)
then
3357 invr=block%dt(ix^d) * dtfactor/x(ix^d,1)
3362 tmp1=wprim(ix^d,
p_)+half*(^
c&wprim(ix^d,
b^
c_)**2+)
3368 w(ix^d,
mom(1))=w(ix^d,
mom(1))+two*tmp1*invr
3371 w(ix^d,
mom(1))=w(ix^d,
mom(1))+invr*&
3372 (two*tmp1+(^ce&wprim(ix^d,
m^ce_)*wct(ix^d,
m^ce_)-wprim(ix^d,
b^ce_)**2+))
3376 w(ix^d,mag(1))=w(ix^d,mag(1))+invr*2.0d0*wprim(ix^d,
psi_)
3382 cot=1.d0/tan(x(ix^d,2))
3386 w(ix^d,
mom(2))=w(ix^d,
mom(2))+invr*(tmp1*cot-wprim(ix^d,m1_)*wct(ix^d,m2_)&
3387 +wprim(ix^d,b1_)*wprim(ix^d,b2_))
3389 if(.not.stagger_grid)
then
3390 tmp=wprim(ix^d,m1_)*wprim(ix^d,b2_)-wprim(ix^d,m2_)*wprim(ix^d,b1_)
3392 tmp=tmp+wprim(ix^d,
psi_)*cot
3394 w(ix^d,mag(2))=w(ix^d,mag(2))+tmp*invr
3399 w(ix^d,
mom(2))=w(ix^d,
mom(2))+invr*(tmp1*cot-wprim(ix^d,m1_)*wct(ix^d,m2_)&
3400 +wprim(ix^d,b1_)*wprim(ix^d,b2_)&
3401 +(wprim(ix^d,m3_)*wct(ix^d,m3_)-wprim(ix^d,b3_)**2)*cot)
3403 if(.not.stagger_grid)
then
3404 tmp=wprim(ix^d,m1_)*wprim(ix^d,b2_)-wprim(ix^d,m2_)*wprim(ix^d,b1_)
3406 tmp=tmp+wprim(ix^d,
psi_)*cot
3408 w(ix^d,mag(2))=w(ix^d,mag(2))+tmp*invr
3411 w(ix^d,
mom(3))=w(ix^d,
mom(3))-invr*&
3412 (wprim(ix^d,m3_)*wct(ix^d,m1_) &
3413 -wprim(ix^d,b3_)*wprim(ix^d,b1_) &
3414 +(wprim(ix^d,m2_)*wct(ix^d,m3_) &
3415 -wprim(ix^d,b2_)*wprim(ix^d,b3_))*cot)
3417 if(.not.stagger_grid)
then
3418 w(ix^d,mag(3))=w(ix^d,mag(3))+invr*&
3419 (wprim(ix^d,m1_)*wprim(ix^d,b3_) &
3420 -wprim(ix^d,m3_)*wprim(ix^d,b1_) &
3421 -(wprim(ix^d,m3_)*wprim(ix^d,b2_) &
3422 -wprim(ix^d,m2_)*wprim(ix^d,b3_))*cot)
3427 end subroutine rmhd_add_source_geom
3430 subroutine rmhd_add_source_geom_split(qdt,dtfactor, ixI^L,ixO^L,wCT,wprim,w,x)
3433 integer,
intent(in) :: ixi^
l, ixo^
l
3434 double precision,
intent(in) :: qdt, dtfactor, x(ixi^s,1:
ndim)
3435 double precision,
intent(inout) :: wct(ixi^s,1:nw), wprim(ixi^s,1:nw),w(ixi^s,1:nw)
3436 double precision :: tmp(ixi^s),tmp1(ixi^s),tmp2(ixi^s),invrho(ixo^s),invr(ixo^s)
3437 integer :: iw,idir, h1x^
l{^nooned, h2x^
l}
3438 integer :: mr_,mphi_
3439 integer :: br_,bphi_
3442 br_=mag(1); bphi_=mag(1)-1+
phi_
3446 invrho(ixo^s) = 1d0/wct(ixo^s,
rho_)
3450 invr(ixo^s) =
block%dt(ixo^s) * dtfactor/x(ixo^s,1)
3452 invr(ixo^s) = qdt/x(ixo^s,1)
3457 call rmhd_get_p_total(wct,x,ixi^
l,ixo^
l,tmp)
3459 w(ixo^s,mr_)=w(ixo^s,mr_)+invr(ixo^s)*(tmp(ixo^s)-&
3460 wct(ixo^s,bphi_)**2+wct(ixo^s,mphi_)**2*invrho(ixo^s))
3461 w(ixo^s,mphi_)=w(ixo^s,mphi_)+qdt*invr(ixo^s)*(&
3462 -wct(ixo^s,mphi_)*wct(ixo^s,mr_)*invrho(ixo^s) &
3463 +wct(ixo^s,bphi_)*wct(ixo^s,br_))
3465 w(ixo^s,bphi_)=w(ixo^s,bphi_)+invr(ixo^s)*&
3466 (wct(ixo^s,bphi_)*wct(ixo^s,mr_) &
3467 -wct(ixo^s,br_)*wct(ixo^s,mphi_)) &
3471 w(ixo^s,mr_)=w(ixo^s,mr_)+invr(ixo^s)*tmp(ixo^s)
3473 if(
rmhd_glm) w(ixo^s,br_)=w(ixo^s,br_)+wct(ixo^s,
psi_)*invr(ixo^s)
3475 h1x^
l=ixo^
l-
kr(1,^
d); {^nooned h2x^
l=ixo^
l-
kr(2,^
d);}
3476 call rmhd_get_p_total(wct,x,ixi^
l,ixo^
l,tmp1)
3477 tmp(ixo^s)=tmp1(ixo^s)
3479 tmp2(ixo^s)=sum(
block%B0(ixo^s,:,0)*wct(ixo^s,mag(:)),dim=
ndim+1)
3480 tmp(ixo^s)=tmp(ixo^s)+tmp2(ixo^s)
3483 tmp(ixo^s)=tmp(ixo^s)*x(ixo^s,1) &
3484 *(
block%surfaceC(ixo^s,1)-
block%surfaceC(h1x^s,1))/
block%dvolume(ixo^s)
3487 tmp(ixo^s)=tmp(ixo^s)+wct(ixo^s,
mom(idir))**2*invrho(ixo^s)-wct(ixo^s,mag(idir))**2
3488 if(
b0field) tmp(ixo^s)=tmp(ixo^s)-2.0d0*
block%B0(ixo^s,idir,0)*wct(ixo^s,mag(idir))
3491 w(ixo^s,
mom(1))=w(ixo^s,
mom(1))+tmp(ixo^s)*invr(ixo^s)
3494 w(ixo^s,mag(1))=w(ixo^s,mag(1))+invr(ixo^s)*2.0d0*wct(ixo^s,
psi_)
3498 tmp(ixo^s)=tmp1(ixo^s)
3500 tmp(ixo^s)=tmp(ixo^s)+tmp2(ixo^s)
3503 tmp1(ixo^s) =
block%dt(ixo^s) * tmp(ixo^s)
3505 tmp1(ixo^s) = qdt * tmp(ixo^s)
3508 w(ixo^s,
mom(2))=w(ixo^s,
mom(2))+tmp1(ixo^s) &
3509 *(
block%surfaceC(ixo^s,2)-
block%surfaceC(h2x^s,2)) &
3510 /
block%dvolume(ixo^s)
3511 tmp(ixo^s)=-(wct(ixo^s,
mom(1))*wct(ixo^s,
mom(2))*invrho(ixo^s) &
3512 -wct(ixo^s,mag(1))*wct(ixo^s,mag(2)))
3514 tmp(ixo^s)=tmp(ixo^s)+
block%B0(ixo^s,1,0)*wct(ixo^s,mag(2)) &
3515 +wct(ixo^s,mag(1))*
block%B0(ixo^s,2,0)
3518 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom(3))**2*invrho(ixo^s) &
3519 -wct(ixo^s,mag(3))**2)*dcos(x(ixo^s,2))/dsin(x(ixo^s,2))
3521 tmp(ixo^s)=tmp(ixo^s)-2.0d0*
block%B0(ixo^s,3,0)*wct(ixo^s,mag(3))&
3522 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2))
3525 w(ixo^s,
mom(2))=w(ixo^s,
mom(2))+tmp(ixo^s)*invr(ixo^s)
3528 tmp(ixo^s)=(wct(ixo^s,
mom(1))*wct(ixo^s,mag(2)) &
3529 -wct(ixo^s,
mom(2))*wct(ixo^s,mag(1)))*invrho(ixo^s)
3531 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom(1))*
block%B0(ixo^s,2,0) &
3532 -wct(ixo^s,
mom(2))*
block%B0(ixo^s,1,0))*invrho(ixo^s)
3535 tmp(ixo^s)=tmp(ixo^s) &
3536 + dcos(x(ixo^s,2))/dsin(x(ixo^s,2))*wct(ixo^s,
psi_)
3538 w(ixo^s,mag(2))=w(ixo^s,mag(2))+tmp(ixo^s)*invr(ixo^s)
3543 tmp(ixo^s)=-(wct(ixo^s,
mom(3))*wct(ixo^s,
mom(1))*invrho(ixo^s) &
3544 -wct(ixo^s,mag(3))*wct(ixo^s,mag(1))) {^nooned &
3545 -(wct(ixo^s,
mom(2))*wct(ixo^s,
mom(3))*invrho(ixo^s) &
3546 -wct(ixo^s,mag(2))*wct(ixo^s,mag(3))) &
3547 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2)) }
3549 tmp(ixo^s)=tmp(ixo^s)+
block%B0(ixo^s,1,0)*wct(ixo^s,mag(3)) &
3550 +wct(ixo^s,mag(1))*
block%B0(ixo^s,3,0) {^nooned &
3551 +(
block%B0(ixo^s,2,0)*wct(ixo^s,mag(3)) &
3552 +wct(ixo^s,mag(2))*
block%B0(ixo^s,3,0)) &
3553 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2)) }
3555 w(ixo^s,
mom(3))=w(ixo^s,
mom(3))+tmp(ixo^s)*invr(ixo^s)
3558 tmp(ixo^s)=(wct(ixo^s,
mom(1))*wct(ixo^s,mag(3)) &
3559 -wct(ixo^s,
mom(3))*wct(ixo^s,mag(1)))*invrho(ixo^s) {^nooned &
3560 -(wct(ixo^s,
mom(3))*wct(ixo^s,mag(2)) &
3561 -wct(ixo^s,
mom(2))*wct(ixo^s,mag(3)))*dcos(x(ixo^s,2)) &
3562 *invrho(ixo^s)/dsin(x(ixo^s,2)) }
3564 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom(1))*
block%B0(ixo^s,3,0) &
3565 -wct(ixo^s,
mom(3))*
block%B0(ixo^s,1,0))*invrho(ixo^s){^nooned &
3566 -(wct(ixo^s,
mom(3))*
block%B0(ixo^s,2,0) &
3567 -wct(ixo^s,
mom(2))*
block%B0(ixo^s,3,0))*dcos(x(ixo^s,2)) &
3568 *invrho(ixo^s)/dsin(x(ixo^s,2)) }
3570 w(ixo^s,mag(3))=w(ixo^s,mag(3))+tmp(ixo^s)*invr(ixo^s)
3574 end subroutine rmhd_add_source_geom_split
3579 integer,
intent(in) :: ixi^
l, ixo^
l
3580 double precision,
intent(in) :: w(ixi^s, nw)
3581 double precision :: mge(ixo^s)
3584 mge = sum((w(ixo^s, mag(:))+
block%B0(ixo^s,:,
b0i))**2, dim=
ndim+1)
3586 mge = sum(w(ixo^s, mag(:))**2, dim=
ndim+1)
3590 subroutine rmhd_modify_wlr(ixI^L,ixO^L,qt,wLC,wRC,wLp,wRp,s,idir)
3593 integer,
intent(in) :: ixi^
l, ixo^
l, idir
3594 double precision,
intent(in) :: qt
3595 double precision,
intent(inout) :: wlc(ixi^s,1:nw), wrc(ixi^s,1:nw)
3596 double precision,
intent(inout) :: wlp(ixi^s,1:nw), wrp(ixi^s,1:nw)
3598 double precision :: db(ixo^s), dpsi(ixo^s)
3602 {
do ix^db=ixomin^db,ixomax^db\}
3603 wlc(ix^
d,mag(idir))=s%ws(ix^
d,idir)
3604 wrc(ix^
d,mag(idir))=s%ws(ix^
d,idir)
3605 wlp(ix^
d,mag(idir))=s%ws(ix^
d,idir)
3606 wrp(ix^
d,mag(idir))=s%ws(ix^
d,idir)
3615 {
do ix^db=ixomin^db,ixomax^db\}
3616 db(ix^d)=wrp(ix^d,mag(idir))-wlp(ix^d,mag(idir))
3617 dpsi(ix^d)=wrp(ix^d,
psi_)-wlp(ix^d,
psi_)
3618 wlp(ix^d,mag(idir))=half*(wrp(ix^d,mag(idir))+wlp(ix^d,mag(idir))-dpsi(ix^d)/cmax_global)
3619 wlp(ix^d,
psi_)=half*(wrp(ix^d,
psi_)+wlp(ix^d,
psi_)-db(ix^d)*cmax_global)
3620 wrp(ix^d,mag(idir))=wlp(ix^d,mag(idir))
3622 if(total_energy)
then
3623 wrc(ix^d,
e_)=wrc(ix^d,
e_)-half*wrc(ix^d,mag(idir))**2
3624 wlc(ix^d,
e_)=wlc(ix^d,
e_)-half*wlc(ix^d,mag(idir))**2
3626 wrc(ix^d,mag(idir))=wlp(ix^d,mag(idir))
3628 wlc(ix^d,mag(idir))=wlp(ix^d,mag(idir))
3631 if(total_energy)
then
3632 wrc(ix^d,
e_)=wrc(ix^d,
e_)+half*wrc(ix^d,mag(idir))**2
3633 wlc(ix^d,
e_)=wlc(ix^d,
e_)+half*wlc(ix^d,mag(idir))**2
3637 if(
associated(usr_set_wlr))
call usr_set_wlr(ixi^l,ixo^l,qt,wlc,wrc,wlp,wrp,s,idir)
3638 end subroutine rmhd_modify_wlr
3640 subroutine rmhd_boundary_adjust(igrid,psb)
3642 integer,
intent(in) :: igrid
3644 integer :: ib, idims, iside, ixo^
l, i^
d
3653 i^
d=
kr(^
d,idims)*(2*iside-3);
3654 if (neighbor_type(i^
d,igrid)/=1) cycle
3655 ib=(idims-1)*2+iside
3673 call fixdivb_boundary(ixg^
ll,ixo^
l,psb(igrid)%w,psb(igrid)%x,ib)
3677 end subroutine rmhd_boundary_adjust
3679 subroutine fixdivb_boundary(ixG^L,ixO^L,w,x,iB)
3681 integer,
intent(in) :: ixg^
l,ixo^
l,ib
3682 double precision,
intent(inout) :: w(ixg^s,1:nw)
3683 double precision,
intent(in) :: x(ixg^s,1:
ndim)
3684 double precision :: dx1x2,dx1x3,dx2x1,dx2x3,dx3x1,dx3x2
3685 integer :: ix^
d,ixf^
l
3698 do ix1=ixfmax1,ixfmin1,-1
3699 w(ix1-1,ixfmin2:ixfmax2,mag(1))=w(ix1+1,ixfmin2:ixfmax2,mag(1)) &
3700 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
3701 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
3704 do ix1=ixfmax1,ixfmin1,-1
3705 w(ix1-1,ixfmin2:ixfmax2,mag(1))=( (w(ix1+1,ixfmin2:ixfmax2,mag(1))+&
3706 w(ix1,ixfmin2:ixfmax2,mag(1)))*
block%surfaceC(ix1,ixfmin2:ixfmax2,1)&
3707 +(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
3708 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
3709 -(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
3710 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
3711 /
block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
3725 do ix1=ixfmax1,ixfmin1,-1
3726 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
3727 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
3728 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
3729 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
3730 +dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
3731 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
3734 do ix1=ixfmax1,ixfmin1,-1
3735 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
3736 ( (w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
3737 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
3738 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
3739 +(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
3740 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
3741 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
3742 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
3743 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
3744 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
3745 +(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
3746 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
3747 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
3748 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
3749 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
3750 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
3751 /
block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
3752 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
3766 do ix1=ixfmin1,ixfmax1
3767 w(ix1+1,ixfmin2:ixfmax2,mag(1))=w(ix1-1,ixfmin2:ixfmax2,mag(1)) &
3768 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
3769 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
3772 do ix1=ixfmin1,ixfmax1
3773 w(ix1+1,ixfmin2:ixfmax2,mag(1))=( (w(ix1-1,ixfmin2:ixfmax2,mag(1))+&
3774 w(ix1,ixfmin2:ixfmax2,mag(1)))*
block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)&
3775 -(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
3776 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
3777 +(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
3778 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
3779 /
block%surfaceC(ix1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
3793 do ix1=ixfmin1,ixfmax1
3794 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
3795 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
3796 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
3797 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
3798 -dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
3799 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
3802 do ix1=ixfmin1,ixfmax1
3803 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
3804 ( (w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
3805 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
3806 block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
3807 -(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
3808 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
3809 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
3810 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
3811 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
3812 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
3813 -(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
3814 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
3815 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
3816 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
3817 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
3818 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
3819 /
block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
3820 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
3834 do ix2=ixfmax2,ixfmin2,-1
3835 w(ixfmin1:ixfmax1,ix2-1,mag(2))=w(ixfmin1:ixfmax1,ix2+1,mag(2)) &
3836 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
3837 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
3840 do ix2=ixfmax2,ixfmin2,-1
3841 w(ixfmin1:ixfmax1,ix2-1,mag(2))=( (w(ixfmin1:ixfmax1,ix2+1,mag(2))+&
3842 w(ixfmin1:ixfmax1,ix2,mag(2)))*
block%surfaceC(ixfmin1:ixfmax1,ix2,2)&
3843 +(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
3844 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
3845 -(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
3846 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
3847 /
block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
3861 do ix2=ixfmax2,ixfmin2,-1
3862 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
3863 ix2+1,ixfmin3:ixfmax3,mag(2)) &
3864 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
3865 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
3866 +dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
3867 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
3870 do ix2=ixfmax2,ixfmin2,-1
3871 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=&
3872 ( (w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))+&
3873 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
3874 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)&
3875 +(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
3876 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
3877 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
3878 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
3879 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
3880 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
3881 +(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
3882 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
3883 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
3884 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
3885 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
3886 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
3887 /
block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)-&
3888 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
3902 do ix2=ixfmin2,ixfmax2
3903 w(ixfmin1:ixfmax1,ix2+1,mag(2))=w(ixfmin1:ixfmax1,ix2-1,mag(2)) &
3904 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
3905 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
3908 do ix2=ixfmin2,ixfmax2
3909 w(ixfmin1:ixfmax1,ix2+1,mag(2))=( (w(ixfmin1:ixfmax1,ix2-1,mag(2))+&
3910 w(ixfmin1:ixfmax1,ix2,mag(2)))*
block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)&
3911 -(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
3912 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
3913 +(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
3914 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
3915 /
block%surfaceC(ixfmin1:ixfmax1,ix2,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
3929 do ix2=ixfmin2,ixfmax2
3930 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
3931 ix2-1,ixfmin3:ixfmax3,mag(2)) &
3932 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
3933 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
3934 -dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
3935 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
3938 do ix2=ixfmin2,ixfmax2
3939 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=&
3940 ( (w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))+&
3941 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
3942 block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)&
3943 -(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
3944 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
3945 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
3946 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
3947 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
3948 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
3949 -(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
3950 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
3951 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
3952 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
3953 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
3954 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
3955 /
block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)-&
3956 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
3973 do ix3=ixfmax3,ixfmin3,-1
3974 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=w(ixfmin1:ixfmax1,&
3975 ixfmin2:ixfmax2,ix3+1,mag(3)) &
3976 +dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
3977 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
3978 +dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
3979 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
3982 do ix3=ixfmax3,ixfmin3,-1
3983 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=&
3984 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))+&
3985 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
3986 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)&
3987 +(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
3988 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
3989 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
3990 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
3991 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
3992 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
3993 +(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
3994 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
3995 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
3996 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
3997 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
3998 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
3999 /
block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)-&
4000 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
4015 do ix3=ixfmin3,ixfmax3
4016 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=w(ixfmin1:ixfmax1,&
4017 ixfmin2:ixfmax2,ix3-1,mag(3)) &
4018 -dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
4019 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
4020 -dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
4021 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
4024 do ix3=ixfmin3,ixfmax3
4025 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=&
4026 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))+&
4027 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
4028 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)&
4029 -(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
4030 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
4031 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
4032 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
4033 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
4034 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
4035 -(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
4036 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
4037 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
4038 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
4039 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
4040 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
4041 /
block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)-&
4042 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
4048 call mpistop(
"Special boundary is not defined for this region")
4050 end subroutine fixdivb_boundary
4058 double precision,
intent(in) :: qdt
4059 double precision,
intent(in) :: qt
4060 logical,
intent(inout) :: active
4062 integer,
parameter :: max_its = 50
4063 double precision :: residual_it(max_its), max_divb
4064 double precision :: tmp(ixg^t), grad(ixg^t,
ndim)
4065 double precision :: res
4066 double precision,
parameter :: max_residual = 1
d-3
4067 double precision,
parameter :: residual_reduction = 1
d-10
4068 integer :: iigrid, igrid
4069 integer :: n, nc, lvl, ix^
l, ixc^
l, idim
4072 mg%operator_type = mg_laplacian
4079 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
4080 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
4083 mg%bc(n, mg_iphi)%bc_type = mg_bc_neumann
4084 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
4086 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
4087 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
4090 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
4091 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
4095 write(*,*)
"rmhd_clean_divb_multigrid warning: unknown boundary type"
4096 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
4097 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
4104 do iigrid = 1, igridstail
4105 igrid = igrids(iigrid);
4108 lvl =
mg%boxes(id)%lvl
4109 nc =
mg%box_size_lvl(lvl)
4115 call get_divb(ps(igrid)%w(ixg^t, 1:nw), ixg^
ll,
ixm^
ll, tmp, &
4117 mg%boxes(id)%cc({1:nc}, mg_irhs) = tmp(
ixm^t)
4118 max_divb = max(max_divb, maxval(abs(tmp(
ixm^t))))
4123 call mpi_allreduce(mpi_in_place, max_divb, 1, mpi_double_precision, &
4126 if (
mype == 0) print *,
"Performing multigrid divB cleaning"
4127 if (
mype == 0) print *,
"iteration vs residual"
4130 call mg_fas_fmg(
mg, n>1, max_res=residual_it(n))
4131 if (
mype == 0)
write(*,
"(I4,E11.3)") n, residual_it(n)
4132 if (residual_it(n) < residual_reduction * max_divb)
exit
4134 if (
mype == 0 .and. n > max_its)
then
4135 print *,
"divb_multigrid warning: not fully converged"
4136 print *,
"current amplitude of divb: ", residual_it(max_its)
4137 print *,
"multigrid smallest grid: ", &
4138 mg%domain_size_lvl(:,
mg%lowest_lvl)
4139 print *,
"note: smallest grid ideally has <= 8 cells"
4140 print *,
"multigrid dx/dy/dz ratio: ",
mg%dr(:, 1)/
mg%dr(1, 1)
4141 print *,
"note: dx/dy/dz should be similar"
4145 call mg_fas_vcycle(
mg, max_res=res)
4146 if (res < max_residual)
exit
4148 if (res > max_residual)
call mpistop(
"divb_multigrid: no convergence")
4152 do iigrid = 1, igridstail
4153 igrid = igrids(iigrid);
4160 tmp(ix^s) =
mg%boxes(id)%cc({:,}, mg_iphi)
4163 ixcmin^
d=ixmlo^
d-
kr(idim,^
d);
4165 call gradientf(tmp,ps(igrid)%x,ixg^
ll,ixc^
l,idim,grad(ixg^t,idim))
4167 ps(igrid)%ws(ixc^s,idim)=ps(igrid)%ws(ixc^s,idim)-grad(ixc^s,idim)
4180 ps(igrid)%w(
ixm^t, mag(1:
ndim)) = &
4181 ps(igrid)%w(
ixm^t, mag(1:
ndim)) - grad(
ixm^t, :)
4183 if(total_energy)
then
4185 tmp(
ixm^t) = 0.5_dp * (sum(ps(igrid)%w(
ixm^t, &
4188 ps(igrid)%w(
ixm^t,
e_) = ps(igrid)%w(
ixm^t,
e_) + tmp(
ixm^t)
4195 subroutine rmhd_update_faces(ixI^L,ixO^L,qt,qdt,wprim,fC,fE,sCT,s,vcts)
4197 integer,
intent(in) :: ixi^
l, ixo^
l
4198 double precision,
intent(in) :: qt,qdt
4200 double precision,
intent(in) :: wprim(ixi^s,1:nw)
4201 type(state) :: sct, s
4202 type(ct_velocity) :: vcts
4203 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
4204 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
4208 call update_faces_average(ixi^
l,ixo^
l,qt,qdt,fc,fe,sct,s)
4210 call update_faces_contact(ixi^
l,ixo^
l,qt,qdt,wprim,fc,fe,sct,s,vcts)
4212 call update_faces_hll(ixi^
l,ixo^
l,qt,qdt,fe,sct,s,vcts)
4214 call mpistop(
'choose average, uct_contact,or uct_hll for type_ct!')
4216 end subroutine rmhd_update_faces
4219 subroutine update_faces_average(ixI^L,ixO^L,qt,qdt,fC,fE,sCT,s)
4222 integer,
intent(in) :: ixi^
l, ixo^
l
4223 double precision,
intent(in) :: qt, qdt
4224 type(state) :: sct, s
4225 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
4226 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
4227 double precision :: circ(ixi^s,1:
ndim)
4229 double precision,
dimension(ixI^S,sdim:3) :: e_resi
4230 integer :: ix^
d,ixc^
l,ixa^
l,i1kr^
d,i2kr^
d
4231 integer :: idim1,idim2,idir,iwdim1,iwdim2
4233 associate(bfaces=>s%ws,x=>s%x)
4238 if(
rmhd_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
4241 i1kr^
d=
kr(idim1,^
d);
4244 i2kr^
d=
kr(idim2,^
d);
4247 if (
lvc(idim1,idim2,idir)==1)
then
4249 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
4251 {
do ix^db=ixcmin^db,ixcmax^db\}
4252 fe(ix^
d,idir)=quarter*&
4253 (fc(ix^
d,iwdim1,idim2)+fc({ix^
d+i1kr^
d},iwdim1,idim2)&
4254 -fc(ix^
d,iwdim2,idim1)-fc({ix^
d+i2kr^
d},iwdim2,idim1))
4256 if(
rmhd_eta/=zero) fe(ix^
d,idir)=fe(ix^
d,idir)+e_resi(ix^
d,idir)
4258 fe(ix^
d,idir)=fe(ix^
d,idir)*qdt*s%dsC(ix^
d,idir)
4265 if(
associated(usr_set_electric_field)) &
4266 call usr_set_electric_field(ixi^l,ixo^l,qt,qdt,fe,sct)
4267 circ(ixi^s,1:ndim)=zero
4271 ixcmin^d=ixomin^d-kr(idim1,^d);
4273 ixa^l=ixc^l-kr(idim2,^d);
4276 if(lvc(idim1,idim2,idir)==1)
then
4278 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
4281 else if(lvc(idim1,idim2,idir)==-1)
then
4283 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
4290 where(s%surfaceC(ixc^s,idim1) > 1.0d-9*s%dvolume(ixc^s))
4291 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
4293 circ(ixc^s,idim1)=zero
4296 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
4299 end subroutine update_faces_average
4302 subroutine update_faces_contact(ixI^L,ixO^L,qt,qdt,wp,fC,fE,sCT,s,vcts)
4306 integer,
intent(in) :: ixi^
l, ixo^
l
4307 double precision,
intent(in) :: qt, qdt
4309 double precision,
intent(in) :: wp(ixi^s,1:nw)
4310 type(state) :: sct, s
4311 type(ct_velocity) :: vcts
4312 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
4313 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
4314 double precision :: circ(ixi^s,1:
ndim)
4316 double precision :: ecc(ixi^s,
sdim:3)
4317 double precision :: ein(ixi^s,
sdim:3)
4319 double precision :: el(ixi^s),er(ixi^s)
4321 double precision :: elc,erc
4323 double precision,
dimension(ixI^S,sdim:3) :: e_resi
4325 double precision :: jce(ixi^s,
sdim:3)
4327 double precision :: xs(ixgs^t,1:
ndim)
4328 double precision :: gradi(ixgs^t)
4329 integer :: ixc^
l,ixa^
l
4330 integer :: idim1,idim2,idir,iwdim1,iwdim2,ix^
d,i1kr^
d,i2kr^
d
4332 associate(bfaces=>s%ws,x=>s%x,w=>s%w,vnorm=>vcts%vnorm,wcts=>sct%ws)
4334 if(
rmhd_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
4336 {
do ix^db=iximin^db,iximax^db\}
4339 ecc(ix^
d,1)=(wp(ix^
d,b2_)+
block%B0(ix^
d,2,0))*wp(ix^
d,m3_)-(wp(ix^
d,b3_)+
block%B0(ix^
d,3,0))*wp(ix^
d,m2_)
4340 ecc(ix^
d,2)=(wp(ix^
d,b3_)+
block%B0(ix^
d,3,0))*wp(ix^
d,m1_)-(wp(ix^
d,b1_)+
block%B0(ix^
d,1,0))*wp(ix^
d,m3_)
4341 ecc(ix^
d,3)=(wp(ix^
d,b1_)+
block%B0(ix^
d,1,0))*wp(ix^
d,m2_)-(wp(ix^
d,b2_)+
block%B0(ix^
d,2,0))*wp(ix^
d,m1_)
4344 ecc(ix^
d,3)=wp(ix^
d,b1_)*wp(ix^
d,m2_)-wp(ix^
d,b2_)*wp(ix^
d,m1_)
4351 {
do ix^db=iximin^db,iximax^db\}
4354 ecc(ix^d,1)=wp(ix^d,b2_)*wp(ix^d,m3_)-wp(ix^d,b3_)*wp(ix^d,m2_)
4355 ecc(ix^d,2)=wp(ix^d,b3_)*wp(ix^d,m1_)-wp(ix^d,b1_)*wp(ix^d,m3_)
4356 ecc(ix^d,3)=wp(ix^d,b1_)*wp(ix^d,m2_)-wp(ix^d,b2_)*wp(ix^d,m1_)
4359 ecc(ix^d,3)=wp(ix^d,b1_)*wp(ix^d,m2_)-wp(ix^d,b2_)*wp(ix^d,m1_)
4373 i1kr^d=kr(idim1,^d);
4376 i2kr^d=kr(idim2,^d);
4379 if (lvc(idim1,idim2,idir)==1)
then
4381 ixcmin^d=ixomin^d+kr(idir,^d)-1;
4384 {
do ix^db=ixcmin^db,ixcmax^db\}
4385 fe(ix^d,idir)=quarter*&
4386 (fc(ix^d,iwdim1,idim2)+fc({ix^d+i1kr^d},iwdim1,idim2)&
4387 -fc(ix^d,iwdim2,idim1)-fc({ix^d+i2kr^d},iwdim2,idim1))
4392 ixamax^d=ixcmax^d+i1kr^d;
4393 {
do ix^db=ixamin^db,ixamax^db\}
4394 el(ix^d)=fc(ix^d,iwdim1,idim2)-ecc(ix^d,idir)
4395 er(ix^d)=fc(ix^d,iwdim1,idim2)-ecc({ix^d+i2kr^d},idir)
4398 do ix^db=ixcmin^db,ixcmax^db\}
4399 if(vnorm(ix^d,idim1)>0.d0)
then
4401 else if(vnorm(ix^d,idim1)<0.d0)
then
4402 elc=el({ix^d+i1kr^d})
4404 elc=0.5d0*(el(ix^d)+el({ix^d+i1kr^d}))
4406 if(vnorm({ix^d+i2kr^d},idim1)>0.d0)
then
4408 else if(vnorm({ix^d+i2kr^d},idim1)<0.d0)
then
4409 erc=er({ix^d+i1kr^d})
4411 erc=0.5d0*(er(ix^d)+er({ix^d+i1kr^d}))
4413 fe(ix^d,idir)=fe(ix^d,idir)+0.25d0*(elc+erc)
4417 ixamax^d=ixcmax^d+i2kr^d;
4418 {
do ix^db=ixamin^db,ixamax^db\}
4419 el(ix^d)=-fc(ix^d,iwdim2,idim1)-ecc(ix^d,idir)
4420 er(ix^d)=-fc(ix^d,iwdim2,idim1)-ecc({ix^d+i1kr^d},idir)
4423 do ix^db=ixcmin^db,ixcmax^db\}
4424 if(vnorm(ix^d,idim2)>0.d0)
then
4426 else if(vnorm(ix^d,idim2)<0.d0)
then
4427 elc=el({ix^d+i2kr^d})
4429 elc=0.5d0*(el(ix^d)+el({ix^d+i2kr^d}))
4431 if(vnorm({ix^d+i1kr^d},idim2)>0.d0)
then
4433 else if(vnorm({ix^d+i1kr^d},idim2)<0.d0)
then
4434 erc=er({ix^d+i2kr^d})
4436 erc=0.5d0*(er(ix^d)+er({ix^d+i2kr^d}))
4438 fe(ix^d,idir)=fe(ix^d,idir)+0.25d0*(elc+erc)
4442 if(
rmhd_eta/=zero) fe(ix^d,idir)=fe(ix^d,idir)+e_resi(ix^d,idir)
4444 fe(ix^d,idir)=fe(ix^d,idir)*qdt*s%dsC(ix^d,idir)
4457 if (lvc(idim1,idim2,idir)==0) cycle
4459 ixcmin^d=ixomin^d+kr(idir,^d)-1;
4460 ixamax^d=ixcmax^d-kr(idir,^d)+1;
4463 xs(ixa^s,:)=x(ixa^s,:)
4464 xs(ixa^s,idim2)=x(ixa^s,idim2)+half*s%dx(ixa^s,idim2)
4465 call gradientf(wcts(ixgs^t,idim2),xs,ixgs^ll,ixc^l,idim1,gradi)
4466 if (lvc(idim1,idim2,idir)==1)
then
4467 jce(ixc^s,idir)=jce(ixc^s,idir)+gradi(ixc^s)
4469 jce(ixc^s,idir)=jce(ixc^s,idir)-gradi(ixc^s)
4476 ixcmin^d=ixomin^d+kr(idir,^d)-1;
4478 ein(ixc^s,idir)=ein(ixc^s,idir)*jce(ixc^s,idir)
4482 {
do ix^db=ixomin^db,ixomax^db\}
4483 jce(ix^d,idir)=0.25d0*(ein(ix^d,idir)+ein(ix1,ix2-1,ix3,idir)+ein(ix1,ix2,ix3-1,idir)&
4484 +ein(ix1,ix2-1,ix3-1,idir))
4485 if(jce(ix^d,idir)<0.d0) jce(ix^d,idir)=0.d0
4486 w(ix^d,
e_)=w(ix^d,
e_)+qdt*jce(ix^d,idir)
4488 else if(idir==2)
then
4489 {
do ix^db=ixomin^db,ixomax^db\}
4490 jce(ix^d,idir)=0.25d0*(ein(ix^d,idir)+ein(ix1-1,ix2,ix3,idir)+ein(ix1,ix2,ix3-1,idir)&
4491 +ein(ix1-1,ix2,ix3-1,idir))
4492 if(jce(ix^d,idir)<0.d0) jce(ix^d,idir)=0.d0
4493 w(ix^d,
e_)=w(ix^d,
e_)+qdt*jce(ix^d,idir)
4496 {
do ix^db=ixomin^db,ixomax^db\}
4497 jce(ix^d,idir)=0.25d0*(ein(ix^d,idir)+ein(ix1-1,ix2,ix3,idir)+ein(ix1,ix2-1,ix3,idir)&
4498 +ein(ix1-1,ix2-1,ix3,idir))
4499 if(jce(ix^d,idir)<0.d0) jce(ix^d,idir)=0.d0
4500 w(ix^d,
e_)=w(ix^d,
e_)+qdt*jce(ix^d,idir)
4506 {
do ix^db=ixomin^db,ixomax^db\}
4507 jce(ix^d,idir)=0.25d0*(ein(ix^d,idir)+ein(ix1-1,ix2,idir)+ein(ix1,ix2-1,idir)&
4508 +ein(ix1-1,ix2-1,idir))
4509 if(jce(ix^d,idir)<0.d0) jce(ix^d,idir)=0.d0
4510 w(ix^d,
e_)=w(ix^d,
e_)+qdt*jce(ix^d,idir)
4515 block%w(ixo^s,nw)=block%w(ixo^s,nw)+jce(ixo^s,idir)
4520 if(
associated(usr_set_electric_field)) &
4521 call usr_set_electric_field(ixi^l,ixo^l,qt,qdt,fe,sct)
4522 circ(ixi^s,1:ndim)=zero
4526 ixcmin^d=ixomin^d-kr(idim1,^d);
4528 ixa^l=ixc^l-kr(idim2,^d);
4531 if(lvc(idim1,idim2,idir)==1)
then
4533 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
4536 else if(lvc(idim1,idim2,idir)==-1)
then
4538 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
4545 where(s%surfaceC(ixc^s,idim1) > smalldouble)
4546 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
4548 circ(ixc^s,idim1)=zero
4551 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
4554 end subroutine update_faces_contact
4557 subroutine update_faces_hll(ixI^L,ixO^L,qt,qdt,fE,sCT,s,vcts)
4561 integer,
intent(in) :: ixi^
l, ixo^
l
4562 double precision,
intent(in) :: qt, qdt
4563 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
4564 type(state) :: sct, s
4565 type(ct_velocity) :: vcts
4566 double precision :: vtill(ixi^s,2)
4567 double precision :: vtilr(ixi^s,2)
4568 double precision :: bfacetot(ixi^s,
ndim)
4569 double precision :: btill(ixi^s,
ndim)
4570 double precision :: btilr(ixi^s,
ndim)
4571 double precision :: cp(ixi^s,2)
4572 double precision :: cm(ixi^s,2)
4573 double precision :: circ(ixi^s,1:
ndim)
4575 double precision,
dimension(ixI^S,sdim:3) :: e_resi
4576 integer :: hxc^
l,ixc^
l,ixcp^
l,jxc^
l,ixcm^
l
4577 integer :: idim1,idim2,idir
4579 associate(bfaces=>s%ws,bfacesct=>sct%ws,x=>s%x,vbarc=>vcts%vbarC,cbarmin=>vcts%cbarmin,&
4580 cbarmax=>vcts%cbarmax)
4592 if(
rmhd_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
4604 ixcmin^
d=ixomin^
d-1+
kr(idir,^
d);
4607 idim2=mod(idir+1,3)+1
4608 jxc^
l=ixc^
l+
kr(idim1,^
d);
4609 ixcp^
l=ixc^
l+
kr(idim2,^
d);
4612 vtill(ixi^s,2),vtilr(ixi^s,2))
4614 vtill(ixi^s,1),vtilr(ixi^s,1))
4619 bfacetot(ixi^s,idim1)=bfacesct(ixi^s,idim1)+
block%B0(ixi^s,idim1,idim1)
4620 bfacetot(ixi^s,idim2)=bfacesct(ixi^s,idim2)+
block%B0(ixi^s,idim2,idim2)
4622 bfacetot(ixi^s,idim1)=bfacesct(ixi^s,idim1)
4623 bfacetot(ixi^s,idim2)=bfacesct(ixi^s,idim2)
4626 btill(ixi^s,idim1),btilr(ixi^s,idim1))
4628 btill(ixi^s,idim2),btilr(ixi^s,idim2))
4630 cm(ixc^s,1)=max(cbarmin(ixcp^s,idim1),cbarmin(ixc^s,idim1))
4631 cp(ixc^s,1)=max(cbarmax(ixcp^s,idim1),cbarmax(ixc^s,idim1))
4632 cm(ixc^s,2)=max(cbarmin(jxc^s,idim2),cbarmin(ixc^s,idim2))
4633 cp(ixc^s,2)=max(cbarmax(jxc^s,idim2),cbarmax(ixc^s,idim2))
4635 fe(ixc^s,idir)=-(cp(ixc^s,1)*vtill(ixc^s,1)*btill(ixc^s,idim2) &
4636 + cm(ixc^s,1)*vtilr(ixc^s,1)*btilr(ixc^s,idim2) &
4637 - cp(ixc^s,1)*cm(ixc^s,1)*(btilr(ixc^s,idim2)-btill(ixc^s,idim2)))&
4638 /(cp(ixc^s,1)+cm(ixc^s,1)) &
4639 +(cp(ixc^s,2)*vtill(ixc^s,2)*btill(ixc^s,idim1) &
4640 + cm(ixc^s,2)*vtilr(ixc^s,2)*btilr(ixc^s,idim1) &
4641 - cp(ixc^s,2)*cm(ixc^s,2)*(btilr(ixc^s,idim1)-btill(ixc^s,idim1)))&
4642 /(cp(ixc^s,2)+cm(ixc^s,2))
4644 if(
rmhd_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+e_resi(ixc^s,idir)
4645 fe(ixc^s,idir)=qdt*s%dsC(ixc^s,idir)*fe(ixc^s,idir)
4655 circ(ixi^s,1:
ndim)=zero
4659 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
4663 if(
lvc(idim1,idim2,idir)/=0)
then
4664 hxc^
l=ixc^
l-
kr(idim2,^
d);
4666 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
4667 +
lvc(idim1,idim2,idir)&
4674 where(s%surfaceC(ixc^s,idim1) > 1.0
d-9*s%dvolume(ixc^s))
4675 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
4677 circ(ixc^s,idim1)=zero
4680 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
4683 end subroutine update_faces_hll
4686 subroutine get_resistive_electric_field(ixI^L,ixO^L,sCT,s,jce)
4690 integer,
intent(in) :: ixi^
l, ixo^
l
4691 type(state),
intent(in) :: sct, s
4693 double precision :: jce(ixi^s,
sdim:3)
4695 double precision :: jcc(ixi^s,7-2*
ndir:3)
4697 double precision :: xs(ixgs^t,1:
ndim)
4699 double precision :: eta(ixi^s)
4700 double precision :: gradi(ixgs^t)
4701 integer :: ix^
d,ixc^
l,ixa^
l,ixb^
l,idir,idirmin,idim1,idim2
4703 associate(x=>s%x,
dx=>s%dx,w=>s%w,wct=>sct%w,wcts=>sct%ws)
4709 if (
lvc(idim1,idim2,idir)==0) cycle
4711 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
4712 ixbmax^
d=ixcmax^
d-
kr(idir,^
d)+1;
4715 xs(ixb^s,:)=x(ixb^s,:)
4716 xs(ixb^s,idim2)=x(ixb^s,idim2)+half*
dx(ixb^s,idim2)
4717 call gradientf(wcts(ixgs^t,idim2),xs,ixgs^
ll,ixc^
l,idim1,gradi,2)
4718 if (
lvc(idim1,idim2,idir)==1)
then
4719 jce(ixc^s,idir)=jce(ixc^s,idir)+gradi(ixc^s)
4721 jce(ixc^s,idir)=jce(ixc^s,idir)-gradi(ixc^s)
4736 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
4737 jcc(ixc^s,idir)=0.d0
4739 if({ ix^
d==1 .and. ^
d==idir | .or.}) cycle
4740 ixamin^
d=ixcmin^
d+ix^
d;
4741 ixamax^
d=ixcmax^
d+ix^
d;
4742 jcc(ixc^s,idir)=jcc(ixc^s,idir)+eta(ixa^s)
4744 jcc(ixc^s,idir)=jcc(ixc^s,idir)*0.25d0
4745 jce(ixc^s,idir)=jce(ixc^s,idir)*jcc(ixc^s,idir)
4749 end subroutine get_resistive_electric_field
4755 integer,
intent(in) :: ixo^
l
4764 do ix^db=ixomin^db,ixomax^db\}
4766 s%w(ix^
d,b1_)=half/s%surface(ix^
d,1)*(s%ws(ix^
d,1)*s%surfaceC(ix^
d,1)&
4767 +s%ws(ix1-1,ix2,ix3,1)*s%surfaceC(ix1-1,ix2,ix3,1))
4768 s%w(ix^
d,b2_)=half/s%surface(ix^
d,2)*(s%ws(ix^
d,2)*s%surfaceC(ix^
d,2)&
4769 +s%ws(ix1,ix2-1,ix3,2)*s%surfaceC(ix1,ix2-1,ix3,2))
4770 s%w(ix^
d,b3_)=half/s%surface(ix^
d,3)*(s%ws(ix^
d,3)*s%surfaceC(ix^
d,3)&
4771 +s%ws(ix1,ix2,ix3-1,3)*s%surfaceC(ix1,ix2,ix3-1,3))
4774 s%w(ix^
d,b1_)=half/s%surface(ix^
d,1)*(s%ws(ix^
d,1)*s%surfaceC(ix^
d,1)&
4775 +s%ws(ix1-1,ix2,1)*s%surfaceC(ix1-1,ix2,1))
4776 s%w(ix^
d,b2_)=half/s%surface(ix^
d,2)*(s%ws(ix^
d,2)*s%surfaceC(ix^
d,2)&
4777 +s%ws(ix1,ix2-1,2)*s%surfaceC(ix1,ix2-1,2))
4817 integer,
intent(in) :: ixis^
l, ixi^
l, ixo^
l
4818 double precision,
intent(inout) :: ws(ixis^s,1:nws)
4819 double precision,
intent(in) :: x(ixi^s,1:
ndim)
4820 double precision :: adummy(ixis^s,1:3)
4825 subroutine rfactor_from_temperature_ionization(w,x,ixI^L,ixO^L,Rfactor)
4828 integer,
intent(in) :: ixi^
l, ixo^
l
4829 double precision,
intent(in) :: w(ixi^s,1:nw)
4830 double precision,
intent(in) :: x(ixi^s,1:
ndim)
4831 double precision,
intent(out):: rfactor(ixi^s)
4832 double precision :: iz_h(ixo^s),iz_he(ixo^s)
4836 rfactor(ixo^s)=(1.d0+iz_h(ixo^s)+0.1d0*(1.d0+iz_he(ixo^s)*(1.d0+iz_he(ixo^s))))/(2.d0+3.d0*
he_abundance)
4837 end subroutine rfactor_from_temperature_ionization
4839 subroutine rfactor_from_constant_ionization(w,x,ixI^L,ixO^L,Rfactor)
4841 integer,
intent(in) :: ixi^
l, ixo^
l
4842 double precision,
intent(in) :: w(ixi^s,1:nw)
4843 double precision,
intent(in) :: x(ixi^s,1:
ndim)
4844 double precision,
intent(out):: rfactor(ixi^s)
4847 end subroutine rfactor_from_constant_ionization
Module for including anisotropic flux limited diffusion (AFLD)-approximation in Radiation-hydrodynami...
subroutine afld_get_diffcoef_central(w, wct, x, ixil, ixol)
Calculates cell-centered diffusion coefficient to be used in multigrid.
subroutine, public get_afld_rad_force(qdt, ixil, ixol, wct, w, x, energy, qsourcesplit, active)
w[iw]=w[iw]+qdt*S[wCT,qtC,x] where S is the source based on wCT within ixO This subroutine handles th...
subroutine, public afld_init(he_abundance, rhd_radiation_diffusion, afld_gamma)
Initialising FLD-module: Read opacities Initialise Multigrid adimensionalise kappa Add extra variable...
subroutine, public afld_radforce_get_dt(w, ixil, ixol, dtnew, dxd, x)
subroutine, public afld_get_radpress(w, x, ixil, ixol, rad_pressure, nth)
Calculate Radiation Pressure Returns Radiation Pressure as tensor.
subroutine, public get_afld_energy_interact(qdt, ixil, ixol, wct, w, x, energy, qsourcesplit, active)
w[iw]=w[iw]+qdt*S[wCT,qtC,x] where S is the source based on wCT within ixO This subroutine handles th...
Module to include CAK radiation line force in (magneto)hydrodynamic models Computes both the force fr...
subroutine cak_get_dt(w, ixil, ixol, dtnew, dxd, x)
Check time step for total radiation contribution.
subroutine cak_init(phys_gamma)
Initialize the module.
subroutine cak_add_source(qdt, ixil, ixol, wct, w, x, energy, qsourcesplit, active)
w[iw]=w[iw]+qdt*S[wCT,qtC,x] where S is the source based on wCT within ixO
subroutine, public mpistop(message)
Exit MPI-AMRVAC with an error message.
Module for physical and numeric constants.
double precision, parameter const_rad_a
subroutine reconstruct(ixil, ixcl, idir, q, ql, qr)
Reconstruct scalar q within ixO^L to 1/2 dx in direction idir Return both left and right reconstructe...
subroutine b_from_vector_potentiala(ixisl, ixil, ixol, ws, x, a)
calculate magnetic field from vector potential A at cell edges
subroutine add_convert_method(phys_convert_vars, nwc, dataset_names, file_suffix)
Module for flux conservation near refinement boundaries.
Nicolas Moens Module for including flux limited diffusion (FLD)-approximation in Radiation-hydrodynam...
subroutine, public get_fld_rad_force(qdt, ixil, ixol, wct, w, x, energy, qsourcesplit, active)
w[iw]=w[iw]+qdt*S[wCT,qtC,x] where S is the source based on wCT within ixO This subroutine handles th...
subroutine, public fld_get_radpress(w, x, ixil, ixol, rad_pressure, nth)
Calculate Radiation Pressure Returns Radiation Pressure as tensor.
subroutine, public fld_init(he_abundance, radiation_diffusion, energy_interact, r_gamma)
Initialising FLD-module: Read opacities Initialise Multigrid adimensionalise kappa Add extra variable...
subroutine fld_get_diffcoef_central(w, wct, x, ixil, ixol)
Calculates cell-centered diffusion coefficient to be used in multigrid.
character(len=8) fld_diff_scheme
Which method to solve diffusion part.
subroutine, public fld_radforce_get_dt(w, ixil, ixol, dtnew, dxd, x)
Module with basic grid data structures.
type(tree_node_ptr), dimension(:,:), allocatable, save igrid_to_node
Array to go from an [igrid, ipe] index to a node pointer.
subroutine, public get_divb(w, ixil, ixol, divb, nth_in)
Calculate div B within ixO.
integer, dimension(:), allocatable, public mag
Indices of the magnetic field.
Module with geometry-related routines (e.g., divergence, curl)
subroutine divvector(qvec, ixil, ixol, divq, nth_in)
integer, parameter spherical
integer, parameter cylindrical
subroutine curlvector(qvec, ixil, ixol, curlvec, idirmin, idirmin0, ndir0, fourthorder)
Calculate curl of a vector qvec within ixL Options to employ standard second order CD evaluations use...
subroutine gradient(q, ixil, ixol, idir, gradq, nth_in)
subroutine gradientf(q, x, ixil, ixol, idir, gradq, nth_in, pm_in)
subroutine gradientl(q, ixil, ixol, idir, gradq)
This module contains definitions of global parameters and variables and some generic functions/subrou...
type(state), pointer block
Block pointer for using one block and its previous state.
double precision dtdiffpar
For resistive MHD, the time step is also limited by the diffusion time: .
character(len=std_len) typegrad
double precision unit_charge
Physical scaling factor for charge.
integer, parameter bc_noinflow
double precision small_pressure
integer ixghi
Upper index of grid block arrays.
pure subroutine cross_product(ixil, ixol, a, b, axb)
Cross product of two vectors.
integer, dimension(3, 3, 3) lvc
Levi-Civita tensor.
double precision unit_time
Physical scaling factor for time.
double precision unit_density
Physical scaling factor for density.
double precision unit_opacity
Physical scaling factor for Opacity.
integer, parameter unitpar
file handle for IO
integer, parameter bc_asymm
double precision unit_mass
Physical scaling factor for mass.
integer, dimension(3, 3) kr
Kronecker delta tensor.
double precision phys_trac_mask
integer, dimension(:, :), allocatable typeboundary
Array indicating the type of boundary condition per variable and per physical boundary.
double precision unit_numberdensity
Physical scaling factor for number density.
character(len=std_len) convert_type
Which format to use when converting.
double precision unit_pressure
Physical scaling factor for pressure.
integer, parameter ndim
Number of spatial dimensions for grid variables.
double precision unit_length
Physical scaling factor for length.
logical stagger_grid
True for using stagger grid.
double precision cmax_global
global fastest wave speed needed in fd scheme and glm method
logical use_particles
Use particles module or not.
character(len=std_len), dimension(:), allocatable par_files
Which par files are used as input.
integer icomm
The MPI communicator.
double precision bdip
amplitude of background dipolar, quadrupolar, octupolar, user's field
integer b0i
background magnetic field location indicator
integer mype
The rank of the current MPI task.
double precision, dimension(:), allocatable, parameter d
logical local_timestep
each cell has its own timestep or not
double precision dt
global time step
integer ndir
Number of spatial dimensions (components) for vector variables.
integer ixm
the mesh range of a physical block without ghost cells
integer ierrmpi
A global MPI error return code.
logical autoconvert
If true, already convert to output format during the run.
logical slab
Cartesian geometry or not.
integer, parameter bc_periodic
integer, parameter bc_special
boundary condition types
double precision unit_magneticfield
Physical scaling factor for magnetic field.
double precision unit_velocity
Physical scaling factor for velocity.
double precision c_norm
Normalised speed of light.
logical b0field
split magnetic field as background B0 field
double precision, dimension(:,:), allocatable rnode
Corner coordinates.
double precision unit_temperature
Physical scaling factor for temperature.
double precision unit_radflux
Physical scaling factor for radiation flux.
integer, parameter bc_cont
logical si_unit
Use SI units (.true.) or use cgs units (.false.)
double precision, dimension(:,:), allocatable dx
integer nghostcells
Number of ghost cells surrounding a grid.
integer, parameter sdim
starting dimension for electric field
integer, parameter bc_symm
logical phys_trac
Use TRAC for MHD or 1D HD.
logical need_global_cmax
need global maximal wave speed
logical convert
If true and restart_from_file is given, convert snapshots to other file formats.
logical fix_small_values
fix small values with average or replace methods
double precision, dimension(^nd) dxlevel
store unstretched cell size of current level
logical use_multigrid
Use multigrid (only available in 2D and 3D)
logical slab_uniform
uniform Cartesian geometry or not (stretched Cartesian)
double precision small_density
integer max_blocks
The maximum number of grid blocks in a processor.
integer r_
Indices for cylindrical coordinates FOR TESTS, negative value when not used:
integer boundspeed
bound (left/min and right.max) speed of Riemann fan
integer phys_trac_finegrid
integer, parameter unitconvert
integer number_equi_vars
number of equilibrium set variables, besides the mag field
integer, parameter ixglo
Lower index of grid block arrays (always 1)
Module for including gravity in (magneto)hydrodynamics simulations.
subroutine gravity_get_dt(w, ixil, ixol, dtnew, dxd, x)
subroutine gravity_init()
Initialize the module.
subroutine gravity_add_source(qdt, ixil, ixol, wct, wctprim, w, x, energy, rhov, qsourcesplit, active)
w[iw]=w[iw]+qdt*S[wCT,qtC,x] where S is the source based on wCT within ixO
module ionization degree - get ionization degree for given temperature
subroutine ionization_degree_from_temperature(ixil, ixol, te, iz_h, iz_he)
subroutine ionization_degree_init()
Module to couple the octree-mg library to AMRVAC. This file uses the VACPP preprocessor,...
type(mg_t) mg
Data structure containing the multigrid tree.
Module containing all the particle routines.
subroutine particles_init()
Initialize particle data and parameters.
This module defines the procedures of a physics module. It contains function pointers for the various...
Radiation-magneto-hydrodynamics module.
subroutine, public get_current(w, ixil, ixol, idirmin, current)
Calculate idirmin and the idirmin:3 components of the common current array make sure that dxlevel(^D)...
integer, public, protected rmhd_trac_type
Which TRAC method is used.
character(len=8), public rmhd_pressure
In the case of no rmhd_energy, how to compute pressure.
subroutine, public rmhd_phys_init()
logical, public, protected rmhd_thermal_conduction
Whether thermal conduction is used.
double precision, public rmhd_gamma
The adiabatic index.
character(len=8), public rmhd_radiation_formalism
Formalism to treat radiation.
logical, public divbwave
Add divB wave in Roe solver.
integer, public, protected rmhd_trac_finegrid
Distance between two adjacent traced magnetic field lines (in finest cell size)
double precision, public, protected h_ion_fr
Ionization fraction of H H_ion_fr = H+/(H+ + H)
integer, dimension(2 *^nd), public, protected boundary_divbfix_skip
To skip * layer of ghost cells during divB=0 fix for boundary.
logical, public, protected rmhd_hyperbolic_thermal_conduction
Whether thermal conduction is used.
double precision, public, protected rr
logical, public rmhd_equi_thermal
double precision, public rmhd_etah
Hall resistivity.
logical, public, protected rmhd_radiation_diffusion
Treat radiation energy diffusion.
subroutine, public rmhd_face_to_center(ixol, s)
calculate cell-center values from face-center values
procedure(sub_get_pthermal), pointer, public rmhd_get_pthermal
integer, public, protected psi_
Indices of the GLM psi.
type(tc_fluid), allocatable, public tc_fl
type of fluid for thermal conduction
integer, public, protected c
Indices of the momentum density for the form of better vectorization.
subroutine, public b_from_vector_potential(ixisl, ixil, ixol, ws, x)
calculate magnetic field from vector potential
logical, public, protected rmhd_cak_force
Whether CAK radiation line force is activated.
logical, public, protected rmhd_radiation_force
Treat radiation fld_Rad_force.
logical, public, protected rmhd_glm
Whether GLM-MHD is used to control div B.
double precision, public, protected small_r_e
The smallest allowed radiation energy.
double precision, public rmhd_eta_hyper
The MHD hyper-resistivity.
logical, public clean_initial_divb
clean initial divB
integer, public, protected rmhd_n_tracer
Number of tracer species.
logical, public, protected rmhd_particles
Whether particles module is added.
integer, public, protected b
double precision, public kbmpmua4
kb/(m_p mu)* 1/a_rad**4,
integer, public, protected m
subroutine, public rmhd_get_trad(w, x, ixil, ixol, trad)
Calculates radiation temperature.
integer, public equi_rho0_
equi vars indices in the stateequi_vars array
double precision, public rmhd_adiab
The adiabatic constant.
subroutine, public rmhd_get_pthermal_plus_pradiation(w, x, ixil, ixol, pth_plus_prad)
Calculates the sum of the gas pressure and the max Prad tensor element.
integer, public, protected q_
Index of the heat flux q.
integer, public, protected tweight_
logical, public has_equi_rho0
whether split off equilibrium density
double precision, public rmhd_eta
The MHD resistivity.
integer, public, protected p_
Index of the gas pressure (-1 if not present) should equal e_.
subroutine, public get_normalized_divb(w, ixil, ixol, divb)
get dimensionless div B = |divB| * volume / area / |B|
integer, public, protected rho_
Index of the density (in the w array)
integer, public, protected c_
double precision function, dimension(ixo^s), public rmhd_mag_en_all(w, ixil, ixol)
Compute 2 times total magnetic energy.
type(te_fluid), allocatable, public te_fl_rmhd
type of fluid for thermal emission synthesis
logical, public, protected rmhd_gravity
Whether gravity is added.
integer, dimension(:), allocatable, public, protected mom
Indices of the momentum density.
logical, public, protected rmhd_glm_extended
Whether extended GLM-MHD is used with additional sources.
logical, public, protected rmhd_viscosity
Whether viscosity is added.
logical, public, protected rmhd_partial_ionization
Whether plasma is partially ionized.
integer, public, protected tcoff_
Index of the cutoff temperature for the TRAC method.
integer, public, protected e_
Index of the energy density (-1 if not present)
logical, public, protected rmhd_radiation_advection
Treat radiation advection.
double precision, public, protected he_ion_fr2
Ratio of number He2+ / number He+ + He2+ He_ion_fr2 = He2+/(He2+ + He+)
subroutine, public rmhd_get_rho(w, x, ixil, ixol, rho)
integer, dimension(:), allocatable, public, protected tracer
Indices of the tracers.
logical, public, protected rmhd_energy_interact
Treat radiation-gas energy interaction.
subroutine, public rmhd_get_tgas(w, x, ixil, ixol, tgas)
Calculates gas temperature.
character(len=std_len), public, protected type_ct
Method type of constrained transport.
procedure(sub_convert), pointer, public rmhd_to_conserved
double precision, public, protected he_abundance
Helium abundance over Hydrogen.
logical, public partial_energy
Whether an internal or hydrodynamic energy equation is used.
procedure(sub_convert), pointer, public rmhd_to_primitive
logical, public, protected rmhd_dump_full_vars
whether dump full variables (when splitting is used) in a separate dat file
logical, public, protected rmhd_trac
Whether TRAC method is used.
subroutine, public rmhd_clean_divb_multigrid(qdt, qt, active)
subroutine, public rmhd_set_mg_bounds
Set the boundaries for the diffusion of E.
subroutine, public rmhd_get_v(w, x, ixil, ixol, v)
Calculate v vector.
double precision, public hypertc_kappa
The thermal conductivity kappa in hyperbolic thermal conduction.
logical, public has_equi_pe0
whether split off equilibrium thermal pressure
subroutine, public rmhd_get_pradiation(w, x, ixil, ixol, prad, nth)
Calculate radiation pressure within ixO^L.
integer, public, protected te_
Indices of temperature.
logical, public, protected source_split_divb
Whether divB cleaning sources are added splitting from fluid solver.
integer, public, protected r_e
Index of the radiation energy.
procedure(sub_get_pthermal), pointer, public rmhd_get_temperature
character(len=std_len), public, protected typedivbfix
Method type to clean divergence of B.
logical, public, protected b0field_forcefree
B0 field is force-free.
double precision, public rmhd_glm_alpha
GLM-MHD parameter: ratio of the diffusive and advective time scales for div b taking values within [0...
integer, public, protected rmhd_divb_nth
Whether divB is computed with a fourth order approximation.
subroutine, public rmhd_ei_to_e(ixil, ixol, w, x)
Transform internal energy to total energy.
integer, public equi_pe0_
double precision, public, protected he_ion_fr
Ionization fraction of He He_ion_fr = (He2+ + He+)/(He2+ + He+ + He)
logical, public, protected rmhd_energy
Whether an energy equation is used.
logical, dimension(2 *^nd), public, protected boundary_divbfix
To control divB=0 fix for boundary.
double precision, public, protected rmhd_trac_mask
Height of the mask used in the TRAC method.
logical, public, protected eq_state_units
subroutine, public rmhd_e_to_ei(ixil, ixol, w, x)
Transform total energy to internal energy.
logical, public, protected rmhd_4th_order
MHD fourth order.
Module for handling problematic values in simulations, such as negative pressures.
subroutine, public small_values_average(ixil, ixol, w, x, w_flag, windex)
logical, public trace_small_values
trace small values in the source file using traceback flag of compiler
subroutine, public small_values_error(wprim, x, ixil, ixol, w_flag, subname)
logical, dimension(:), allocatable, public small_values_fix_iw
Whether to apply small value fixes to certain variables.
character(len=20), public small_values_method
How to handle small values.
Generic supertimestepping method 1) in amrvac.par in sts_list set the following parameters which have...
subroutine, public add_sts_method(sts_getdt, sts_set_sources, startvar, nflux, startwbc, nwbc, evolve_b)
subroutine which added programatically a term to be calculated using STS Params: sts_getdt function c...
subroutine, public set_conversion_methods_to_head(sts_before_first_cycle, sts_after_last_cycle)
Set the hooks called before the first cycle and after the last cycle in the STS update This method sh...
subroutine, public set_error_handling_to_head(sts_error_handling)
Set the hook of error handling in the STS update. This method is called before updating the BC....
subroutine, public sts_init()
Initialize sts module.
Thermal conduction for HD and MHD or RHD and RMHD or twofl (plasma-neutral) module Adaptation of mod_...
double precision function, public get_tc_dt_mhd(w, ixil, ixol, dxd, x, fl)
Get the explicut timestep for the TC (mhd implementation)
subroutine tc_init_params(phys_gamma)
subroutine, public sts_set_source_tc_mhd(ixil, ixol, w, x, wres, fix_conserve_at_step, my_dt, igrid, nflux, fl)
anisotropic thermal conduction with slope limited symmetric scheme Sharma 2007 Journal of Computation...
subroutine, public tc_get_mhd_params(fl, read_mhd_params)
Init TC coefficients: MHD case.
subroutine get_euv_image(qunit, fl)
subroutine get_sxr_image(qunit, fl)
subroutine get_euv_spectrum(qunit, fl)
subroutine get_whitelight_image(qunit, fl)
Module with all the methods that users can customize in AMRVAC.
procedure(rfactor), pointer usr_rfactor
procedure(special_resistivity), pointer usr_special_resistivity
procedure(set_equi_vars), pointer usr_set_equi_vars
procedure(special_mg_bc), pointer usr_special_mg_bc
procedure(set_electric_field), pointer usr_set_electric_field
The module add viscous source terms and check time step.
subroutine viscosity_add_source(qdt, ixil, ixol, wct, w, x, energy, qsourcesplit, active)
subroutine viscosity_init(phys_wider_stencil)
Initialize the module.
subroutine viscosity_get_dt(w, ixil, ixol, dtnew, dxd, x)
The data structure that contains information about a tree node/grid block.