34 double precision,
public,
protected,
allocatable ::
c_shk(:)
35 double precision,
public,
protected,
allocatable ::
c_hyp(:)
40 integer,
parameter,
private :: mhd_tc =1
41 integer,
parameter,
private :: hd_tc =2
42 integer,
protected :: use_twofl_tc_c = mhd_tc
63 type(
tc_fluid),
allocatable :: tc_fl_n
66 type(
rc_fluid),
allocatable :: rc_fl_n
94 integer,
allocatable,
public ::
mom_c(:)
104 integer,
public,
protected ::
psi_
119 integer,
allocatable,
public ::
mom_n(:)
143 double precision,
public,
protected :: he_abundance = 0d0
145 double precision,
public,
protected ::
rc = 2d0
146 double precision,
public,
protected ::
rn = 1d0
164 double precision,
protected :: small_e
167 character(len=std_len),
public,
protected ::
typedivbfix =
'linde'
170 character(len=std_len),
public,
protected ::
type_ct =
'uct_contact'
179 double precision :: divbdiff = 0.8d0
182 character(len=std_len) :: typedivbdiff =
'all'
199 logical :: twofl_cbounds_species = .true.
203 logical :: grav_split= .false.
206 double precision :: gamma_1, inv_gamma_1
209 integer,
parameter :: divb_none = 0
210 integer,
parameter :: divb_multigrid = -1
211 integer,
parameter :: divb_glm = 1
212 integer,
parameter :: divb_powel = 2
213 integer,
parameter :: divb_janhunen = 3
214 integer,
parameter :: divb_linde = 4
215 integer,
parameter :: divb_lindejanhunen = 5
216 integer,
parameter :: divb_lindepowel = 6
217 integer,
parameter :: divb_lindeglm = 7
218 integer,
parameter :: divb_ct = 8
248 subroutine implicit_mult_factor_subroutine(ixI^L, ixO^L, step_dt, JJ, res)
249 integer,
intent(in) :: ixi^
l, ixo^
l
250 double precision,
intent(in) :: step_dt
251 double precision,
intent(in) :: jj(ixi^s)
252 double precision,
intent(out) :: res(ixi^s)
254 end subroutine implicit_mult_factor_subroutine
256 subroutine mask_subroutine(ixI^L,ixO^L,w,x,res)
258 integer,
intent(in) :: ixi^
l, ixo^
l
259 double precision,
intent(in) :: x(ixi^s,1:
ndim)
260 double precision,
intent(in) :: w(ixi^s,1:nw)
261 double precision,
intent(inout) :: res(ixi^s)
262 end subroutine mask_subroutine
264 subroutine mask_subroutine2(ixI^L,ixO^L,w,x,res1, res2)
266 integer,
intent(in) :: ixi^
l, ixo^
l
267 double precision,
intent(in) :: x(ixi^s,1:
ndim)
268 double precision,
intent(in) :: w(ixi^s,1:nw)
269 double precision,
intent(inout) :: res1(ixi^s),res2(ixi^s)
270 end subroutine mask_subroutine2
274 procedure(implicit_mult_factor_subroutine),
pointer :: calc_mult_factor => null()
275 integer,
protected :: twofl_implicit_calc_mult_method = 1
282 subroutine twofl_read_params(files)
284 character(len=*),
intent(in) :: files(:)
303 do n = 1,
size(files)
304 open(
unitpar, file=trim(files(n)), status=
"old")
305 read(
unitpar, twofl_list,
end=111)
309 end subroutine twofl_read_params
311 subroutine twofl_init_hyper(files)
314 character(len=*),
intent(in) :: files(:)
319 do n = 1,
size(files)
320 open(
unitpar, file=trim(files(n)), status=
"old")
321 read(
unitpar, hyperdiffusivity_list,
end=113)
325 call hyperdiffusivity_init()
329 print*,
"Using Hyperdiffusivity"
330 print*,
"C_SHK ",
c_shk(:)
331 print*,
"C_HYP ",
c_hyp(:)
334 end subroutine twofl_init_hyper
337 subroutine twofl_write_info(fh)
339 integer,
intent(in) :: fh
340 integer,
parameter :: n_par = 1
341 double precision :: values(n_par)
342 character(len=name_len) :: names(n_par)
343 integer,
dimension(MPI_STATUS_SIZE) :: st
346 call mpi_file_write(fh, n_par, 1, mpi_integer, st, er)
350 call mpi_file_write(fh, values, n_par, mpi_double_precision, st, er)
351 call mpi_file_write(fh, names, n_par * name_len, mpi_character, st, er)
352 end subroutine twofl_write_info
368 physics_type =
"twofl"
369 if (twofl_cbounds_species)
then
377 phys_total_energy=.false.
383 phys_internal_e=.false.
391 phys_internal_e = .true.
393 phys_total_energy = .true.
395 phys_energy = .false.
401 if(.not. phys_energy)
then
404 if(
mype==0)
write(*,*)
'WARNING: set twofl_thermal_conduction_n=F when twofl_energy=F'
408 if(
mype==0)
write(*,*)
'WARNING: set twofl_radiative_cooling_n=F when twofl_energy=F'
412 if(
mype==0)
write(*,*)
'WARNING: set twofl_thermal_conduction_c=F when twofl_energy=F'
416 if(
mype==0)
write(*,*)
'WARNING: set twofl_radiative_cooling_c=F when twofl_energy=F'
420 if(
mype==0)
write(*,*)
'WARNING: set twofl_trac=F when twofl_energy=F'
426 if(
mype==0)
write(*,*)
'WARNING: set twofl_trac_type=1 for 1D simulation'
431 if(
mype==0)
write(*,*)
'WARNING: set twofl_trac_mask==bigdouble for global TRAC method'
439 type_divb = divb_none
442 type_divb = divb_multigrid
444 mg%operator_type = mg_laplacian
451 case (
'powel',
'powell')
452 type_divb = divb_powel
454 type_divb = divb_janhunen
456 type_divb = divb_linde
457 case (
'lindejanhunen')
458 type_divb = divb_lindejanhunen
460 type_divb = divb_lindepowel
464 type_divb = divb_lindeglm
469 call mpistop(
'Unknown divB fix')
472 allocate(start_indices(number_species))
473 allocate(stop_indices(number_species))
476 rho_c_ = var_set_fluxvar(
"rho_c",
"rho_c")
482 mom_c(idir) = var_set_fluxvar(
"m_c",
"v_c",idir)
485 allocate(iw_mom(
ndir))
489 if (phys_energy)
then
490 e_c_ = var_set_fluxvar(
"e_c",
"p_c")
498 mag(:) = var_set_bfield(
ndir)
501 psi_ = var_set_fluxvar(
'psi',
'psi', need_bc=.false.)
522 if (twofl_cbounds_species)
then
523 stop_indices(1)=nwflux
524 start_indices(2)=nwflux+1
528 rho_n_ = var_set_fluxvar(
"rho_n",
"rho_n")
531 mom_n(idir) = var_set_fluxvar(
"m_n",
"v_n",idir)
533 if (phys_energy)
then
534 e_n_ = var_set_fluxvar(
"e_n",
"p_n")
549 stop_indices(number_species)=nwflux
581 if (.not.
allocated(flux_type))
then
582 allocate(flux_type(
ndir, nw))
583 flux_type = flux_default
584 else if (any(shape(flux_type) /= [
ndir, nw]))
then
585 call mpistop(
"phys_check error: flux_type has wrong shape")
590 flux_type(:,
psi_)=flux_special
592 flux_type(idir,mag(idir))=flux_special
596 flux_type(idir,mag(idir))=flux_tvdlf
601 phys_get_dt => twofl_get_dt
602 phys_get_cmax => twofl_get_cmax
603 phys_get_a2max => twofl_get_a2max
605 if(twofl_cbounds_species)
then
606 if (
mype .eq. 0) print*,
"Using different cbounds for each species nspecies = ", number_species
607 phys_get_cbounds => twofl_get_cbounds_species
608 phys_get_h_speed => twofl_get_h_speed_species
610 if (
mype .eq. 0) print*,
"Using same cbounds for all species"
611 phys_get_cbounds => twofl_get_cbounds_one
612 phys_get_h_speed => twofl_get_h_speed_one
614 phys_get_flux => twofl_get_flux
615 phys_add_source_geom => twofl_add_source_geom
616 phys_add_source => twofl_add_source
619 phys_check_params => twofl_check_params
620 phys_check_w => twofl_check_w
621 phys_write_info => twofl_write_info
622 phys_handle_small_values => twofl_handle_small_values
625 phys_set_equi_vars => set_equi_vars_grid
628 if(type_divb==divb_glm)
then
629 phys_modify_wlr => twofl_modify_wlr
634 phys_get_ct_velocity => twofl_get_ct_velocity
635 phys_update_faces => twofl_update_faces
637 phys_modify_wlr => twofl_modify_wlr
639 phys_boundary_adjust => twofl_boundary_adjust
648 call twofl_physical_units()
652 call mpistop(
"thermal conduction needs twofl_energy=T")
664 tc_fl_c%get_temperature_from_eint => twofl_get_temperature_from_eint_c_with_equi
665 if(phys_internal_e)
then
666 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_eint_c_with_equi
669 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_eki_c_with_equi
671 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_etot_c_with_equi
676 tc_fl_c%get_temperature_equi => twofl_get_temperature_c_equi
677 tc_fl_c%get_rho_equi => twofl_get_rho_c_equi
682 if(phys_internal_e)
then
683 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_eint_c
686 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_eki_c
688 tc_fl_c%get_temperature_from_conserved => twofl_get_temperature_from_etot_c
691 tc_fl_c%get_temperature_from_eint => twofl_get_temperature_from_eint_c
693 if(use_twofl_tc_c .eq. mhd_tc)
then
696 else if(use_twofl_tc_c .eq. hd_tc)
then
700 if(.not. phys_internal_e)
then
712 tc_fl_n%get_temperature_from_eint => twofl_get_temperature_from_eint_n_with_equi
714 tc_fl_n%has_equi = .true.
715 tc_fl_n%get_temperature_equi => twofl_get_temperature_n_equi
716 tc_fl_n%get_rho_equi => twofl_get_rho_n_equi
718 tc_fl_n%has_equi = .false.
721 tc_fl_n%get_temperature_from_eint => twofl_get_temperature_from_eint_n
723 if(phys_internal_e)
then
725 tc_fl_n%get_temperature_from_conserved => twofl_get_temperature_from_eint_n_with_equi
727 tc_fl_n%get_temperature_from_conserved => twofl_get_temperature_from_eint_n
732 tc_fl_n%get_temperature_from_conserved => twofl_get_temperature_from_etot_n_with_equi
734 tc_fl_n%get_temperature_from_conserved => twofl_get_temperature_from_etot_n
748 call mpistop(
"radiative cooling needs twofl_energy=T")
752 call mpistop(
"twofl_equi_thermal=T has_equi_pe_n0 and has _equi_pe_c0=T")
765 rc_fl_c%get_var_Rfactor => rfactor_c
770 rc_fl_c%get_rho_equi => twofl_get_rho_c_equi
771 rc_fl_c%get_pthermal_equi => twofl_get_pe_c_equi
780 te_fl_c%get_var_Rfactor => rfactor_c
782 phys_te_images => twofl_te_images
801 phys_wider_stencil = 2
803 phys_wider_stencil = 1
808 allocate(
c_shk(1:nwflux))
809 allocate(
c_hyp(1:nwflux))
816 subroutine twofl_te_images
821 case(
'EIvtiCCmpi',
'EIvtuCCmpi')
823 case(
'ESvtiCCmpi',
'ESvtuCCmpi')
825 case(
'SIvtiCCmpi',
'SIvtuCCmpi')
827 case(
'WIvtiCCmpi',
'WIvtuCCmpi')
830 call mpistop(
"Error in synthesize emission: Unknown convert_type")
832 end subroutine twofl_te_images
837 subroutine twofl_sts_set_source_tc_c_mhd(ixI^L,ixO^L,w,x,wres,fix_conserve_at_step,my_dt,igrid,nflux)
841 integer,
intent(in) :: ixi^
l, ixo^
l, igrid, nflux
842 double precision,
intent(in) :: x(ixi^s,1:
ndim)
843 double precision,
intent(inout) :: wres(ixi^s,1:nw), w(ixi^s,1:nw)
844 double precision,
intent(in) :: my_dt
845 logical,
intent(in) :: fix_conserve_at_step
847 end subroutine twofl_sts_set_source_tc_c_mhd
849 subroutine twofl_sts_set_source_tc_c_hd(ixI^L,ixO^L,w,x,wres,fix_conserve_at_step,my_dt,igrid,nflux)
853 integer,
intent(in) :: ixi^
l, ixo^
l, igrid, nflux
854 double precision,
intent(in) :: x(ixi^s,1:
ndim)
855 double precision,
intent(inout) :: wres(ixi^s,1:nw), w(ixi^s,1:nw)
856 double precision,
intent(in) :: my_dt
857 logical,
intent(in) :: fix_conserve_at_step
859 end subroutine twofl_sts_set_source_tc_c_hd
861 function twofl_get_tc_dt_mhd_c(w,ixI^L,ixO^L,dx^D,x)
result(dtnew)
868 integer,
intent(in) :: ixi^
l, ixo^
l
869 double precision,
intent(in) ::
dx^
d, x(ixi^s,1:
ndim)
870 double precision,
intent(in) :: w(ixi^s,1:nw)
871 double precision :: dtnew
874 end function twofl_get_tc_dt_mhd_c
876 function twofl_get_tc_dt_hd_c(w,ixI^L,ixO^L,dx^D,x)
result(dtnew)
883 integer,
intent(in) :: ixi^
l, ixo^
l
884 double precision,
intent(in) ::
dx^
d, x(ixi^s,1:
ndim)
885 double precision,
intent(in) :: w(ixi^s,1:nw)
886 double precision :: dtnew
889 end function twofl_get_tc_dt_hd_c
891 subroutine twofl_tc_handle_small_e_c(w, x, ixI^L, ixO^L, step)
895 integer,
intent(in) :: ixi^
l,ixo^
l
896 double precision,
intent(inout) :: w(ixi^s,1:nw)
897 double precision,
intent(in) :: x(ixi^s,1:
ndim)
898 integer,
intent(in) :: step
900 character(len=140) :: error_msg
902 write(error_msg,
"(a,i3)")
"Charges thermal conduction step ", step
903 call twofl_handle_small_ei_c(w,x,ixi^
l,ixo^
l,
e_c_,error_msg)
904 end subroutine twofl_tc_handle_small_e_c
906 subroutine twofl_sts_set_source_tc_n_hd(ixI^L,ixO^L,w,x,wres,fix_conserve_at_step,my_dt,igrid,nflux)
910 integer,
intent(in) :: ixi^
l, ixo^
l, igrid, nflux
911 double precision,
intent(in) :: x(ixi^s,1:
ndim)
912 double precision,
intent(inout) :: wres(ixi^s,1:nw), w(ixi^s,1:nw)
913 double precision,
intent(in) :: my_dt
914 logical,
intent(in) :: fix_conserve_at_step
916 end subroutine twofl_sts_set_source_tc_n_hd
918 subroutine twofl_tc_handle_small_e_n(w, x, ixI^L, ixO^L, step)
921 integer,
intent(in) :: ixi^
l,ixo^
l
922 double precision,
intent(inout) :: w(ixi^s,1:nw)
923 double precision,
intent(in) :: x(ixi^s,1:
ndim)
924 integer,
intent(in) :: step
926 character(len=140) :: error_msg
928 write(error_msg,
"(a,i3)")
"Neutral thermal conduction step ", step
929 call twofl_handle_small_ei_n(w,x,ixi^
l,ixo^
l,
e_n_,error_msg)
930 end subroutine twofl_tc_handle_small_e_n
932 function twofl_get_tc_dt_hd_n(w,ixI^L,ixO^L,dx^D,x)
result(dtnew)
939 integer,
intent(in) :: ixi^
l, ixo^
l
940 double precision,
intent(in) ::
dx^
d, x(ixi^s,1:
ndim)
941 double precision,
intent(in) :: w(ixi^s,1:nw)
942 double precision :: dtnew
945 end function twofl_get_tc_dt_hd_n
947 subroutine tc_n_params_read_hd(fl)
950 type(tc_fluid),
intent(inout) :: fl
952 logical :: tc_saturate=.false.
953 double precision :: tc_k_para=0d0
955 namelist /tc_n_list/ tc_saturate, tc_k_para
959 read(
unitpar, tc_n_list,
end=111)
962 fl%tc_saturate = tc_saturate
963 fl%tc_k_para = tc_k_para
965 end subroutine tc_n_params_read_hd
967 subroutine rc_params_read_n(fl)
970 type(rc_fluid),
intent(inout) :: fl
973 integer :: ncool = 4000
974 double precision :: cfrac=0.1d0
977 character(len=std_len) :: coolcurve=
'JCorona'
980 character(len=std_len) :: coolmethod=
'exact'
983 logical :: tfix=.false.
989 logical :: rc_split=.false.
991 namelist /rc_list_n/ coolcurve, coolmethod, ncool, cfrac, tlow, tfix, rc_split
995 read(
unitpar, rc_list_n,
end=111)
1000 fl%coolcurve=coolcurve
1001 fl%coolmethod=coolmethod
1004 fl%rc_split=rc_split
1006 end subroutine rc_params_read_n
1011 subroutine tc_c_params_read_mhd(fl)
1013 type(tc_fluid),
intent(inout) :: fl
1018 logical :: tc_perpendicular=.false.
1019 logical :: tc_saturate=.false.
1020 double precision :: tc_k_para=0d0
1021 double precision :: tc_k_perp=0d0
1022 character(len=std_len) :: tc_slope_limiter=
"MC"
1024 namelist /tc_c_list/ tc_perpendicular, tc_saturate, tc_slope_limiter, tc_k_para, tc_k_perp
1027 read(
unitpar, tc_c_list,
end=111)
1031 fl%tc_perpendicular = tc_perpendicular
1032 fl%tc_saturate = tc_saturate
1033 fl%tc_k_para = tc_k_para
1034 fl%tc_k_perp = tc_k_perp
1035 select case(tc_slope_limiter)
1037 fl%tc_slope_limiter = 0
1040 fl%tc_slope_limiter = 1
1043 fl%tc_slope_limiter = 2
1046 fl%tc_slope_limiter = 3
1049 fl%tc_slope_limiter = 4
1051 call mpistop(
"Unknown tc_slope_limiter, choose MC, minmod")
1053 end subroutine tc_c_params_read_mhd
1055 subroutine tc_c_params_read_hd(fl)
1058 type(tc_fluid),
intent(inout) :: fl
1060 logical :: tc_saturate=.false.
1061 double precision :: tc_k_para=0d0
1063 namelist /tc_c_list/ tc_saturate, tc_k_para
1067 read(
unitpar, tc_c_list,
end=111)
1070 fl%tc_saturate = tc_saturate
1071 fl%tc_k_para = tc_k_para
1073 end subroutine tc_c_params_read_hd
1078 subroutine rc_params_read_c(fl)
1081 type(rc_fluid),
intent(inout) :: fl
1084 integer :: ncool = 4000
1085 double precision :: cfrac=0.1d0
1088 character(len=std_len) :: coolcurve=
'JCcorona'
1091 character(len=std_len) :: coolmethod=
'exact'
1094 logical :: tfix=.false.
1100 logical :: rc_split=.false.
1103 namelist /rc_list_c/ coolcurve, coolmethod, ncool, cfrac, tlow, tfix, rc_split
1107 read(
unitpar, rc_list_c,
end=111)
1112 fl%coolcurve=coolcurve
1113 fl%coolmethod=coolmethod
1116 fl%rc_split=rc_split
1118 end subroutine rc_params_read_c
1123 subroutine set_equi_vars_grid_faces(igrid,x,ixI^L,ixO^L)
1127 integer,
intent(in) :: igrid, ixi^
l, ixo^
l
1128 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1130 double precision :: delx(ixi^s,1:
ndim)
1131 double precision :: xc(ixi^s,1:
ndim),xshift^
d
1132 integer :: idims, ixc^
l, hxo^
l, ix, idims2
1138 delx(ixi^s,1:
ndim)=ps(igrid)%dx(ixi^s,1:
ndim)
1143 hxo^
l=ixo^
l-
kr(idims,^
d);
1149 ixcmax^
d=ixomax^
d; ixcmin^
d=hxomin^
d;
1152 xshift^
d=half*(one-
kr(^
d,idims));
1159 xc(ix^
d%ixC^s,^
d)=x(ix^
d%ixC^s,^
d)+(half-xshift^
d)*delx(ix^
d%ixC^s,^
d)
1163 call usr_set_equi_vars(ixi^l,ixc^l,xc,ps(igrid)%equi_vars(ixi^s,1:number_equi_vars,idims))
1166 end subroutine set_equi_vars_grid_faces
1169 subroutine set_equi_vars_grid(igrid)
1173 integer,
intent(in) :: igrid
1179 call set_equi_vars_grid_faces(igrid,ps(igrid)%x,ixg^
ll,
ixm^
ll)
1181 end subroutine set_equi_vars_grid
1184 function convert_vars_splitting(ixI^L,ixO^L, w, x, nwc)
result(wnew)
1186 integer,
intent(in) :: ixi^
l,ixo^
l, nwc
1187 double precision,
intent(in) :: w(ixi^s, 1:nw)
1188 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1189 double precision :: wnew(ixo^s, 1:nwc)
1190 double precision :: rho(ixi^s)
1193 wnew(ixo^s,
rho_n_) = rho(ixo^s)
1196 wnew(ixo^s,
rho_c_) = rho(ixo^s)
1201 wnew(ixo^s,mag(:))=w(ixo^s,mag(:))+
block%B0(ixo^s,:,0)
1203 wnew(ixo^s,mag(:))=w(ixo^s,mag(:))
1206 if(phys_energy)
then
1215 if(
b0field .and. phys_total_energy)
then
1216 wnew(ixo^s,
e_c_)=wnew(ixo^s,
e_c_)+0.5d0*sum(
block%B0(ixo^s,:,0)**2,dim=
ndim+1) &
1217 + sum(w(ixo^s,mag(:))*
block%B0(ixo^s,:,0),dim=
ndim+1)
1221 end function convert_vars_splitting
1224 subroutine grav_params_read(files)
1226 character(len=*),
intent(in) :: files(:)
1229 namelist /grav_list/ grav_split
1231 do n = 1,
size(files)
1232 open(
unitpar, file=trim(files(n)), status=
"old")
1233 read(
unitpar, grav_list,
end=111)
1237 end subroutine grav_params_read
1239 subroutine associate_dump_hyper()
1245 call add_convert_method(dump_hyperdiffusivity_coef_x, nw, cons_wnames(1:nw),
"hyper_x")
1247 call add_convert_method(dump_hyperdiffusivity_coef_y, nw, cons_wnames(1:nw),
"hyper_y")
1249 call add_convert_method(dump_hyperdiffusivity_coef_z, nw, cons_wnames(1:nw),
"hyper_z")
1252 end subroutine associate_dump_hyper
1254 subroutine twofl_check_params
1261 if (.not. phys_energy)
then
1262 if (
twofl_gamma <= 0.0d0)
call mpistop (
"Error: twofl_gamma <= 0")
1263 if (
twofl_adiab < 0.0d0)
call mpistop (
"Error: twofl_adiab < 0")
1267 call mpistop (
"Error: twofl_gamma <= 0 or twofl_gamma == 1")
1268 inv_gamma_1=1.d0/gamma_1
1275 if(has_collisions())
then
1277 phys_implicit_update => twofl_implicit_coll_terms_update
1278 phys_evaluate_implicit => twofl_evaluate_implicit
1279 if(
mype .eq. 1)
then
1280 print*,
"IMPLICIT UPDATE with calc_mult_factor", twofl_implicit_calc_mult_method
1282 if(twofl_implicit_calc_mult_method == 1)
then
1283 calc_mult_factor => calc_mult_factor1
1285 calc_mult_factor => calc_mult_factor2
1291 if (
mype .eq. 0) print*,
"Explicit update of coll terms requires 0<dtcollpar<1, dtcollpar set to 0.8."
1303 call mpistop(
"usr_set_equi_vars has to be implemented in the user file")
1308 if(
mype .eq. 0) print*,
" add conversion method: split -> full "
1312 if(
mype .eq. 0) print*,
" add conversion method: dump coll terms "
1313 call add_convert_method(dump_coll_terms, 3, (/
"alpha ",
"gamma_rec",
"gamma_ion"/),
"_coll")
1316 if(
mype .eq. 0) print*,
" add conversion method: dump hyperdiffusivity coeff. "
1317 call associate_dump_hyper()
1321 end subroutine twofl_check_params
1323 subroutine twofl_physical_units()
1325 double precision :: mp,kb,miu0,c_lightspeed
1327 double precision :: a,b
1338 c_lightspeed=const_c
1384 end subroutine twofl_physical_units
1386 subroutine twofl_check_w(primitive,ixI^L,ixO^L,w,flag)
1389 logical,
intent(in) :: primitive
1390 integer,
intent(in) :: ixi^
l, ixo^
l
1391 double precision,
intent(in) :: w(ixi^s,nw)
1392 double precision :: tmp(ixi^s)
1393 logical,
intent(inout) :: flag(ixi^s,1:nw)
1400 tmp(ixo^s) = w(ixo^s,
rho_n_)
1406 tmp(ixo^s) = w(ixo^s,
rho_c_)
1409 if(phys_energy)
then
1411 tmp(ixo^s) = w(ixo^s,
e_n_)
1416 tmp(ixo^s) = w(ixo^s,
e_c_)
1422 if(phys_internal_e)
then
1423 tmp(ixo^s)=w(ixo^s,
e_n_)
1427 where(tmp(ixo^s) < small_e) flag(ixo^s,
e_n_) = .true.
1428 tmp(ixo^s)=w(ixo^s,
e_c_)
1432 where(tmp(ixo^s) < small_e) flag(ixo^s,
e_c_) = .true.
1435 tmp(ixo^s)=w(ixo^s,
e_n_)-&
1436 twofl_kin_en_n(w,ixi^
l,ixo^
l)
1440 where(tmp(ixo^s) < small_e) flag(ixo^s,
e_n_) = .true.
1441 if(phys_total_energy)
then
1442 tmp(ixo^s)=w(ixo^s,
e_c_)-&
1443 twofl_kin_en_c(w,ixi^
l,ixo^
l)-twofl_mag_en(w,ixi^
l,ixo^
l)
1445 tmp(ixo^s)=w(ixo^s,
e_c_)-&
1446 twofl_kin_en_c(w,ixi^
l,ixo^
l)
1451 where(tmp(ixo^s) < small_e) flag(ixo^s,
e_c_) = .true.
1456 end subroutine twofl_check_w
1461 integer,
intent(in) :: ixi^
l, ixo^
l
1462 double precision,
intent(inout) :: w(ixi^s, nw)
1463 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1465 double precision :: rhoc(ixi^s)
1466 double precision :: rhon(ixi^s)
1476 if(phys_energy)
then
1477 if(phys_internal_e)
then
1478 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*inv_gamma_1
1479 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*inv_gamma_1
1481 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*inv_gamma_1&
1482 +half*sum(w(ixo^s,
mom_n(:))**2,dim=
ndim+1)*rhon(ixo^s)
1483 if(phys_total_energy)
then
1484 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*inv_gamma_1&
1485 +half*sum(w(ixo^s,
mom_c(:))**2,dim=
ndim+1)*rhoc(ixo^s)&
1486 +twofl_mag_en(w, ixi^
l, ixo^
l)
1489 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*inv_gamma_1&
1490 +half*sum(w(ixo^s,
mom_c(:))**2,dim=
ndim+1)*rhoc(ixo^s)
1497 w(ixo^s,
mom_n(idir)) = rhon(ixo^s) * w(ixo^s,
mom_n(idir))
1498 w(ixo^s,
mom_c(idir)) = rhoc(ixo^s) * w(ixo^s,
mom_c(idir))
1505 integer,
intent(in) :: ixi^
l, ixo^
l
1506 double precision,
intent(inout) :: w(ixi^s, nw)
1507 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1509 double precision :: rhoc(ixi^s)
1510 double precision :: rhon(ixi^s)
1513 call twofl_handle_small_values(.false., w, x, ixi^
l, ixo^
l,
'twofl_to_primitive')
1519 if(phys_energy)
then
1520 if(phys_internal_e)
then
1521 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*gamma_1
1522 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*gamma_1
1525 w(ixo^s,
e_n_)=gamma_1*(w(ixo^s,
e_n_)&
1526 -twofl_kin_en_n(w,ixi^
l,ixo^
l))
1528 if(phys_total_energy)
then
1530 w(ixo^s,
e_c_)=gamma_1*(w(ixo^s,
e_c_)&
1531 -twofl_kin_en_c(w,ixi^
l,ixo^
l)&
1532 -twofl_mag_en(w,ixi^
l,ixo^
l))
1535 w(ixo^s,
e_c_)=gamma_1*(w(ixo^s,
e_c_)&
1536 -twofl_kin_en_c(w,ixi^
l,ixo^
l))
1543 w(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir))/rhoc(ixo^s)
1544 w(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir))/rhon(ixo^s)
1551 subroutine twofl_ei_to_e_c(ixI^L,ixO^L,w,x)
1553 integer,
intent(in) :: ixi^
l, ixo^
l
1554 double precision,
intent(inout) :: w(ixi^s, nw)
1555 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1560 +twofl_kin_en_c(w,ixi^
l,ixo^
l)
1563 +twofl_kin_en_c(w,ixi^
l,ixo^
l)&
1564 +twofl_mag_en(w,ixi^
l,ixo^
l)
1566 end subroutine twofl_ei_to_e_c
1569 subroutine twofl_e_to_ei_c(ixI^L,ixO^L,w,x)
1571 integer,
intent(in) :: ixi^
l, ixo^
l
1572 double precision,
intent(inout) :: w(ixi^s, nw)
1573 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1577 -twofl_kin_en_c(w,ixi^
l,ixo^
l)
1581 -twofl_kin_en_c(w,ixi^
l,ixo^
l)&
1582 -twofl_mag_en(w,ixi^
l,ixo^
l)
1584 end subroutine twofl_e_to_ei_c
1587 subroutine twofl_ei_to_e_n(ixI^L,ixO^L,w,x)
1589 integer,
intent(in) :: ixi^
l, ixo^
l
1590 double precision,
intent(inout) :: w(ixi^s, nw)
1591 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1595 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)+twofl_kin_en_n(w,ixi^
l,ixo^
l)
1597 end subroutine twofl_ei_to_e_n
1600 subroutine twofl_e_to_ei_n(ixI^L,ixO^L,w,x)
1602 integer,
intent(in) :: ixi^
l, ixo^
l
1603 double precision,
intent(inout) :: w(ixi^s, nw)
1604 double precision,
intent(in) :: x(ixi^s, 1:
ndim)
1607 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)-twofl_kin_en_n(w,ixi^
l,ixo^
l)
1609 call twofl_handle_small_ei_n(w,x,ixi^
l,ixo^
l,
e_n_,
"e_to_ei_n")
1610 end subroutine twofl_e_to_ei_n
1612 subroutine twofl_handle_small_values(primitive, w, x, ixI^L, ixO^L, subname)
1615 logical,
intent(in) :: primitive
1616 integer,
intent(in) :: ixi^
l,ixo^
l
1617 double precision,
intent(inout) :: w(ixi^s,1:nw)
1618 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1619 character(len=*),
intent(in) :: subname
1622 logical :: flag(ixi^s,1:nw)
1623 double precision :: tmp2(ixi^s)
1624 double precision :: tmp1(ixi^s)
1626 call twofl_check_w(primitive, ixi^
l, ixo^
l, w, flag)
1645 where(flag(ixo^s,
rho_n_)) w(ixo^s,
mom_n(idir)) = 0.0d0
1648 where(flag(ixo^s,
rho_c_)) w(ixo^s,
mom_c(idir)) = 0.0d0
1652 if(phys_energy)
then
1661 tmp2(ixo^s) = small_e - &
1669 tmp1(ixo^s) = small_e - &
1672 tmp1(ixo^s) = small_e
1675 tmp2(ixo^s) = small_e - &
1678 tmp2(ixo^s) = small_e
1680 if(phys_internal_e)
then
1681 where(flag(ixo^s,
e_n_))
1682 w(ixo^s,
e_n_)=tmp1(ixo^s)
1684 where(flag(ixo^s,
e_c_))
1685 w(ixo^s,
e_c_)=tmp2(ixo^s)
1688 where(flag(ixo^s,
e_n_))
1689 w(ixo^s,
e_n_) = tmp1(ixo^s)+&
1690 twofl_kin_en_n(w,ixi^
l,ixo^
l)
1692 if(phys_total_energy)
then
1693 where(flag(ixo^s,
e_c_))
1694 w(ixo^s,
e_c_) = tmp2(ixo^s)+&
1695 twofl_kin_en_c(w,ixi^
l,ixo^
l)+&
1696 twofl_mag_en(w,ixi^
l,ixo^
l)
1699 where(flag(ixo^s,
e_c_))
1700 w(ixo^s,
e_c_) = tmp2(ixo^s)+&
1701 twofl_kin_en_c(w,ixi^
l,ixo^
l)
1710 if(.not.primitive)
then
1713 if(phys_energy)
then
1714 if(phys_internal_e)
then
1715 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*gamma_1
1716 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*gamma_1
1718 w(ixo^s,
e_n_)=gamma_1*(w(ixo^s,
e_n_)&
1719 -twofl_kin_en_n(w,ixi^
l,ixo^
l))
1720 if(phys_total_energy)
then
1721 w(ixo^s,
e_c_)=gamma_1*(w(ixo^s,
e_c_)&
1722 -twofl_kin_en_c(w,ixi^
l,ixo^
l)&
1723 -twofl_mag_en(w,ixi^
l,ixo^
l))
1725 w(ixo^s,
e_c_)=gamma_1*(w(ixo^s,
e_c_)&
1726 -twofl_kin_en_c(w,ixi^
l,ixo^
l))
1735 tmp1(ixo^s) = w(ixo^s,
rho_n_)
1741 tmp2(ixo^s) = w(ixo^s,
rho_c_)
1744 w(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir))/tmp1(ixo^s)
1745 w(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir))/tmp2(ixo^s)
1751 end subroutine twofl_handle_small_values
1754 subroutine twofl_get_cmax(w,x,ixI^L,ixO^L,idim,cmax)
1757 integer,
intent(in) :: ixi^
l, ixo^
l, idim
1759 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1760 double precision,
intent(inout) :: cmax(ixi^s)
1761 double precision :: cmax2(ixi^s),rhon(ixi^s)
1763 call twofl_get_csound_c_idim(w,x,ixi^
l,ixo^
l,idim,cmax)
1765 if(phys_energy)
then
1775 cmax(ixo^s)=max(abs(w(ixo^s,
mom_n(idim)))+cmax2(ixo^s),&
1776 abs(w(ixo^s,
mom_c(idim)))+cmax(ixo^s))
1778 end subroutine twofl_get_cmax
1780 subroutine twofl_get_a2max(w,x,ixI^L,ixO^L,a2max)
1783 integer,
intent(in) :: ixi^
l, ixo^
l
1784 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
1785 double precision,
intent(inout) :: a2max(
ndim)
1786 double precision :: a2(ixi^s,
ndim,nw)
1787 integer :: gxo^
l,hxo^
l,jxo^
l,kxo^
l,i,j
1792 hxo^
l=ixo^
l-
kr(i,^
d);
1793 gxo^
l=hxo^
l-
kr(i,^
d);
1794 jxo^
l=ixo^
l+
kr(i,^
d);
1795 kxo^
l=jxo^
l+
kr(i,^
d);
1796 a2(ixo^s,i,1:nw)=abs(-w(kxo^s,1:nw)+16.d0*w(jxo^s,1:nw)&
1797 -30.d0*w(ixo^s,1:nw)+16.d0*w(hxo^s,1:nw)-w(gxo^s,1:nw))
1798 a2max(i)=maxval(a2(ixo^s,i,1:nw))/12.d0/
dxlevel(i)**2
1800 end subroutine twofl_get_a2max
1804 subroutine twofl_get_tcutoff_n(ixI^L,ixO^L,w,x,tco_local,Tmax_local)
1806 integer,
intent(in) :: ixi^
l,ixo^
l
1807 double precision,
intent(in) :: x(ixi^s,1:
ndim),w(ixi^s,1:nw)
1808 double precision,
intent(out) :: tco_local, tmax_local
1810 double precision,
parameter :: delta=0.25d0
1811 double precision :: tmp1(ixi^s),te(ixi^s),lts(ixi^s)
1812 integer :: jxo^
l,hxo^
l
1813 logical :: lrlt(ixi^s)
1818 tmp1(ixi^s)=w(ixi^s,
e_n_)-0.5d0*sum(w(ixi^s,
mom_n(:))**2,dim=
ndim+1)/lts(ixi^s)
1819 te(ixi^s)=tmp1(ixi^s)/lts(ixi^s)*(
twofl_gamma-1.d0)
1821 tmax_local=maxval(te(ixo^s))
1825 lts(ixo^s)=0.5d0*abs(te(jxo^s)-te(hxo^s))/te(ixo^s)
1827 where(lts(ixo^s) > delta)
1831 if(any(lrlt(ixo^s)))
then
1832 tco_local=maxval(te(ixo^s), mask=lrlt(ixo^s))
1835 end subroutine twofl_get_tcutoff_n
1838 subroutine twofl_get_tcutoff_c(ixI^L,ixO^L,w,x,Tco_local,Tmax_local)
1841 integer,
intent(in) :: ixi^
l,ixo^
l
1842 double precision,
intent(in) :: x(ixi^s,1:
ndim)
1843 double precision,
intent(inout) :: w(ixi^s,1:nw)
1844 double precision,
intent(out) :: tco_local,tmax_local
1846 double precision,
parameter :: trac_delta=0.25d0
1847 double precision :: tmp1(ixi^s),te(ixi^s),lts(ixi^s)
1848 double precision,
dimension(ixI^S,1:ndir) :: bunitvec
1849 double precision,
dimension(ixI^S,1:ndim) :: gradt
1850 double precision :: bdir(
ndim)
1851 double precision :: ltr(ixi^s),ltrc,ltrp,altr(ixi^s)
1852 integer :: idims,jxo^
l,hxo^
l,ixa^
d,ixb^
d
1853 integer :: jxp^
l,hxp^
l,ixp^
l
1854 logical :: lrlt(ixi^s)
1858 if(phys_internal_e)
then
1859 tmp1(ixi^s)=w(ixi^s,
e_c_)
1861 tmp1(ixi^s)=w(ixi^s,
e_c_)-0.5d0*(sum(w(ixi^s,
mom_c(:))**2,dim=
ndim+1)/&
1862 lts(ixi^s)+sum(w(ixi^s,mag(:))**2,dim=
ndim+1))
1864 te(ixi^s)=tmp1(ixi^s)/lts(ixi^s)*(
twofl_gamma-1.d0)
1865 tmax_local=maxval(te(ixo^s))
1875 lts(ixo^s)=0.5d0*abs(te(jxo^s)-te(hxo^s))/te(ixo^s)
1877 where(lts(ixo^s) > trac_delta)
1880 if(any(lrlt(ixo^s)))
then
1881 tco_local=maxval(te(ixo^s), mask=lrlt(ixo^s))
1892 lts(ixp^s)=0.5d0*abs(te(jxp^s)-te(hxp^s))/te(ixp^s)
1893 ltr(ixp^s)=max(one, (exp(lts(ixp^s))/ltrc)**ltrp)
1895 (0.25*(ltr(jxo^s)+two*ltr(ixo^s)+ltr(hxo^s)))**0.4d0
1897 call mpistop(
"twofl_trac_type not allowed for 1D simulation")
1909 gradt(ixo^s,idims)=tmp1(ixo^s)
1913 bunitvec(ixo^s,:)=w(ixo^s,iw_mag(:))+
block%B0(ixo^s,:,0)
1915 bunitvec(ixo^s,:)=w(ixo^s,iw_mag(:))
1921 ixb^
d=(ixomin^
d+ixomax^
d-1)/2+ixa^
d;
1924 if(sum(bdir(:)**2) .gt. zero)
then
1925 bdir(1:ndim)=bdir(1:ndim)/dsqrt(sum(bdir(:)**2))
1927 block%special_values(3:ndim+2)=bdir(1:ndim)
1929 tmp1(ixo^s)=dsqrt(sum(bunitvec(ixo^s,:)**2,dim=ndim+1))
1930 where(tmp1(ixo^s)/=0.d0)
1931 tmp1(ixo^s)=1.d0/tmp1(ixo^s)
1933 tmp1(ixo^s)=bigdouble
1937 bunitvec(ixo^s,idims)=bunitvec(ixo^s,idims)*tmp1(ixo^s)
1940 lts(ixo^s)=abs(sum(gradt(ixo^s,1:ndim)*bunitvec(ixo^s,1:ndim),dim=ndim+1))/te(ixo^s)
1942 if(slab_uniform)
then
1943 lts(ixo^s)=minval(dxlevel)*lts(ixo^s)
1945 lts(ixo^s)=minval(block%ds(ixo^s,:),dim=ndim+1)*lts(ixo^s)
1948 where(lts(ixo^s) > trac_delta)
1951 if(any(lrlt(ixo^s)))
then
1952 block%special_values(1)=maxval(te(ixo^s), mask=lrlt(ixo^s))
1954 block%special_values(1)=zero
1956 block%special_values(2)=tmax_local
1964 call gradient(te,ixi^l,ixp^l,idims,tmp1)
1965 gradt(ixp^s,idims)=tmp1(ixp^s)
1969 bunitvec(ixp^s,:)=w(ixp^s,iw_mag(:))+block%B0(ixp^s,:,0)
1971 bunitvec(ixp^s,:)=w(ixp^s,iw_mag(:))
1973 tmp1(ixp^s)=dsqrt(sum(bunitvec(ixp^s,:)**2,dim=ndim+1))
1974 where(tmp1(ixp^s)/=0.d0)
1975 tmp1(ixp^s)=1.d0/tmp1(ixp^s)
1977 tmp1(ixp^s)=bigdouble
1981 bunitvec(ixp^s,idims)=bunitvec(ixp^s,idims)*tmp1(ixp^s)
1984 lts(ixp^s)=abs(sum(gradt(ixp^s,1:ndim)*bunitvec(ixp^s,1:ndim),dim=ndim+1))/te(ixp^s)
1986 if(slab_uniform)
then
1987 lts(ixp^s)=minval(dxlevel)*lts(ixp^s)
1989 lts(ixp^s)=minval(block%ds(ixp^s,:),dim=ndim+1)*lts(ixp^s)
1991 ltr(ixp^s)=max(one, (exp(lts(ixp^s))/ltrc)**ltrp)
1995 hxo^l=ixo^l-kr(idims,^d);
1996 jxo^l=ixo^l+kr(idims,^d);
1997 altr(ixo^s)=altr(ixo^s) &
1998 +0.25*(ltr(hxo^s)+two*ltr(ixo^s)+ltr(jxo^s))*bunitvec(ixo^s,idims)**2
1999 w(ixo^s,
tcoff_c_)=te(ixo^s)*altr(ixo^s)**(0.4*ltrp)
2004 call mpistop(
"unknown twofl_trac_type")
2007 end subroutine twofl_get_tcutoff_c
2010 subroutine twofl_get_h_speed_one(wprim,x,ixI^L,ixO^L,idim,Hspeed)
2013 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2014 double precision,
intent(in) :: wprim(ixi^s, nw)
2015 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2016 double precision,
intent(out) :: hspeed(ixi^s,1:number_species)
2018 double precision :: csound(ixi^s,
ndim),tmp(ixi^s)
2019 integer :: jxc^
l, ixc^
l, ixa^
l, id, ix^
d
2024 call twofl_get_csound_prim(wprim,x,ixi^
l,ixa^
l,id,tmp)
2025 csound(ixa^s,id)=tmp(ixa^s)
2028 ixcmin^
d=ixomin^
d+
kr(idim,^
d)-1;
2029 jxcmax^
d=ixcmax^
d+
kr(idim,^
d);
2030 jxcmin^
d=ixcmin^
d+
kr(idim,^
d);
2031 hspeed(ixc^s,1)=0.5d0*abs(&
2032 0.5d0 * (wprim(jxc^s,
mom_c(idim))+ wprim(jxc^s,
mom_n(idim))) &
2033 +csound(jxc^s,idim)- &
2034 0.5d0 * (wprim(ixc^s,
mom_c(idim)) + wprim(ixc^s,
mom_n(idim)))&
2035 +csound(ixc^s,idim))
2039 ixamax^
d=ixcmax^
d+
kr(id,^
d);
2040 ixamin^
d=ixcmin^
d+
kr(id,^
d);
2041 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(&
2042 0.5d0 * (wprim(ixa^s,
mom_c(id)) + wprim(ixa^s,
mom_n(id)))&
2044 0.5d0 * (wprim(ixc^s,
mom_c(id)) + wprim(ixc^s,
mom_n(id)))&
2048 ixamax^
d=ixcmax^
d-
kr(id,^
d);
2049 ixamin^
d=ixcmin^
d-
kr(id,^
d);
2050 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(&
2051 0.5d0 * (wprim(ixc^s,
mom_c(id)) + wprim(ixc^s,
mom_n(id)))&
2053 0.5d0 * (wprim(ixa^s,
mom_c(id)) + wprim(ixa^s,
mom_n(id)))&
2060 ixamax^
d=jxcmax^
d+
kr(id,^
d);
2061 ixamin^
d=jxcmin^
d+
kr(id,^
d);
2062 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(&
2063 0.5d0 * (wprim(ixa^s,
mom_c(id)) + wprim(ixa^s,
mom_n(id)))&
2065 0.5d0 * (wprim(jxc^s,
mom_c(id)) + wprim(jxc^s,
mom_n(id)))&
2067 ixamax^
d=jxcmax^
d-
kr(id,^
d);
2068 ixamin^
d=jxcmin^
d-
kr(id,^
d);
2069 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(&
2070 0.5d0 * (wprim(jxc^s,
mom_c(id)) + wprim(jxc^s,
mom_n(id)))&
2072 0.5d0 * (wprim(ixa^s,
mom_c(id)) + wprim(ixa^s,
mom_n(id)))&
2076 end subroutine twofl_get_h_speed_one
2079 subroutine twofl_get_h_speed_species(wprim,x,ixI^L,ixO^L,idim,Hspeed)
2082 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2083 double precision,
intent(in) :: wprim(ixi^s, nw)
2084 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2085 double precision,
intent(out) :: hspeed(ixi^s,1:number_species)
2087 double precision :: csound(ixi^s,
ndim),tmp(ixi^s)
2088 integer :: jxc^
l, ixc^
l, ixa^
l, id, ix^
d
2094 call twofl_get_csound_prim_c(wprim,x,ixi^
l,ixa^
l,id,tmp)
2095 csound(ixa^s,id)=tmp(ixa^s)
2098 ixcmin^
d=ixomin^
d+
kr(idim,^
d)-1;
2099 jxcmax^
d=ixcmax^
d+
kr(idim,^
d);
2100 jxcmin^
d=ixcmin^
d+
kr(idim,^
d);
2101 hspeed(ixc^s,1)=0.5d0*abs(wprim(jxc^s,
mom_c(idim))+csound(jxc^s,idim)-wprim(ixc^s,
mom_c(idim))+csound(ixc^s,idim))
2105 ixamax^
d=ixcmax^
d+
kr(id,^
d);
2106 ixamin^
d=ixcmin^
d+
kr(id,^
d);
2107 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixa^s,
mom_c(id))+csound(ixa^s,id)-wprim(ixc^s,
mom_c(id))+csound(ixc^s,id)))
2108 ixamax^
d=ixcmax^
d-
kr(id,^
d);
2109 ixamin^
d=ixcmin^
d-
kr(id,^
d);
2110 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixc^s,
mom_c(id))+csound(ixc^s,id)-wprim(ixa^s,
mom_c(id))+csound(ixa^s,id)))
2115 ixamax^
d=jxcmax^
d+
kr(id,^
d);
2116 ixamin^
d=jxcmin^
d+
kr(id,^
d);
2117 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(ixa^s,
mom_c(id))+csound(ixa^s,id)-wprim(jxc^s,
mom_c(id))+csound(jxc^s,id)))
2118 ixamax^
d=jxcmax^
d-
kr(id,^
d);
2119 ixamin^
d=jxcmin^
d-
kr(id,^
d);
2120 hspeed(ixc^s,1)=max(hspeed(ixc^s,1),0.5d0*abs(wprim(jxc^s,
mom_c(id))+csound(jxc^s,id)-wprim(ixa^s,
mom_c(id))+csound(ixa^s,id)))
2126 call twofl_get_csound_prim_n(wprim,x,ixi^
l,ixa^
l,id,tmp)
2127 csound(ixa^s,id)=tmp(ixa^s)
2130 ixcmin^
d=ixomin^
d+
kr(idim,^
d)-1;
2131 jxcmax^
d=ixcmax^
d+
kr(idim,^
d);
2132 jxcmin^
d=ixcmin^
d+
kr(idim,^
d);
2133 hspeed(ixc^s,2)=0.5d0*abs(wprim(jxc^s,
mom_n(idim))+csound(jxc^s,idim)-wprim(ixc^s,
mom_n(idim))+csound(ixc^s,idim))
2137 ixamax^
d=ixcmax^
d+
kr(id,^
d);
2138 ixamin^
d=ixcmin^
d+
kr(id,^
d);
2139 hspeed(ixc^s,2)=max(hspeed(ixc^s,2),0.5d0*abs(wprim(ixa^s,
mom_n(id))+csound(ixa^s,id)-wprim(ixc^s,
mom_n(id))+csound(ixc^s,id)))
2140 ixamax^
d=ixcmax^
d-
kr(id,^
d);
2141 ixamin^
d=ixcmin^
d-
kr(id,^
d);
2142 hspeed(ixc^s,2)=max(hspeed(ixc^s,2),0.5d0*abs(wprim(ixc^s,
mom_n(id))+csound(ixc^s,id)-wprim(ixa^s,
mom_n(id))+csound(ixa^s,id)))
2147 ixamax^
d=jxcmax^
d+
kr(id,^
d);
2148 ixamin^
d=jxcmin^
d+
kr(id,^
d);
2149 hspeed(ixc^s,2)=max(hspeed(ixc^s,2),0.5d0*abs(wprim(ixa^s,
mom_n(id))+csound(ixa^s,id)-wprim(jxc^s,
mom_n(id))+csound(jxc^s,id)))
2150 ixamax^
d=jxcmax^
d-
kr(id,^
d);
2151 ixamin^
d=jxcmin^
d-
kr(id,^
d);
2152 hspeed(ixc^s,2)=max(hspeed(ixc^s,2),0.5d0*abs(wprim(jxc^s,
mom_n(id))+csound(jxc^s,id)-wprim(ixa^s,
mom_n(id))+csound(ixa^s,id)))
2155 end subroutine twofl_get_h_speed_species
2158 subroutine twofl_get_cbounds_one(wLC,wRC,wLp,wRp,x,ixI^L,ixO^L,idim,Hspeed,cmax,cmin)
2162 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2163 double precision,
intent(in) :: wlc(ixi^s, nw), wrc(ixi^s, nw)
2164 double precision,
intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
2165 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2166 double precision,
intent(inout) :: cmax(ixi^s,number_species)
2167 double precision,
intent(inout),
optional :: cmin(ixi^s,number_species)
2168 double precision,
intent(in) :: hspeed(ixi^s,1:number_species)
2170 double precision :: wmean(ixi^s,nw)
2171 double precision :: rhon(ixi^s)
2172 double precision :: rhoc(ixi^s)
2173 double precision,
dimension(ixI^S) :: umean, dmean, csoundl, csoundr, tmp1,tmp2,tmp3
2182 tmp1(ixo^s)=sqrt(abs(rhoc(ixo^s) +rhon(ixo^s)))
2186 tmp2(ixo^s)=sqrt(abs(rhoc(ixo^s) +rhon(ixo^s)))
2188 tmp3(ixo^s)=1.d0/(tmp1(ixo^s)+tmp2(ixo^s))
2189 umean(ixo^s)=(0.5*(wlp(ixo^s,
mom_n(idim))+wlp(ixo^s,
mom_c(idim)))*tmp1(ixo^s) + &
2190 0.5*(wrp(ixo^s,
mom_n(idim))+wrp(ixo^s,
mom_c(idim)))*tmp2(ixo^s))*tmp3(ixo^s)
2191 call twofl_get_csound_prim(wlp,x,ixi^
l,ixo^
l,idim,csoundl)
2192 call twofl_get_csound_prim(wrp,x,ixi^
l,ixo^
l,idim,csoundr)
2194 dmean(ixo^s)=(tmp1(ixo^s)*csoundl(ixo^s)**2+tmp2(ixo^s)*csoundr(ixo^s)**2)*tmp3(ixo^s)+&
2195 0.5d0*tmp1(ixo^s)*tmp2(ixo^s)*tmp3(ixo^s)**2*(&
2196 0.5*(wrp(ixo^s,
mom_n(idim))+wrp(ixo^s,
mom_c(idim)))- &
2197 0.5*(wlp(ixo^s,
mom_n(idim))+wlp(ixo^s,
mom_c(idim))))**2
2198 dmean(ixo^s)=sqrt(dmean(ixo^s))
2199 if(
present(cmin))
then
2200 cmin(ixo^s,1)=umean(ixo^s)-dmean(ixo^s)
2201 cmax(ixo^s,1)=umean(ixo^s)+dmean(ixo^s)
2203 {
do ix^db=ixomin^db,ixomax^db\}
2204 cmin(ix^
d,1)=sign(one,cmin(ix^
d,1))*max(abs(cmin(ix^
d,1)),hspeed(ix^
d,1))
2205 cmax(ix^
d,1)=sign(one,cmax(ix^
d,1))*max(abs(cmax(ix^
d,1)),hspeed(ix^
d,1))
2209 cmax(ixo^s,1)=abs(umean(ixo^s))+dmean(ixo^s)
2213 wmean(ixo^s,1:nwflux)=0.5d0*(wlc(ixo^s,1:nwflux)+wrc(ixo^s,1:nwflux))
2215 tmp2(ixo^s)=wmean(ixo^s,
mom_n(idim))/rhon(ixo^s)
2217 tmp1(ixo^s)=wmean(ixo^s,
mom_c(idim))/rhoc(ixo^s)
2218 call twofl_get_csound(wmean,x,ixi^l,ixo^l,idim,csoundr)
2219 if(
present(cmin))
then
2220 cmax(ixo^s,1)=max(max(abs(tmp2(ixo^s)), abs(tmp1(ixo^s)) ) +csoundr(ixo^s),zero)
2221 cmin(ixo^s,1)=min(min(abs(tmp2(ixo^s)), abs(tmp1(ixo^s)) ) -csoundr(ixo^s),zero)
2222 if(h_correction)
then
2223 {
do ix^db=ixomin^db,ixomax^db\}
2224 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
2225 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
2229 cmax(ixo^s,1)= max(abs(tmp2(ixo^s)),abs(tmp1(ixo^s)))+csoundr(ixo^s)
2233 call twofl_get_csound(wlp,x,ixi^l,ixo^l,idim,csoundl)
2234 call twofl_get_csound(wrp,x,ixi^l,ixo^l,idim,csoundr)
2235 csoundl(ixo^s)=max(csoundl(ixo^s),csoundr(ixo^s))
2236 if(
present(cmin))
then
2237 cmin(ixo^s,1)=min(0.5*(wlp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))),&
2238 0.5*(wrp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))))-csoundl(ixo^s)
2239 cmax(ixo^s,1)=max(0.5*(wlp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))),&
2240 0.5*(wrp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))))+csoundl(ixo^s)
2241 if(h_correction)
then
2242 {
do ix^db=ixomin^db,ixomax^db\}
2243 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
2244 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
2248 cmax(ixo^s,1)=max(0.5*(wlp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))),&
2249 0.5*(wrp(ixo^s,
mom_c(idim))+ wrp(ixo^s,
mom_n(idim))))+csoundl(ixo^s)
2253 end subroutine twofl_get_cbounds_one
2256 subroutine twofl_get_csound_prim_c(w,x,ixI^L,ixO^L,idim,csound)
2259 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2260 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
2261 double precision,
intent(out):: csound(ixi^s)
2262 double precision :: cfast2(ixi^s), avmincs2(ixi^s), b2(ixi^s), kmax
2263 double precision :: inv_rho(ixo^s)
2264 double precision :: rhoc(ixi^s)
2270 inv_rho(ixo^s)=1.d0/rhoc(ixo^s)
2272 if(phys_energy)
then
2273 call twofl_get_pthermal_c_primitive(w,x,ixi^
l,ixo^
l,csound)
2274 csound(ixo^s)=
twofl_gamma*csound(ixo^s)/rhoc(ixo^s)
2276 call twofl_get_csound2_adiab_c(w,x,ixi^
l,ixo^
l,csound)
2280 b2(ixo^s) = twofl_mag_en_all(w,ixi^
l,ixo^
l)
2281 cfast2(ixo^s) = b2(ixo^s) * inv_rho(ixo^s)+csound(ixo^s)
2282 avmincs2(ixo^s) = cfast2(ixo^s)**2-4.0d0*csound(ixo^s) &
2283 * twofl_mag_i_all(w,ixi^
l,ixo^
l,idim)**2 &
2286 where(avmincs2(ixo^s)<zero)
2287 avmincs2(ixo^s)=zero
2290 avmincs2(ixo^s)=sqrt(avmincs2(ixo^s))
2293 csound(ixo^s) = sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s)))
2298 kmax = dpi/min({
dxlevel(^
d)},bigdouble)*half
2299 csound(ixo^s) = max(sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s))), &
2300 twofl_etah * sqrt(b2(ixo^s))*inv_rho(ixo^s)*kmax)
2303 end subroutine twofl_get_csound_prim_c
2306 subroutine twofl_get_csound_prim_n(w,x,ixI^L,ixO^L,idim,csound)
2309 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2310 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
2311 double precision,
intent(out):: csound(ixi^s)
2312 double precision :: rhon(ixi^s)
2314 if(phys_energy)
then
2316 call twofl_get_pthermal_n_primitive(w,x,ixi^
l,ixo^
l,csound)
2317 csound(ixo^s)=
twofl_gamma*csound(ixo^s)/rhon(ixo^s)
2319 call twofl_get_csound2_adiab_n(w,x,ixi^
l,ixo^
l,csound)
2321 csound(ixo^s) = sqrt(csound(ixo^s))
2323 end subroutine twofl_get_csound_prim_n
2326 subroutine twofl_get_cbounds_species(wLC,wRC,wLp,wRp,x,ixI^L,ixO^L,idim,Hspeed,cmax,cmin)
2331 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2332 double precision,
intent(in) :: wlc(ixi^s,
nw), wrc(ixi^s,
nw)
2333 double precision,
intent(in) :: wlp(ixi^s,
nw), wrp(ixi^s,
nw)
2334 double precision,
intent(in) :: x(ixi^s,1:
ndim)
2336 double precision,
intent(inout),
optional :: cmin(ixi^s,1:
number_species)
2339 double precision :: wmean(ixi^s,
nw)
2340 double precision :: rho(ixi^s)
2341 double precision,
dimension(ixI^S) :: umean, dmean, csoundl, csoundr, tmp1,tmp2,tmp3
2350 tmp1(ixo^s)=sqrt(abs(rho(ixo^s)))
2353 tmp2(ixo^s)=sqrt(abs(rho(ixo^s)))
2355 tmp3(ixo^s)=1.d0/(tmp1(ixo^s)+tmp2(ixo^s))
2356 umean(ixo^s)=(wlp(ixo^s,
mom_c(idim))*tmp1(ixo^s)+wrp(ixo^s,
mom_c(idim))*tmp2(ixo^s))*tmp3(ixo^s)
2357 call twofl_get_csound_prim_c(wlp,x,ixi^
l,ixo^
l,idim,csoundl)
2358 call twofl_get_csound_prim_c(wrp,x,ixi^
l,ixo^
l,idim,csoundr)
2361 dmean(ixo^s)=(tmp1(ixo^s)*csoundl(ixo^s)**2+tmp2(ixo^s)*csoundr(ixo^s)**2)*tmp3(ixo^s)+&
2362 0.5d0*tmp1(ixo^s)*tmp2(ixo^s)*tmp3(ixo^s)**2*&
2363 (wrp(ixo^s,
mom_c(idim)) - wlp(ixo^s,
mom_c(idim)))**2
2364 dmean(ixo^s)=sqrt(dmean(ixo^s))
2365 if(
present(cmin))
then
2366 cmin(ixo^s,1)=umean(ixo^s)-dmean(ixo^s)
2367 cmax(ixo^s,1)=umean(ixo^s)+dmean(ixo^s)
2369 {
do ix^db=ixomin^db,ixomax^db\}
2370 cmin(ix^
d,1)=sign(one,cmin(ix^
d,1))*max(abs(cmin(ix^
d,1)),hspeed(ix^
d,1))
2371 cmax(ix^
d,1)=sign(one,cmax(ix^
d,1))*max(abs(cmax(ix^
d,1)),hspeed(ix^
d,1))
2375 cmax(ixo^s,1)=abs(umean(ixo^s))+dmean(ixo^s)
2381 tmp1(ixo^s)=sqrt(abs(rho(ixo^s)))
2384 tmp2(ixo^s)=sqrt(abs(rho(ixo^s)))
2386 tmp3(ixo^s)=1.d0/(tmp1(ixo^s)+tmp2(ixo^s))
2387 umean(ixo^s)=(wlp(ixo^s,
mom_n(idim))*tmp1(ixo^s)+wrp(ixo^s,
mom_n(idim))*tmp2(ixo^s))*tmp3(ixo^s)
2388 call twofl_get_csound_prim_n(wlp,x,ixi^l,ixo^l,idim,csoundl)
2389 call twofl_get_csound_prim_n(wrp,x,ixi^l,ixo^l,idim,csoundr)
2392 dmean(ixo^s)=(tmp1(ixo^s)*csoundl(ixo^s)**2+tmp2(ixo^s)*csoundr(ixo^s)**2)*tmp3(ixo^s)+&
2393 0.5d0*tmp1(ixo^s)*tmp2(ixo^s)*tmp3(ixo^s)**2*&
2394 (wrp(ixo^s,
mom_n(idim)) - wlp(ixo^s,
mom_n(idim)))**2
2395 dmean(ixo^s)=sqrt(dmean(ixo^s))
2396 if(
present(cmin))
then
2397 cmin(ixo^s,2)=umean(ixo^s)-dmean(ixo^s)
2398 cmax(ixo^s,2)=umean(ixo^s)+dmean(ixo^s)
2399 if(h_correction)
then
2400 {
do ix^db=ixomin^db,ixomax^db\}
2401 cmin(ix^d,2)=sign(one,cmin(ix^d,2))*max(abs(cmin(ix^d,2)),hspeed(ix^d,2))
2402 cmax(ix^d,2)=sign(one,cmax(ix^d,2))*max(abs(cmax(ix^d,2)),hspeed(ix^d,2))
2406 cmax(ixo^s,2)=abs(umean(ixo^s))+dmean(ixo^s)
2411 wmean(ixo^s,1:nwflux)=0.5d0*(wlp(ixo^s,1:nwflux)+wrp(ixo^s,1:nwflux))
2413 tmp1(ixo^s)=wmean(ixo^s,
mom_c(idim))
2414 call twofl_get_csound_c_idim(wmean,x,ixi^l,ixo^l,idim,csoundr)
2415 if(
present(cmin))
then
2416 cmax(ixo^s,1)=max(abs(tmp1(ixo^s))+csoundr(ixo^s),zero)
2417 cmin(ixo^s,1)=min(abs(tmp1(ixo^s))-csoundr(ixo^s),zero)
2418 if(h_correction)
then
2419 {
do ix^db=ixomin^db,ixomax^db\}
2420 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
2421 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
2425 cmax(ixo^s,1)=abs(tmp1(ixo^s))+csoundr(ixo^s)
2429 tmp1(ixo^s)=wmean(ixo^s,
mom_n(idim))
2430 call twofl_get_csound_n(wmean,x,ixi^l,ixo^l,csoundr)
2431 if(
present(cmin))
then
2432 cmax(ixo^s,2)=max(abs(tmp1(ixo^s))+csoundr(ixo^s),zero)
2433 cmin(ixo^s,2)=min(abs(tmp1(ixo^s))-csoundr(ixo^s),zero)
2434 if(h_correction)
then
2435 {
do ix^db=ixomin^db,ixomax^db\}
2436 cmin(ix^d,2)=sign(one,cmin(ix^d,2))*max(abs(cmin(ix^d,2)),hspeed(ix^d,2))
2437 cmax(ix^d,2)=sign(one,cmax(ix^d,2))*max(abs(cmax(ix^d,2)),hspeed(ix^d,2))
2441 cmax(ixo^s,2)= abs(tmp1(ixo^s))+csoundr(ixo^s)
2445 call twofl_get_csound_c_idim(wlp,x,ixi^l,ixo^l,idim,csoundl)
2446 call twofl_get_csound_c_idim(wrp,x,ixi^l,ixo^l,idim,csoundr)
2447 csoundl(ixo^s)=max(csoundl(ixo^s),csoundr(ixo^s))
2448 if(
present(cmin))
then
2449 cmin(ixo^s,1)=min(wlp(ixo^s,
mom_c(idim)),wrp(ixo^s,
mom_c(idim)))-csoundl(ixo^s)
2450 cmax(ixo^s,1)=max(wlp(ixo^s,
mom_c(idim)),wrp(ixo^s,
mom_c(idim)))+csoundl(ixo^s)
2451 if(h_correction)
then
2452 {
do ix^db=ixomin^db,ixomax^db\}
2453 cmin(ix^d,1)=sign(one,cmin(ix^d,1))*max(abs(cmin(ix^d,1)),hspeed(ix^d,1))
2454 cmax(ix^d,1)=sign(one,cmax(ix^d,1))*max(abs(cmax(ix^d,1)),hspeed(ix^d,1))
2458 cmax(ixo^s,1)=max(wlp(ixo^s,
mom_c(idim)),wrp(ixo^s,
mom_c(idim)))+csoundl(ixo^s)
2460 call twofl_get_csound_n(wlp,x,ixi^l,ixo^l,csoundl)
2461 call twofl_get_csound_n(wrp,x,ixi^l,ixo^l,csoundr)
2462 csoundl(ixo^s)=max(csoundl(ixo^s),csoundr(ixo^s))
2463 if(
present(cmin))
then
2464 cmin(ixo^s,2)=min(wlp(ixo^s,
mom_n(idim)),wrp(ixo^s,
mom_n(idim)))-csoundl(ixo^s)
2465 cmax(ixo^s,2)=max(wlp(ixo^s,
mom_n(idim)),wrp(ixo^s,
mom_n(idim)))+csoundl(ixo^s)
2466 if(h_correction)
then
2467 {
do ix^db=ixomin^db,ixomax^db\}
2468 cmin(ix^d,2)=sign(one,cmin(ix^d,2))*max(abs(cmin(ix^d,1)),hspeed(ix^d,2))
2469 cmax(ix^d,2)=sign(one,cmax(ix^d,2))*max(abs(cmax(ix^d,1)),hspeed(ix^d,2))
2473 cmax(ixo^s,2)=max(wlp(ixo^s,
mom_n(idim)),wrp(ixo^s,
mom_n(idim)))+csoundl(ixo^s)
2478 end subroutine twofl_get_cbounds_species
2481 subroutine twofl_get_ct_velocity(vcts,wLp,wRp,ixI^L,ixO^L,idim,cmax,cmin)
2484 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2485 double precision,
intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
2486 double precision,
intent(in) :: cmax(ixi^s)
2487 double precision,
intent(in),
optional :: cmin(ixi^s)
2488 type(ct_velocity),
intent(inout):: vcts
2490 integer :: idime,idimn
2496 if(.not.
allocated(vcts%vnorm))
allocate(vcts%vnorm(ixi^s,1:
ndim))
2498 vcts%vnorm(ixo^s,idim)=0.5d0*(wlp(ixo^s,
mom_c(idim))+wrp(ixo^s,
mom_c(idim)))
2500 if(.not.
allocated(vcts%vbarC))
then
2501 allocate(vcts%vbarC(ixi^s,1:
ndir,2),vcts%vbarLC(ixi^s,1:
ndir,2),vcts%vbarRC(ixi^s,1:
ndir,2))
2502 allocate(vcts%cbarmin(ixi^s,1:
ndim),vcts%cbarmax(ixi^s,1:
ndim))
2505 if(
present(cmin))
then
2506 vcts%cbarmin(ixo^s,idim)=max(-cmin(ixo^s),zero)
2507 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
2509 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
2510 vcts%cbarmin(ixo^s,idim)=vcts%cbarmax(ixo^s,idim)
2513 idimn=mod(idim,
ndir)+1
2514 idime=mod(idim+1,
ndir)+1
2516 vcts%vbarLC(ixo^s,idim,1)=wlp(ixo^s,
mom_c(idimn))
2517 vcts%vbarRC(ixo^s,idim,1)=wrp(ixo^s,
mom_c(idimn))
2518 vcts%vbarC(ixo^s,idim,1)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,1) &
2519 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
2520 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
2522 vcts%vbarLC(ixo^s,idim,2)=wlp(ixo^s,
mom_c(idime))
2523 vcts%vbarRC(ixo^s,idim,2)=wrp(ixo^s,
mom_c(idime))
2524 vcts%vbarC(ixo^s,idim,2)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,2) &
2525 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
2526 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
2528 call mpistop(
'choose average, uct_contact,or uct_hll for type_ct!')
2531 end subroutine twofl_get_ct_velocity
2533 subroutine twofl_get_csound_c_idim(w,x,ixI^L,ixO^L,idim,csound)
2536 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2538 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
2539 double precision,
intent(out):: csound(ixi^s)
2540 double precision :: cfast2(ixi^s), avmincs2(ixi^s), b2(ixi^s), kmax
2541 double precision :: inv_rho(ixo^s)
2542 double precision :: tmp(ixi^s)
2543#if (!defined(ONE_FLUID) || ONE_FLUID==0) && (defined(A_TOT) && A_TOT == 1)
2544 double precision :: rhon(ixi^s)
2547#if (!defined(ONE_FLUID) || ONE_FLUID==0) && (defined(A_TOT) && A_TOT == 1)
2549 inv_rho(ixo^s) = 1d0/(rhon(ixo^s)+tmp(ixo^s))
2551 inv_rho(ixo^s)=1.d0/tmp(ixo^s)
2554 if(phys_energy)
then
2561 b2(ixo^s) = twofl_mag_en_all(w,ixi^
l,ixo^
l)
2563 cfast2(ixo^s) = b2(ixo^s) * inv_rho(ixo^s)+csound(ixo^s)
2564 avmincs2(ixo^s) = cfast2(ixo^s)**2-4.0d0*csound(ixo^s) &
2565 * twofl_mag_i_all(w,ixi^
l,ixo^
l,idim)**2 &
2568 where(avmincs2(ixo^s)<zero)
2569 avmincs2(ixo^s)=zero
2572 avmincs2(ixo^s)=sqrt(avmincs2(ixo^s))
2575 csound(ixo^s) = sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s)))
2580 kmax = dpi/min({
dxlevel(^
d)},bigdouble)*half
2581 csound(ixo^s) = max(sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s))), &
2582 twofl_etah * sqrt(b2(ixo^s))*inv_rho(ixo^s)*kmax)
2585 end subroutine twofl_get_csound_c_idim
2588 subroutine twofl_get_csound_prim(w,x,ixI^L,ixO^L,idim,csound)
2591 integer,
intent(in) :: ixi^
l, ixo^
l, idim
2592 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s,1:
ndim)
2593 double precision,
intent(out):: csound(ixi^s)
2594 double precision :: cfast2(ixi^s), avmincs2(ixi^s), b2(ixi^s), kmax
2595 double precision :: inv_rho(ixo^s)
2596 double precision :: rhoc(ixi^s)
2597#if (defined(A_TOT) && A_TOT == 1)
2598 double precision :: rhon(ixi^s)
2601#if (defined(A_TOT) && A_TOT == 1)
2603 inv_rho(ixo^s) = 1d0/(rhon(ixo^s)+rhoc(ixo^s))
2605 inv_rho(ixo^s)=1.d0/rhoc(ixo^s)
2611 b2(ixo^s) = twofl_mag_en_all(w,ixi^
l,ixo^
l)
2612 cfast2(ixo^s) = b2(ixo^s) * inv_rho(ixo^s)+csound(ixo^s)
2613 avmincs2(ixo^s) = cfast2(ixo^s)**2-4.0d0*csound(ixo^s) &
2614 * twofl_mag_i_all(w,ixi^
l,ixo^
l,idim)**2 &
2617 where(avmincs2(ixo^s)<zero)
2618 avmincs2(ixo^s)=zero
2621 avmincs2(ixo^s)=sqrt(avmincs2(ixo^s))
2624 csound(ixo^s) = sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s)))
2629 kmax = dpi/min({
dxlevel(^
d)},bigdouble)*half
2630 csound(ixo^s) = max(sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s))), &
2631 twofl_etah * sqrt(b2(ixo^s))*inv_rho(ixo^s)*kmax)
2638 integer,
intent(in) :: ixI^L, ixO^L
2639 double precision,
intent(in) :: w(ixI^S,nw)
2640 double precision,
intent(in) :: x(ixI^S,1:ndim)
2641 double precision,
intent(out) :: csound2(ixI^S)
2642 double precision :: pth_c(ixI^S)
2643 double precision :: pth_n(ixI^S)
2645 if(phys_energy)
then
2646 call twofl_get_pthermal_c_primitive(w,x,ixi^l,ixo^l,pth_c)
2647 call twofl_get_pthermal_n_primitive(w,x,ixi^l,ixo^l,pth_n)
2648 call twofl_get_csound2_from_pthermal(w,x,ixi^l,ixo^l,pth_c,pth_n,csound2)
2650 call twofl_get_csound2_adiab(w,x,ixi^l,ixo^l,csound2)
2654 end subroutine twofl_get_csound_prim
2656 subroutine twofl_get_csound2(w,x,ixI^L,ixO^L,csound2)
2658 integer,
intent(in) :: ixI^L, ixO^L
2659 double precision,
intent(in) :: w(ixI^S,nw)
2660 double precision,
intent(in) :: x(ixI^S,1:ndim)
2661 double precision,
intent(out) :: csound2(ixI^S)
2662 double precision :: pth_c(ixI^S)
2663 double precision :: pth_n(ixI^S)
2665 if(phys_energy)
then
2668 call twofl_get_csound2_from_pthermal(w,x,ixi^l,ixo^l,pth_c,pth_n,csound2)
2670 call twofl_get_csound2_adiab(w,x,ixi^l,ixo^l,csound2)
2672 end subroutine twofl_get_csound2
2674 subroutine twofl_get_csound2_adiab(w,x,ixI^L,ixO^L,csound2)
2676 integer,
intent(in) :: ixI^L, ixO^L
2677 double precision,
intent(in) :: w(ixI^S,nw)
2678 double precision,
intent(in) :: x(ixI^S,1:ndim)
2679 double precision,
intent(out) :: csound2(ixI^S)
2680 double precision :: rhoc(ixI^S)
2681 double precision :: rhon(ixI^S)
2687 rhon(ixo^s)**gamma_1,rhoc(ixo^s)**gamma_1)
2688 end subroutine twofl_get_csound2_adiab
2690 subroutine twofl_get_csound(w,x,ixI^L,ixO^L,idim,csound)
2693 integer,
intent(in) :: ixI^L, ixO^L, idim
2694 double precision,
intent(in) :: w(ixI^S, nw), x(ixI^S,1:ndim)
2695 double precision,
intent(out):: csound(ixI^S)
2696 double precision :: cfast2(ixI^S), AvMinCs2(ixI^S), b2(ixI^S), kmax
2697 double precision :: inv_rho(ixO^S)
2698 double precision :: rhoc(ixI^S)
2699#if (defined(A_TOT) && A_TOT == 1)
2700 double precision :: rhon(ixI^S)
2703#if (defined(A_TOT) && A_TOT == 1)
2705 inv_rho(ixo^s) = 1d0/(rhon(ixo^s)+rhoc(ixo^s))
2707 inv_rho(ixo^s)=1.d0/rhoc(ixo^s)
2710 call twofl_get_csound2(w,x,ixi^l,ixo^l,csound)
2713 b2(ixo^s) = twofl_mag_en_all(w,ixi^l,ixo^l)
2715 cfast2(ixo^s) = b2(ixo^s) * inv_rho(ixo^s)+csound(ixo^s)
2716 avmincs2(ixo^s) = cfast2(ixo^s)**2-4.0d0*csound(ixo^s) &
2717 * twofl_mag_i_all(w,ixi^l,ixo^l,idim)**2 &
2720 where(avmincs2(ixo^s)<zero)
2721 avmincs2(ixo^s)=zero
2724 avmincs2(ixo^s)=sqrt(avmincs2(ixo^s))
2727 csound(ixo^s) = sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s)))
2732 kmax = dpi/min({
dxlevel(^
d)},bigdouble)*half
2733 csound(ixo^s) = max(sqrt(half*(cfast2(ixo^s)+avmincs2(ixo^s))), &
2734 twofl_etah * sqrt(b2(ixo^s))*inv_rho(ixo^s)*kmax)
2737 end subroutine twofl_get_csound
2739 subroutine twofl_get_csound2_from_pthermal(w,x,ixI^L,ixO^L,pth_c,pth_n,csound2)
2741 integer,
intent(in) :: ixI^L, ixO^L
2742 double precision,
intent(in) :: w(ixI^S,nw)
2743 double precision,
intent(in) :: x(ixI^S,1:ndim)
2744 double precision,
intent(in) :: pth_c(ixI^S)
2745 double precision,
intent(in) :: pth_n(ixI^S)
2746 double precision,
intent(out) :: csound2(ixI^S)
2747 double precision :: csound1(ixI^S),rhon(ixI^S),rhoc(ixI^S)
2751#if !defined(C_TOT) || C_TOT == 0
2752 csound2(ixo^s)=
twofl_gamma*max((pth_c(ixo^s) + pth_n(ixo^s))/(rhoc(ixo^s) + rhon(ixo^s)),&
2753 pth_n(ixo^s)/rhon(ixo^s), pth_c(ixo^s)/rhoc(ixo^s))
2755 csound2(ixo^s)=
twofl_gamma*(csound2(ixo^s) + csound1(ixo^s))/(rhoc(ixo^s) + rhon(ixo^s))
2758 end subroutine twofl_get_csound2_from_pthermal
2762 subroutine twofl_get_csound_n(w,x,ixI^L,ixO^L,csound)
2765 integer,
intent(in) :: ixI^L, ixO^L
2766 double precision,
intent(in) :: w(ixI^S, nw), x(ixI^S,1:ndim)
2767 double precision,
intent(out):: csound(ixI^S)
2768 double precision :: pe_n1(ixI^S)
2769 call twofl_get_csound2_n_from_conserved(w,x,ixi^l,ixo^l,csound)
2770 csound(ixo^s) = sqrt(csound(ixo^s))
2771 end subroutine twofl_get_csound_n
2775 subroutine twofl_get_temperature_from_eint_n(w, x, ixI^L, ixO^L, res)
2777 integer,
intent(in) :: ixI^L, ixO^L
2778 double precision,
intent(in) :: w(ixI^S, 1:nw)
2779 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2780 double precision,
intent(out):: res(ixI^S)
2782 res(ixo^s) = 1d0/
rn * gamma_1 * w(ixo^s,
e_n_) /w(ixo^s,
rho_n_)
2784 end subroutine twofl_get_temperature_from_eint_n
2786 subroutine twofl_get_temperature_from_eint_n_with_equi(w, x, ixI^L, ixO^L, res)
2788 integer,
intent(in) :: ixI^L, ixO^L
2789 double precision,
intent(in) :: w(ixI^S, 1:nw)
2790 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2791 double precision,
intent(out):: res(ixI^S)
2795 end subroutine twofl_get_temperature_from_eint_n_with_equi
2806 subroutine twofl_get_temperature_n_equi(w,x, ixI^L, ixO^L, res)
2808 integer,
intent(in) :: ixI^L, ixO^L
2809 double precision,
intent(in) :: w(ixI^S, 1:nw)
2810 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2811 double precision,
intent(out):: res(ixI^S)
2812 res(ixo^s) = 1d0/
rn * &
2814 end subroutine twofl_get_temperature_n_equi
2816 subroutine twofl_get_rho_n_equi(w, x,ixI^L, ixO^L, res)
2818 integer,
intent(in) :: ixI^L, ixO^L
2819 double precision,
intent(in) :: w(ixI^S, 1:nw)
2820 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2821 double precision,
intent(out):: res(ixI^S)
2823 end subroutine twofl_get_rho_n_equi
2825 subroutine twofl_get_pe_n_equi(w, x, ixI^L, ixO^L, res)
2827 integer,
intent(in) :: ixI^L, ixO^L
2828 double precision,
intent(in) :: w(ixI^S, 1:nw)
2829 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2830 double precision,
intent(out):: res(ixI^S)
2832 end subroutine twofl_get_pe_n_equi
2838 subroutine twofl_get_temperature_from_etot_n(w, x, ixI^L, ixO^L, res)
2840 integer,
intent(in) :: ixI^L, ixO^L
2841 double precision,
intent(in) :: w(ixI^S, 1:nw)
2842 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2843 double precision,
intent(out):: res(ixI^S)
2844 res(ixo^s)=1d0/
rn * (gamma_1*(w(ixo^s,
e_n_)&
2845 - twofl_kin_en_n(w,ixi^l,ixo^l)))/w(ixo^s,
rho_n_)
2846 end subroutine twofl_get_temperature_from_etot_n
2848 subroutine twofl_get_temperature_from_etot_n_with_equi(w, x, ixI^L, ixO^L, res)
2850 integer,
intent(in) :: ixI^L, ixO^L
2851 double precision,
intent(in) :: w(ixI^S, 1:nw)
2852 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2853 double precision,
intent(out):: res(ixI^S)
2854 res(ixo^s)=1d0/
rn * (gamma_1*(w(ixo^s,
e_n_)&
2858 end subroutine twofl_get_temperature_from_etot_n_with_equi
2862 subroutine twofl_get_temperature_from_eint_c(w, x, ixI^L, ixO^L, res)
2864 integer,
intent(in) :: ixI^L, ixO^L
2865 double precision,
intent(in) :: w(ixI^S, 1:nw)
2866 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2867 double precision,
intent(out):: res(ixI^S)
2869 res(ixo^s) = 1d0/
rc * gamma_1 * w(ixo^s,
e_c_) /w(ixo^s,
rho_c_)
2871 end subroutine twofl_get_temperature_from_eint_c
2873 subroutine twofl_get_temperature_from_eint_c_with_equi(w, x, ixI^L, ixO^L, res)
2875 integer,
intent(in) :: ixI^L, ixO^L
2876 double precision,
intent(in) :: w(ixI^S, 1:nw)
2877 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2878 double precision,
intent(out):: res(ixI^S)
2881 end subroutine twofl_get_temperature_from_eint_c_with_equi
2892 subroutine twofl_get_temperature_c_equi(w,x, ixI^L, ixO^L, res)
2894 integer,
intent(in) :: ixI^L, ixO^L
2895 double precision,
intent(in) :: w(ixI^S, 1:nw)
2896 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2897 double precision,
intent(out):: res(ixI^S)
2898 res(ixo^s) = 1d0/
rc * &
2900 end subroutine twofl_get_temperature_c_equi
2902 subroutine twofl_get_rho_c_equi(w, x, ixI^L, ixO^L, res)
2904 integer,
intent(in) :: ixI^L, ixO^L
2905 double precision,
intent(in) :: w(ixI^S, 1:nw)
2906 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2907 double precision,
intent(out):: res(ixI^S)
2909 end subroutine twofl_get_rho_c_equi
2911 subroutine twofl_get_pe_c_equi(w,x, ixI^L, ixO^L, res)
2913 integer,
intent(in) :: ixI^L, ixO^L
2914 double precision,
intent(in) :: w(ixI^S, 1:nw)
2915 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2916 double precision,
intent(out):: res(ixI^S)
2918 end subroutine twofl_get_pe_c_equi
2924 subroutine twofl_get_temperature_from_etot_c(w, x, ixI^L, ixO^L, res)
2926 integer,
intent(in) :: ixI^L, ixO^L
2927 double precision,
intent(in) :: w(ixI^S, 1:nw)
2928 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2929 double precision,
intent(out):: res(ixI^S)
2930 res(ixo^s)=1d0/
rc * (gamma_1*(w(ixo^s,
e_c_)&
2931 - twofl_kin_en_c(w,ixi^l,ixo^l)&
2932 - twofl_mag_en(w,ixi^l,ixo^l)))/w(ixo^s,
rho_c_)
2933 end subroutine twofl_get_temperature_from_etot_c
2934 subroutine twofl_get_temperature_from_eki_c(w, x, ixI^L, ixO^L, res)
2936 integer,
intent(in) :: ixI^L, ixO^L
2937 double precision,
intent(in) :: w(ixI^S, 1:nw)
2938 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2939 double precision,
intent(out):: res(ixI^S)
2940 res(ixo^s)=1d0/
rc * (gamma_1*(w(ixo^s,
e_c_)&
2941 - twofl_kin_en_c(w,ixi^l,ixo^l)))/w(ixo^s,
rho_c_)
2942 end subroutine twofl_get_temperature_from_eki_c
2944 subroutine twofl_get_temperature_from_etot_c_with_equi(w, x, ixI^L, ixO^L, res)
2946 integer,
intent(in) :: ixI^L, ixO^L
2947 double precision,
intent(in) :: w(ixI^S, 1:nw)
2948 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2949 double precision,
intent(out):: res(ixI^S)
2950 res(ixo^s)=1d0/
rc * (gamma_1*(w(ixo^s,
e_c_)&
2951 - twofl_kin_en_c(w,ixi^l,ixo^l)&
2955 end subroutine twofl_get_temperature_from_etot_c_with_equi
2957 subroutine twofl_get_temperature_from_eki_c_with_equi(w, x, ixI^L, ixO^L, res)
2959 integer,
intent(in) :: ixI^L, ixO^L
2960 double precision,
intent(in) :: w(ixI^S, 1:nw)
2961 double precision,
intent(in) :: x(ixI^S, 1:ndim)
2962 double precision,
intent(out):: res(ixI^S)
2963 res(ixo^s)=1d0/
rc * (gamma_1*(w(ixo^s,
e_c_)&
2967 end subroutine twofl_get_temperature_from_eki_c_with_equi
2969 subroutine twofl_get_csound2_adiab_n(w,x,ixI^L,ixO^L,csound2)
2971 integer,
intent(in) :: ixI^L, ixO^L
2972 double precision,
intent(in) :: w(ixI^S,nw)
2973 double precision,
intent(in) :: x(ixI^S,1:ndim)
2974 double precision,
intent(out) :: csound2(ixI^S)
2975 double precision :: rhon(ixI^S)
2980 end subroutine twofl_get_csound2_adiab_n
2982 subroutine twofl_get_csound2_n_from_conserved(w,x,ixI^L,ixO^L,csound2)
2984 integer,
intent(in) :: ixI^L, ixO^L
2985 double precision,
intent(in) :: w(ixI^S,nw)
2986 double precision,
intent(in) :: x(ixI^S,1:ndim)
2987 double precision,
intent(out) :: csound2(ixI^S)
2988 double precision :: rhon(ixI^S)
2990 if(phys_energy)
then
2993 csound2(ixo^s)=
twofl_gamma*csound2(ixo^s)/rhon(ixo^s)
2995 call twofl_get_csound2_adiab_n(w,x,ixi^l,ixo^l,csound2)
2997 end subroutine twofl_get_csound2_n_from_conserved
3000 subroutine twofl_get_csound2_n_from_primitive(w,x,ixI^L,ixO^L,csound2)
3002 integer,
intent(in) :: ixI^L, ixO^L
3003 double precision,
intent(in) :: w(ixI^S,nw)
3004 double precision,
intent(in) :: x(ixI^S,1:ndim)
3005 double precision,
intent(out) :: csound2(ixI^S)
3006 double precision :: rhon(ixI^S)
3008 if(phys_energy)
then
3010 call twofl_get_pthermal_n_primitive(w,x,ixi^l,ixo^l,csound2)
3011 csound2(ixo^s)=
twofl_gamma*csound2(ixo^s)/rhon(ixo^s)
3013 call twofl_get_csound2_adiab_n(w,x,ixi^l,ixo^l,csound2)
3015 end subroutine twofl_get_csound2_n_from_primitive
3017 subroutine twofl_get_csound2_adiab_c(w,x,ixI^L,ixO^L,csound2)
3019 integer,
intent(in) :: ixI^L, ixO^L
3020 double precision,
intent(in) :: w(ixI^S,nw)
3021 double precision,
intent(in) :: x(ixI^S,1:ndim)
3022 double precision,
intent(out) :: csound2(ixI^S)
3023 double precision :: rhoc(ixI^S)
3028 end subroutine twofl_get_csound2_adiab_c
3032 integer,
intent(in) :: ixi^
l, ixo^
l
3033 double precision,
intent(in) :: w(ixi^s,nw)
3034 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3035 double precision,
intent(out) :: csound2(ixi^s)
3036 double precision :: rhoc(ixi^s)
3038 if(phys_energy)
then
3041 csound2(ixo^s)=
twofl_gamma*csound2(ixo^s)/rhoc(ixo^s)
3043 call twofl_get_csound2_adiab_c(w,x,ixi^
l,ixo^
l,csound2)
3048 subroutine twofl_get_flux(wC,w,x,ixI^L,ixO^L,idim,f)
3052 integer,
intent(in) :: ixi^
l, ixo^
l, idim
3054 double precision,
intent(in) :: wc(ixi^s,nw)
3056 double precision,
intent(in) :: w(ixi^s,nw)
3057 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3058 double precision,
intent(out) :: f(ixi^s,nwflux)
3060 double precision :: pgas(ixo^s), ptotal(ixo^s),tmp(ixi^s)
3061 double precision,
allocatable:: vhall(:^
d&,:)
3062 integer :: idirmin, iw, idir, jdir, kdir
3071 if(phys_energy)
then
3072 pgas(ixo^s)=w(ixo^s,
e_c_)
3081 allocate(vhall(ixi^s,1:
ndir))
3082 call twofl_getv_hall(w,x,ixi^
l,ixo^
l,vhall)
3085 if(
b0field) tmp(ixo^s)=sum(
block%B0(ixo^s,:,idim)*w(ixo^s,mag(:)),dim=
ndim+1)
3087 ptotal(ixo^s) = pgas(ixo^s) + 0.5d0*sum(w(ixo^s, mag(:))**2, dim=
ndim+1)
3093 f(ixo^s,
mom_c(idir))=ptotal(ixo^s)-w(ixo^s,mag(idim))*w(ixo^s,mag(idir))
3096 f(ixo^s,
mom_c(idir))= -w(ixo^s,mag(idir))*w(ixo^s,mag(idim))
3100 -w(ixo^s,mag(idir))*
block%B0(ixo^s,idim,idim)&
3101 -w(ixo^s,mag(idim))*
block%B0(ixo^s,idir,idim)
3108 if(phys_energy)
then
3109 if (phys_internal_e)
then
3113 f(ixo^s,
e_c_)=w(ixo^s,
mom_c(idim))*(wc(ixo^s,
e_c_)+pgas(ixo^s))
3115 f(ixo^s,
e_c_)=w(ixo^s,
mom_c(idim))*(wc(ixo^s,
e_c_)+ptotal(ixo^s))&
3116 -w(ixo^s,mag(idim))*sum(w(ixo^s,mag(:))*w(ixo^s,
mom_c(:)),dim=
ndim+1)
3120 + w(ixo^s,
mom_c(idim)) * tmp(ixo^s) &
3121 - sum(w(ixo^s,
mom_c(:))*w(ixo^s,mag(:)),dim=
ndim+1) *
block%B0(ixo^s,idim,idim)
3127 f(ixo^s,
e_c_) = f(ixo^s,
e_c_) + vhall(ixo^s,idim) * &
3128 sum(w(ixo^s, mag(:))**2,dim=
ndim+1) &
3129 - w(ixo^s,mag(idim)) * sum(vhall(ixo^s,:)*w(ixo^s,mag(:)),dim=
ndim+1)
3132 + vhall(ixo^s,idim) * tmp(ixo^s) &
3133 - sum(vhall(ixo^s,:)*w(ixo^s,mag(:)),dim=
ndim+1) *
block%B0(ixo^s,idim,idim)
3140#if !defined(E_RM_W0) || E_RM_W0 == 1
3144 if(phys_internal_e)
then
3158 if (idim==idir)
then
3161 f(ixo^s,mag(idir))=w(ixo^s,
psi_)
3163 f(ixo^s,mag(idir))=zero
3166 f(ixo^s,mag(idir))=w(ixo^s,
mom_c(idim))*w(ixo^s,mag(idir))-w(ixo^s,mag(idim))*w(ixo^s,
mom_c(idir))
3169 f(ixo^s,mag(idir))=f(ixo^s,mag(idir))&
3170 +w(ixo^s,
mom_c(idim))*
block%B0(ixo^s,idir,idim)&
3171 -w(ixo^s,
mom_c(idir))*
block%B0(ixo^s,idim,idim)
3178 f(ixo^s,mag(idir)) = f(ixo^s,mag(idir)) &
3179 - vhall(ixo^s,idir)*(w(ixo^s,mag(idim))+
block%B0(ixo^s,idim,idim)) &
3180 + vhall(ixo^s,idim)*(w(ixo^s,mag(idir))+
block%B0(ixo^s,idir,idim))
3182 f(ixo^s,mag(idir)) = f(ixo^s,mag(idir)) &
3183 - vhall(ixo^s,idir)*w(ixo^s,mag(idim)) &
3184 + vhall(ixo^s,idim)*w(ixo^s,mag(idir))
3204 if(phys_energy)
then
3205 pgas(ixo^s) = w(ixo^s,
e_n_)
3223 f(ixo^s,
mom_n(idim)) = f(ixo^s,
mom_n(idim)) + pgas(ixo^s)
3225 if(phys_energy)
then
3227 pgas(ixo^s) = wc(ixo^s,
e_n_)
3228 if(.not. phys_internal_e)
then
3230 pgas(ixo^s) = pgas(ixo^s) + w(ixo^s,
e_n_)
3234#if !defined(E_RM_W0) || E_RM_W0 == 1
3235 pgas(ixo^s) = pgas(ixo^s) +
block%equi_vars(ixo^s,
equi_pe_n0_,idim) * inv_gamma_1
3241 f(ixo^s,
e_n_) = w(ixo^s,
mom_n(idim)) * pgas(ixo^s)
3249 end subroutine twofl_get_flux
3252 subroutine twofl_add_source(qdt,dtfactor,ixI^L,ixO^L,wCT,wCTprim,w,x,qsourcesplit,active)
3258 integer,
intent(in) :: ixi^
l, ixo^
l
3259 double precision,
intent(in) :: qdt,dtfactor
3260 double precision,
intent(in) :: wct(ixi^s,1:nw),wctprim(ixi^s,1:nw),x(ixi^s,1:
ndim)
3261 double precision,
intent(inout) :: w(ixi^s,1:nw)
3262 logical,
intent(in) :: qsourcesplit
3263 logical,
intent(inout) :: active
3265 if (.not. qsourcesplit)
then
3267 if(phys_internal_e)
then
3269 call internal_energy_add_source_n(qdt,ixi^
l,ixo^
l,wct,w,x)
3270 call internal_energy_add_source_c(qdt,ixi^
l,ixo^
l,wct,w,x,
e_c_)
3272#if !defined(E_RM_W0) || E_RM_W0==1
3276 call add_pe_n0_divv(qdt,ixi^
l,ixo^
l,wct,w,x)
3280 call add_pe_c0_divv(qdt,ixi^
l,ixo^
l,wct,w,x)
3285 call add_source_lorentz_work(qdt,ixi^
l,ixo^
l,w,wct,x)
3292 call add_source_b0split(qdt,ixi^
l,ixo^
l,wct,w,x)
3298 call add_source_res2(qdt,ixi^
l,ixo^
l,wct,w,x)
3303 call add_source_hyperres(qdt,ixi^
l,ixo^
l,wct,w,x)
3308 call twofl_explicit_coll_terms_update(qdt,ixi^
l,ixo^
l,w,wct,x)
3313 call add_source_hyperdiffusive(qdt,ixi^
l,ixo^
l,w,wct,x)
3321 select case (type_divb)
3326 call add_source_glm(qdt,ixi^
l,ixo^
l,wct,w,x)
3329 call add_source_powel(qdt,ixi^
l,ixo^
l,wct,w,x)
3330 case (divb_janhunen)
3332 call add_source_janhunen(qdt,ixi^
l,ixo^
l,wct,w,x)
3335 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
3336 case (divb_lindejanhunen)
3338 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
3339 call add_source_janhunen(qdt,ixi^
l,ixo^
l,wct,w,x)
3340 case (divb_lindepowel)
3342 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
3343 call add_source_powel(qdt,ixi^
l,ixo^
l,wct,w,x)
3344 case (divb_lindeglm)
3346 call add_source_linde(qdt,ixi^
l,ixo^
l,wct,w,x)
3347 call add_source_glm(qdt,ixi^
l,ixo^
l,wct,w,x)
3350 case (divb_multigrid)
3353 call mpistop(
'Unknown divB fix')
3360 w,x,qsourcesplit,active,
rc_fl_c)
3364 w,x,qsourcesplit,active,rc_fl_n)
3373 call gravity_add_source(qdt,ixi^
l,ixo^
l,wct,&
3377 end subroutine twofl_add_source
3379 subroutine add_pe_n0_divv(qdt,ixI^L,ixO^L,wCT,w,x)
3383 integer,
intent(in) :: ixi^
l, ixo^
l
3384 double precision,
intent(in) :: qdt
3385 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3386 double precision,
intent(inout) :: w(ixi^s,1:nw)
3387 double precision :: v(ixi^s,1:
ndir)
3389 call twofl_get_v_n(wct,x,ixi^
l,ixi^
l,v)
3392 end subroutine add_pe_n0_divv
3394 subroutine add_pe_c0_divv(qdt,ixI^L,ixO^L,wCT,w,x)
3398 integer,
intent(in) :: ixi^
l, ixo^
l
3399 double precision,
intent(in) :: qdt
3400 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3401 double precision,
intent(inout) :: w(ixi^s,1:nw)
3402 double precision :: v(ixi^s,1:
ndir)
3404 call twofl_get_v_c(wct,x,ixi^
l,ixi^
l,v)
3407 end subroutine add_pe_c0_divv
3409 subroutine add_geom_pdivv(qdt,ixI^L,ixO^L,v,p,w,x,ind)
3412 integer,
intent(in) :: ixi^
l, ixo^
l,ind
3413 double precision,
intent(in) :: qdt
3414 double precision,
intent(in) :: p(ixi^s), v(ixi^s,1:
ndir), x(ixi^s,1:
ndim)
3415 double precision,
intent(inout) :: w(ixi^s,1:nw)
3416 double precision :: divv(ixi^s)
3427 w(ixo^s,ind)=w(ixo^s,ind)+qdt*p(ixo^s)*divv(ixo^s)
3428 end subroutine add_geom_pdivv
3431 subroutine get_lorentz(ixI^L,ixO^L,w,JxB)
3433 integer,
intent(in) :: ixi^
l, ixo^
l
3434 double precision,
intent(in) :: w(ixi^s,1:nw)
3435 double precision,
intent(inout) :: jxb(ixi^s,3)
3436 double precision :: a(ixi^s,3), b(ixi^s,3), tmp(ixi^s,3)
3437 integer :: idir, idirmin
3439 double precision :: current(ixi^s,7-2*
ndir:3)
3443 b(ixo^s, idir) = twofl_mag_i_all(w, ixi^
l, ixo^
l,idir)
3451 a(ixo^s,idir)=current(ixo^s,idir)
3455 end subroutine get_lorentz
3457 subroutine add_source_lorentz_work(qdt,ixI^L,ixO^L,w,wCT,x)
3459 integer,
intent(in) :: ixi^
l, ixo^
l
3460 double precision,
intent(in) :: qdt
3461 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3462 double precision,
intent(inout) :: w(ixi^s,1:nw)
3463 double precision :: a(ixi^s,3), b(ixi^s,1:
ndir)
3465 call get_lorentz(ixi^
l, ixo^
l,wct,a)
3466 call twofl_get_v_c(wct,x,ixi^
l,ixo^
l,b)
3469 end subroutine add_source_lorentz_work
3472 subroutine twofl_get_v_n(w,x,ixI^L,ixO^L,v)
3475 integer,
intent(in) :: ixi^
l, ixo^
l
3476 double precision,
intent(in) :: w(ixi^s,nw), x(ixi^s,1:
ndim)
3477 double precision,
intent(out) :: v(ixi^s,
ndir)
3478 double precision :: rhon(ixi^s)
3484 v(ixo^s,idir) = w(ixo^s,
mom_n(idir)) / rhon(ixo^s)
3487 end subroutine twofl_get_v_n
3491 integer,
intent(in) :: ixi^
l, ixo^
l
3492 double precision,
intent(in) :: w(ixi^s,1:nw), x(ixi^s,1:
ndim)
3493 double precision,
intent(out) :: rhon(ixi^s)
3497 rhon(ixo^s) = w(ixo^s,
rho_n_)
3505 integer,
intent(in) :: ixi^
l, ixo^
l
3506 double precision,
intent(in) :: w(ixi^s,1:nw)
3507 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3508 double precision,
intent(out) :: pth(ixi^s)
3512 if(phys_energy)
then
3513 if(phys_internal_e)
then
3514 pth(ixo^s)=gamma_1*w(ixo^s,
e_n_)
3516 pth(ixo^s)=gamma_1*(w(ixo^s,
e_n_)&
3517 - twofl_kin_en_n(w,ixi^
l,ixo^
l))
3528 {
do ix^db= ixo^lim^db\}
3534 {
do ix^db= ixo^lim^db\}
3536 write(*,*)
"Error: small value of gas pressure",pth(ix^
d),&
3537 " encountered when call twofl_get_pthermal_n"
3539 write(*,*)
"Location: ", x(ix^
d,:)
3540 write(*,*)
"Cell number: ", ix^
d
3542 write(*,*) trim(cons_wnames(iw)),
": ",w(ix^
d,iw)
3546 write(*,*)
"Saving status at the previous time step"
3554 subroutine twofl_get_pthermal_n_primitive(w,x,ixI^L,ixO^L,pth)
3556 integer,
intent(in) :: ixi^
l, ixo^
l
3557 double precision,
intent(in) :: w(ixi^s,1:nw)
3558 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3559 double precision,
intent(out) :: pth(ixi^s)
3561 if(phys_energy)
then
3565 pth(ixo^s) = w(ixo^s,
e_n_)
3571 end subroutine twofl_get_pthermal_n_primitive
3577 integer,
intent(in) :: ixi^
l, ixo^
l, idim
3578 double precision,
intent(in) :: w(ixi^s,nw), x(ixi^s,1:
ndim)
3579 double precision,
intent(out) :: v(ixi^s)
3580 double precision :: rhon(ixi^s)
3583 v(ixo^s) = w(ixo^s,
mom_n(idim)) / rhon(ixo^s)
3587 subroutine internal_energy_add_source_n(qdt,ixI^L,ixO^L,wCT,w,x)
3591 integer,
intent(in) :: ixi^
l, ixo^
l
3592 double precision,
intent(in) :: qdt
3593 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3594 double precision,
intent(inout) :: w(ixi^s,1:nw)
3595 double precision :: pth(ixi^s),v(ixi^s,1:
ndir),divv(ixi^s)
3598 call twofl_get_v_n(wct,x,ixi^
l,ixi^
l,v)
3599 call add_geom_pdivv(qdt,ixi^
l,ixo^
l,v,-pth,w,x,
e_n_)
3602 call twofl_handle_small_ei_n(w,x,ixi^
l,ixo^
l,
e_n_,
'internal_energy_add_source')
3604 end subroutine internal_energy_add_source_n
3607 subroutine twofl_get_v_c(w,x,ixI^L,ixO^L,v)
3610 integer,
intent(in) :: ixi^
l, ixo^
l
3611 double precision,
intent(in) :: w(ixi^s,nw), x(ixi^s,1:
ndim)
3612 double precision,
intent(out) :: v(ixi^s,
ndir)
3613 double precision :: rhoc(ixi^s)
3618 v(ixo^s,idir) = w(ixo^s,
mom_c(idir)) / rhoc(ixo^s)
3621 end subroutine twofl_get_v_c
3625 integer,
intent(in) :: ixi^
l, ixo^
l
3626 double precision,
intent(in) :: w(ixi^s,1:nw), x(ixi^s,1:
ndim)
3627 double precision,
intent(out) :: rhoc(ixi^s)
3631 rhoc(ixo^s) = w(ixo^s,
rho_c_)
3639 integer,
intent(in) :: ixi^
l, ixo^
l
3640 double precision,
intent(in) :: w(ixi^s,1:nw)
3641 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3642 double precision,
intent(out) :: pth(ixi^s)
3645 if(phys_energy)
then
3646 if(phys_internal_e)
then
3647 pth(ixo^s)=gamma_1*w(ixo^s,
e_c_)
3648 elseif(phys_total_energy)
then
3649 pth(ixo^s)=gamma_1*(w(ixo^s,
e_c_)&
3650 - twofl_kin_en_c(w,ixi^
l,ixo^
l)&
3651 - twofl_mag_en(w,ixi^
l,ixo^
l))
3653 pth(ixo^s)=gamma_1*(w(ixo^s,
e_c_)&
3654 - twofl_kin_en_c(w,ixi^
l,ixo^
l))
3665 {
do ix^db= ixo^lim^db\}
3671 {
do ix^db= ixo^lim^db\}
3673 write(*,*)
"Error: small value of gas pressure",pth(ix^
d),&
3674 " encountered when call twofl_get_pe_c1"
3676 write(*,*)
"Location: ", x(ix^
d,:)
3677 write(*,*)
"Cell number: ", ix^
d
3679 write(*,*) trim(cons_wnames(iw)),
": ",w(ix^
d,iw)
3683 write(*,*)
"Saving status at the previous time step"
3691 subroutine twofl_get_pthermal_c_primitive(w,x,ixI^L,ixO^L,pth)
3693 integer,
intent(in) :: ixi^
l, ixo^
l
3694 double precision,
intent(in) :: w(ixi^s,1:nw)
3695 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3696 double precision,
intent(out) :: pth(ixi^s)
3698 if(phys_energy)
then
3702 pth(ixo^s) = w(ixo^s,
e_c_)
3708 end subroutine twofl_get_pthermal_c_primitive
3714 integer,
intent(in) :: ixi^
l, ixo^
l, idim
3715 double precision,
intent(in) :: w(ixi^s,nw), x(ixi^s,1:
ndim)
3716 double precision,
intent(out) :: v(ixi^s)
3717 double precision :: rhoc(ixi^s)
3720 v(ixo^s) = w(ixo^s,
mom_c(idim)) / rhoc(ixo^s)
3724 subroutine internal_energy_add_source_c(qdt,ixI^L,ixO^L,wCT,w,x,ie)
3728 integer,
intent(in) :: ixi^
l, ixo^
l,ie
3729 double precision,
intent(in) :: qdt
3730 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3731 double precision,
intent(inout) :: w(ixi^s,1:nw)
3732 double precision :: pth(ixi^s),v(ixi^s,1:
ndir),divv(ixi^s)
3735 call twofl_get_v_c(wct,x,ixi^
l,ixi^
l,v)
3736 call add_geom_pdivv(qdt,ixi^
l,ixo^
l,v,-pth,w,x,ie)
3738 call twofl_handle_small_ei_c(w,x,ixi^
l,ixo^
l,ie,
'internal_energy_add_source')
3740 end subroutine internal_energy_add_source_c
3743 subroutine twofl_handle_small_ei_c(w, x, ixI^L, ixO^L, ie, subname)
3746 integer,
intent(in) :: ixi^
l,ixo^
l, ie
3747 double precision,
intent(inout) :: w(ixi^s,1:nw)
3748 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3749 character(len=*),
intent(in) :: subname
3752 logical :: flag(ixi^s,1:nw)
3753 double precision :: rhoc(ixi^s)
3754 double precision :: rhon(ixi^s)
3758 where(w(ixo^s,ie)+
block%equi_vars(ixo^s,
equi_pe_c0_,0)*inv_gamma_1<small_e)&
3759 flag(ixo^s,ie)=.true.
3761 where(w(ixo^s,ie)<small_e) flag(ixo^s,ie)=.true.
3763 if(any(flag(ixo^s,ie)))
then
3767 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e - &
3770 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e
3778 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*gamma_1
3780 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*gamma_1
3783 w(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir))/rhon(ixo^s)
3784 w(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir))/rhoc(ixo^s)
3790 end subroutine twofl_handle_small_ei_c
3793 subroutine twofl_handle_small_ei_n(w, x, ixI^L, ixO^L, ie, subname)
3796 integer,
intent(in) :: ixi^
l,ixo^
l, ie
3797 double precision,
intent(inout) :: w(ixi^s,1:nw)
3798 double precision,
intent(in) :: x(ixi^s,1:
ndim)
3799 character(len=*),
intent(in) :: subname
3802 logical :: flag(ixi^s,1:nw)
3803 double precision :: rhoc(ixi^s)
3804 double precision :: rhon(ixi^s)
3808 where(w(ixo^s,ie)+
block%equi_vars(ixo^s,
equi_pe_n0_,0)*inv_gamma_1<small_e)&
3809 flag(ixo^s,ie)=.true.
3811 where(w(ixo^s,ie)<small_e) flag(ixo^s,ie)=.true.
3813 if(any(flag(ixo^s,ie)))
then
3817 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e - &
3820 where(flag(ixo^s,ie)) w(ixo^s,ie)=small_e
3826 w(ixo^s,
e_n_)=w(ixo^s,
e_n_)*gamma_1
3828 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)*gamma_1
3831 w(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir))/rhon(ixo^s)
3832 w(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir))/rhoc(ixo^s)
3838 end subroutine twofl_handle_small_ei_n
3841 subroutine add_source_b0split(qdt,ixI^L,ixO^L,wCT,w,x)
3844 integer,
intent(in) :: ixi^
l, ixo^
l
3845 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3846 double precision,
intent(inout) :: w(ixi^s,1:nw)
3848 double precision :: a(ixi^s,3), b(ixi^s,3), axb(ixi^s,3)
3860 a(ixo^s,idir)=
block%J0(ixo^s,idir)
3863 axb(ixo^s,:)=axb(ixo^s,:)*qdt
3868 if(phys_total_energy)
then
3871 b(ixo^s,:)=wct(ixo^s,mag(:))
3879 axb(ixo^s,:)=axb(ixo^s,:)*qdt
3882 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)-axb(ixo^s,idir)*
block%J0(ixo^s,idir)
3886 if (
fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_B0')
3888 end subroutine add_source_b0split
3894 subroutine add_source_res1(qdt,ixI^L,ixO^L,wCT,w,x)
3899 integer,
intent(in) :: ixi^
l, ixo^
l
3900 double precision,
intent(in) :: qdt
3901 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
3902 double precision,
intent(inout) :: w(ixi^s,1:nw)
3903 integer :: ixa^
l,idir,jdir,kdir,idirmin,idim,jxo^
l,hxo^
l,ix
3904 integer :: lxo^
l, kxo^
l
3906 double precision :: tmp(ixi^s),tmp2(ixi^s)
3909 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s)
3910 double precision :: gradeta(ixi^s,1:
ndim), bf(ixi^s,1:
ndir)
3919 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
3920 call mpistop(
"Error in add_source_res1: Non-conforming input limits")
3927 gradeta(ixo^s,1:
ndim)=zero
3933 gradeta(ixo^s,idim)=tmp(ixo^s)
3940 bf(ixi^s,1:
ndir)=wct(ixi^s,mag(1:
ndir))
3947 tmp2(ixi^s)=bf(ixi^s,idir)
3949 lxo^
l=ixo^
l+2*
kr(idim,^
d);
3950 jxo^
l=ixo^
l+
kr(idim,^
d);
3951 hxo^
l=ixo^
l-
kr(idim,^
d);
3952 kxo^
l=ixo^
l-2*
kr(idim,^
d);
3953 tmp(ixo^s)=tmp(ixo^s)+&
3954 (-tmp2(lxo^s)+16.0d0*tmp2(jxo^s)-30.0d0*tmp2(ixo^s)+16.0d0*tmp2(hxo^s)-tmp2(kxo^s)) &
3959 tmp2(ixi^s)=bf(ixi^s,idir)
3961 jxo^
l=ixo^
l+
kr(idim,^
d);
3962 hxo^
l=ixo^
l-
kr(idim,^
d);
3963 tmp(ixo^s)=tmp(ixo^s)+&
3964 (tmp2(jxo^s)-2.0d0*tmp2(ixo^s)+tmp2(hxo^s))/
dxlevel(idim)**2
3969 tmp(ixo^s)=tmp(ixo^s)*eta(ixo^s)
3973 do jdir=1,
ndim;
do kdir=idirmin,3
3974 if (
lvc(idir,jdir,kdir)/=0)
then
3975 if (
lvc(idir,jdir,kdir)==1)
then
3976 tmp(ixo^s)=tmp(ixo^s)-gradeta(ixo^s,jdir)*current(ixo^s,kdir)
3978 tmp(ixo^s)=tmp(ixo^s)+gradeta(ixo^s,jdir)*current(ixo^s,kdir)
3985 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))+qdt*tmp(ixo^s)
3986 if (phys_total_energy)
then
3987 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)+qdt*tmp(ixo^s)*bf(ixo^s,idir)
3991 if (phys_energy)
then
3993 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)+qdt*eta(ixo^s)*sum(current(ixo^s,:)**2,dim=ndim+1)
3996 if (fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_res1')
3998 end subroutine add_source_res1
4002 subroutine add_source_res2(qdt,ixI^L,ixO^L,wCT,w,x)
4007 integer,
intent(in) :: ixi^
l, ixo^
l
4008 double precision,
intent(in) :: qdt
4009 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4010 double precision,
intent(inout) :: w(ixi^s,1:nw)
4013 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s),curlj(ixi^s,1:3)
4014 double precision :: tmpvec(ixi^s,1:3),tmp(ixo^s)
4015 integer :: ixa^
l,idir,idirmin,idirmin1
4019 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
4020 call mpistop(
"Error in add_source_res2: Non-conforming input limits")
4034 tmpvec(ixa^s,1:
ndir)=zero
4036 tmpvec(ixa^s,idir)=current(ixa^s,idir)*eta(ixa^s)
4042 w(ixo^s,mag(
ndir)) = w(ixo^s,mag(
ndir))-qdt*curlj(ixo^s,
ndir)
4044 w(ixo^s,mag(1:
ndir)) = w(ixo^s,mag(1:
ndir))-qdt*curlj(ixo^s,1:
ndir)
4047 if(phys_energy)
then
4048 if(phys_total_energy)
then
4051 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)+qdt*(eta(ixo^s)*sum(current(ixo^s,:)**2,dim=
ndim+1)-&
4052 sum(wct(ixo^s,mag(1:
ndir))*curlj(ixo^s,1:
ndir),dim=
ndim+1))
4055 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)+qdt*eta(ixo^s)*sum(current(ixo^s,:)**2,dim=
ndim+1)
4060 if (
fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_res2')
4061 end subroutine add_source_res2
4065 subroutine add_source_hyperres(qdt,ixI^L,ixO^L,wCT,w,x)
4069 integer,
intent(in) :: ixi^
l, ixo^
l
4070 double precision,
intent(in) :: qdt
4071 double precision,
intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4072 double precision,
intent(inout) :: w(ixi^s,1:nw)
4074 double precision :: current(ixi^s,7-2*
ndir:3)
4075 double precision :: tmpvec(ixi^s,1:3),tmpvec2(ixi^s,1:3),tmp(ixi^s),ehyper(ixi^s,1:3)
4076 integer :: ixa^
l,idir,jdir,kdir,idirmin,idirmin1
4079 if (iximin^
d>ixamin^
d.or.iximax^
d<ixamax^
d|.or.) &
4080 call mpistop(
"Error in add_source_hyperres: Non-conforming input limits")
4083 tmpvec(ixa^s,1:
ndir)=zero
4085 tmpvec(ixa^s,jdir)=current(ixa^s,jdir)
4089 call curlvector(tmpvec,ixi^
l,ixa^
l,tmpvec2,idirmin1,1,3)
4092 tmpvec(ixa^s,1:
ndir)=zero
4093 call curlvector(tmpvec2,ixi^
l,ixa^
l,tmpvec,idirmin1,1,3)
4097 tmpvec2(ixa^s,1:
ndir)=zero
4098 call curlvector(ehyper,ixi^
l,ixa^
l,tmpvec2,idirmin1,1,3)
4101 w(ixo^s,mag(idir)) = w(ixo^s,mag(idir))-tmpvec2(ixo^s,idir)*qdt
4104 if (phys_energy)
then
4107 tmpvec2(ixa^s,1:
ndir)=zero
4108 do idir=1,
ndir;
do jdir=1,
ndir;
do kdir=idirmin,3
4109 tmpvec2(ixa^s,idir) = tmpvec(ixa^s,idir)&
4110 +
lvc(idir,jdir,kdir)*wct(ixa^s,mag(jdir))*ehyper(ixa^s,kdir)
4111 end do;
end do;
end do
4113 call divvector(tmpvec2,ixi^l,ixo^l,tmp)
4114 w(ixo^s,
e_c_)=w(ixo^s,
e_c_)+tmp(ixo^s)*qdt
4117 if (fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_hyperres')
4119 end subroutine add_source_hyperres
4121 subroutine add_source_glm(qdt,ixI^L,ixO^L,wCT,w,x)
4128 integer,
intent(in) :: ixi^
l, ixo^
l
4129 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4130 double precision,
intent(inout) :: w(ixi^s,1:nw)
4131 double precision:: divb(ixi^s)
4132 integer :: idim,idir
4133 double precision :: gradpsi(ixi^s)
4159 if (phys_total_energy)
then
4161 w(ixo^s,
e_c_) = w(ixo^s,
e_c_)-qdt*wct(ixo^s,mag(idim))*gradpsi(ixo^s)
4167 w(ixo^s,
mom_c(idir))=w(ixo^s,
mom_c(idir))-qdt*twofl_mag_i_all(w,ixi^
l,ixo^
l,idir)*divb(ixo^s)
4170 if (
fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_glm')
4172 end subroutine add_source_glm
4175 subroutine add_source_powel(qdt,ixI^L,ixO^L,wCT,w,x)
4178 integer,
intent(in) :: ixi^
l, ixo^
l
4179 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4180 double precision,
intent(inout) :: w(ixi^s,1:nw)
4181 double precision :: divb(ixi^s),v(ixi^s,1:
ndir)
4188 call twofl_get_v_c(wct,x,ixi^
l,ixo^
l,v)
4190 if (phys_total_energy)
then
4193 qdt*sum(v(ixo^s,:)*wct(ixo^s,mag(:)),dim=
ndim+1)*divb(ixo^s)
4198 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))-qdt*v(ixo^s,idir)*divb(ixo^s)
4203 w(ixo^s,
mom_c(idir))=w(ixo^s,
mom_c(idir))-qdt*twofl_mag_i_all(w,ixi^
l,ixo^
l,idir)*divb(ixo^s)
4206 if (
fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_powel')
4208 end subroutine add_source_powel
4210 subroutine add_source_janhunen(qdt,ixI^L,ixO^L,wCT,w,x)
4215 integer,
intent(in) :: ixi^
l, ixo^
l
4216 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4217 double precision,
intent(inout) :: w(ixi^s,1:nw)
4218 double precision :: divb(ixi^s),vel(ixi^s)
4227 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))-qdt*vel(ixo^s)*divb(ixo^s)
4230 if (
fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^
l,ixo^
l,
'add_source_janhunen')
4232 end subroutine add_source_janhunen
4234 subroutine add_source_linde(qdt,ixI^L,ixO^L,wCT,w,x)
4239 integer,
intent(in) :: ixi^
l, ixo^
l
4240 double precision,
intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:
ndim)
4241 double precision,
intent(inout) :: w(ixi^s,1:nw)
4242 integer :: idim, idir, ixp^
l, i^
d, iside
4243 double precision :: divb(ixi^s),graddivb(ixi^s)
4244 logical,
dimension(-1:1^D&) :: leveljump
4252 if(i^
d==0|.and.) cycle
4253 if(neighbor_type(i^
d,
block%igrid)==2 .or. neighbor_type(i^
d,
block%igrid)==4)
then
4254 leveljump(i^
d)=.true.
4256 leveljump(i^
d)=.false.
4265 i^dd=kr(^dd,^d)*(2*iside-3);
4266 if (leveljump(i^dd))
then
4268 ixpmin^d=ixomin^d-i^d
4270 ixpmax^d=ixomax^d-i^d
4281 select case(typegrad)
4283 call gradient(divb,ixi^l,ixp^l,idim,graddivb)
4285 call gradientl(divb,ixi^l,ixp^l,idim,graddivb)
4289 if (slab_uniform)
then
4290 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff/(^d&1.0d0/dxlevel(^d)**2+)
4292 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff &
4293 /(^d&1.0d0/block%ds(ixp^s,^d)**2+)
4296 w(ixp^s,mag(idim))=w(ixp^s,mag(idim))+graddivb(ixp^s)
4298 if (typedivbdiff==
'all' .and. phys_total_energy)
then
4300 w(ixp^s,
e_c_)=w(ixp^s,
e_c_)+wct(ixp^s,mag(idim))*graddivb(ixp^s)
4304 if (fix_small_values)
call twofl_handle_small_values(.false.,w,x,ixi^l,ixo^l,
'add_source_linde')
4306 end subroutine add_source_linde
4314 integer,
intent(in) :: ixi^
l, ixo^
l
4315 double precision,
intent(in) :: w(ixi^s,1:nw)
4316 double precision :: divb(ixi^s), dsurface(ixi^s)
4318 double precision :: invb(ixo^s)
4319 integer :: ixa^
l,idims
4321 call get_divb(w,ixi^
l,ixo^
l,divb)
4322 invb(ixo^s)=sqrt(twofl_mag_en_all(w,ixi^
l,ixo^
l))
4323 where(invb(ixo^s)/=0.d0)
4324 invb(ixo^s)=1.d0/invb(ixo^s)
4327 divb(ixo^s)=0.5d0*abs(divb(ixo^s))*invb(ixo^s)/sum(1.d0/
dxlevel(:))
4329 ixamin^
d=ixomin^
d-1;
4330 ixamax^
d=ixomax^
d-1;
4331 dsurface(ixo^s)= sum(
block%surfaceC(ixo^s,:),dim=
ndim+1)
4333 ixa^
l=ixo^
l-
kr(idims,^
d);
4334 dsurface(ixo^s)=dsurface(ixo^s)+
block%surfaceC(ixa^s,idims)
4336 divb(ixo^s)=abs(divb(ixo^s))*invb(ixo^s)*&
4337 block%dvolume(ixo^s)/dsurface(ixo^s)
4348 integer,
intent(in) :: ixo^
l, ixi^
l
4349 double precision,
intent(in) :: w(ixi^s,1:nw)
4350 integer,
intent(out) :: idirmin
4351 integer :: idir, idirmin0
4354 double precision :: current(ixi^s,7-2*
ndir:3),bvec(ixi^s,1:
ndir)
4358 bvec(ixi^s,1:
ndir)=w(ixi^s,mag(1:
ndir))
4362 if(
b0field) current(ixo^s,idirmin0:3)=current(ixo^s,idirmin0:3)+&
4363 block%J0(ixo^s,idirmin0:3)
4369 subroutine gravity_add_source(qdt,ixI^L,ixO^L,wCT,w,x,&
4370 energy,qsourcesplit,active)
4374 integer,
intent(in) :: ixi^
l, ixo^
l
4375 double precision,
intent(in) :: qdt, x(ixi^s,1:
ndim)
4376 double precision,
intent(in) :: wct(ixi^s,1:nw)
4377 double precision,
intent(inout) :: w(ixi^s,1:nw)
4378 logical,
intent(in) :: energy,qsourcesplit
4379 logical,
intent(inout) :: active
4380 double precision :: vel(ixi^s)
4383 double precision :: gravity_field(ixi^s,
ndim)
4385 if(qsourcesplit .eqv. grav_split)
then
4389 write(*,*)
"mod_usr.t: please point usr_gravity to a subroutine"
4390 write(*,*)
"like the phys_gravity in mod_usr_methods.t"
4391 call mpistop(
"gravity_add_source: usr_gravity not defined")
4397 w(ixo^s,
mom_n(idim)) = w(ixo^s,
mom_n(idim)) &
4398 + qdt * gravity_field(ixo^s,idim) * wct(ixo^s,
rho_n_)
4399 w(ixo^s,
mom_c(idim)) = w(ixo^s,
mom_c(idim)) &
4400 + qdt * gravity_field(ixo^s,idim) * wct(ixo^s,
rho_c_)
4402#if !defined(E_RM_W0) || E_RM_W0 == 1
4405 + qdt * gravity_field(ixo^s,idim) * vel(ixo^s) * wct(ixo^s,
rho_n_)
4408 + qdt * gravity_field(ixo^s,idim) * vel(ixo^s) * wct(ixo^s,
rho_c_)
4411 + qdt * gravity_field(ixo^s,idim) * wct(ixo^s,
mom_n(idim))
4413 + qdt * gravity_field(ixo^s,idim) * wct(ixo^s,
mom_c(idim))
4421 end subroutine gravity_add_source
4423 subroutine gravity_get_dt(w,ixI^L,ixO^L,dtnew,dx^D,x)
4427 integer,
intent(in) :: ixi^
l, ixo^
l
4428 double precision,
intent(in) ::
dx^
d, x(ixi^s,1:
ndim), w(ixi^s,1:nw)
4429 double precision,
intent(inout) :: dtnew
4431 double precision :: dxinv(1:
ndim), max_grav
4434 double precision :: gravity_field(ixi^s,
ndim)
4436 ^
d&dxinv(^
d)=one/
dx^
d;
4439 write(*,*)
"mod_usr.t: please point usr_gravity to a subroutine"
4440 write(*,*)
"like the phys_gravity in mod_usr_methods.t"
4441 call mpistop(
"gravity_get_dt: usr_gravity not defined")
4447 max_grav = maxval(abs(gravity_field(ixo^s,idim)))
4448 max_grav = max(max_grav, epsilon(1.0d0))
4449 dtnew = min(dtnew, 1.0d0 / sqrt(max_grav * dxinv(idim)))
4452 end subroutine gravity_get_dt
4455 subroutine twofl_get_dt(w,ixI^L,ixO^L,dtnew,dx^D,x)
4462 integer,
intent(in) :: ixi^
l, ixo^
l
4463 double precision,
intent(inout) :: dtnew
4464 double precision,
intent(in) ::
dx^
d
4465 double precision,
intent(in) :: w(ixi^s,1:nw)
4466 double precision,
intent(in) :: x(ixi^s,1:
ndim)
4468 integer :: idirmin,idim
4469 double precision :: dxarr(
ndim)
4470 double precision :: current(ixi^s,7-2*
ndir:3),eta(ixi^s)
4484 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/dxarr(idim)**2)))
4487 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/
block%ds(ixo^s,idim)**2)))
4501 if(
dtcollpar>0d0 .and. has_collisions())
then
4502 call coll_get_dt(w,x,ixi^
l,ixo^
l,dtnew)
4517 call gravity_get_dt(w,ixi^
l,ixo^
l,dtnew,
dx^
d,x)
4520 call hyperdiffusivity_get_dt(w,ixi^
l,ixo^
l,dtnew,
dx^
d,x)
4524 end subroutine twofl_get_dt
4526 pure function has_collisions()
result(res)
4529 end function has_collisions
4531 subroutine coll_get_dt(w,x,ixI^L,ixO^L,dtnew)
4533 integer,
intent(in) :: ixi^
l, ixo^
l
4534 double precision,
intent(in) :: w(ixi^s,1:nw)
4535 double precision,
intent(in) :: x(ixi^s,1:
ndim)
4536 double precision,
intent(inout) :: dtnew
4538 double precision :: rhon(ixi^s), rhoc(ixi^s), alpha(ixi^s)
4539 double precision,
allocatable :: gamma_rec(:^
d&), gamma_ion(:^D&)
4540 double precision :: max_coll_rate
4546 max_coll_rate = maxval(alpha(ixo^s) * max(rhon(ixo^s), rhoc(ixo^s)))
4549 allocate(gamma_ion(ixi^s), gamma_rec(ixi^s))
4551 max_coll_rate=max(max_coll_rate, maxval(gamma_ion(ixo^s)), maxval(gamma_rec(ixo^s)))
4552 deallocate(gamma_ion, gamma_rec)
4554 dtnew = min(
dtcollpar/max_coll_rate, dtnew)
4556 end subroutine coll_get_dt
4559 subroutine twofl_add_source_geom(qdt,dtfactor,ixI^L,ixO^L,wCT,wprim,w,x)
4563 integer,
intent(in) :: ixi^
l, ixo^
l
4564 double precision,
intent(in) :: qdt, dtfactor,x(ixi^s,1:
ndim)
4565 double precision,
intent(inout) :: wct(ixi^s,1:nw), wprim(ixi^s,1:nw), w(ixi^s,1:nw)
4567 integer :: iw,idir, h1x^
l{^nooned, h2x^
l}
4568 double precision :: tmp(ixi^s),tmp1(ixi^s),tmp2(ixi^s),rho(ixi^s)
4570 integer :: mr_,mphi_
4571 integer :: br_,bphi_
4576 br_=mag(1); bphi_=mag(1)-1+
phi_
4584 w(ixo^s,mr_)=w(ixo^s,mr_)+qdt/x(ixo^s,1)*(tmp(ixo^s)-&
4585 wct(ixo^s,bphi_)**2+wct(ixo^s,mphi_)**2/rho(ixo^s))
4586 w(ixo^s,mphi_)=w(ixo^s,mphi_)+qdt/x(ixo^s,1)*(&
4587 -wct(ixo^s,mphi_)*wct(ixo^s,mr_)/rho(ixo^s) &
4588 +wct(ixo^s,bphi_)*wct(ixo^s,br_))
4590 w(ixo^s,bphi_)=w(ixo^s,bphi_)+qdt/x(ixo^s,1)*&
4591 (wct(ixo^s,bphi_)*wct(ixo^s,mr_) &
4592 -wct(ixo^s,br_)*wct(ixo^s,mphi_)) &
4596 w(ixo^s,mr_)=w(ixo^s,mr_)+qdt/x(ixo^s,1)*tmp(ixo^s)
4598 if(
twofl_glm) w(ixo^s,br_)=w(ixo^s,br_)+qdt*wct(ixo^s,
psi_)/x(ixo^s,1)
4600 h1x^
l=ixo^
l-
kr(1,^
d); {^nooned h2x^
l=ixo^
l-
kr(2,^
d);}
4602 tmp(ixo^s)=tmp1(ixo^s)
4604 tmp2(ixo^s)=sum(
block%B0(ixo^s,:,0)*wct(ixo^s,mag(:)),dim=
ndim+1)
4605 tmp(ixo^s)=tmp(ixo^s)+tmp2(ixo^s)
4608 tmp(ixo^s)=tmp(ixo^s)*x(ixo^s,1) &
4609 *(
block%surfaceC(ixo^s,1)-
block%surfaceC(h1x^s,1))/
block%dvolume(ixo^s)
4612 tmp(ixo^s)=tmp(ixo^s)+wct(ixo^s,
mom_c(idir))**2/rho(ixo^s)-wct(ixo^s,mag(idir))**2
4613 if(
b0field) tmp(ixo^s)=tmp(ixo^s)-2.0d0*
block%B0(ixo^s,idir,0)*wct(ixo^s,mag(idir))
4616 w(ixo^s,
mom_c(1))=w(ixo^s,
mom_c(1))+qdt*tmp(ixo^s)/x(ixo^s,1)
4619 w(ixo^s,mag(1))=w(ixo^s,mag(1))+qdt/x(ixo^s,1)*2.0d0*wct(ixo^s,
psi_)
4624 tmp(ixo^s)=tmp1(ixo^s)
4626 tmp(ixo^s)=tmp(ixo^s)+tmp2(ixo^s)
4629 w(ixo^s,
mom_c(2))=w(ixo^s,
mom_c(2))+qdt*tmp(ixo^s) &
4630 *(
block%surfaceC(ixo^s,2)-
block%surfaceC(h2x^s,2)) &
4631 /
block%dvolume(ixo^s)
4632 tmp(ixo^s)=-(wct(ixo^s,
mom_c(1))*wct(ixo^s,
mom_c(2))/rho(ixo^s) &
4633 -wct(ixo^s,mag(1))*wct(ixo^s,mag(2)))
4635 tmp(ixo^s)=tmp(ixo^s)+
block%B0(ixo^s,1,0)*wct(ixo^s,mag(2)) &
4636 +wct(ixo^s,mag(1))*
block%B0(ixo^s,2,0)
4639 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom_c(3))**2/rho(ixo^s) &
4640 -wct(ixo^s,mag(3))**2)*dcos(x(ixo^s,2))/dsin(x(ixo^s,2))
4642 tmp(ixo^s)=tmp(ixo^s)-2.0d0*
block%B0(ixo^s,3,0)*wct(ixo^s,mag(3))&
4643 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2))
4646 w(ixo^s,
mom_c(2))=w(ixo^s,
mom_c(2))+qdt*tmp(ixo^s)/x(ixo^s,1)
4649 tmp(ixo^s)=(wct(ixo^s,
mom_c(1))*wct(ixo^s,mag(2)) &
4650 -wct(ixo^s,
mom_c(2))*wct(ixo^s,mag(1)))/rho(ixo^s)
4652 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom_c(1))*
block%B0(ixo^s,2,0) &
4653 -wct(ixo^s,
mom_c(2))*
block%B0(ixo^s,1,0))/rho(ixo^s)
4656 tmp(ixo^s)=tmp(ixo^s) &
4657 + dcos(x(ixo^s,2))/dsin(x(ixo^s,2))*wct(ixo^s,
psi_)
4659 w(ixo^s,mag(2))=w(ixo^s,mag(2))+qdt*tmp(ixo^s)/x(ixo^s,1)
4665 tmp(ixo^s)=-(wct(ixo^s,
mom_c(3))*wct(ixo^s,
mom_c(1))/rho(ixo^s) &
4666 -wct(ixo^s,mag(3))*wct(ixo^s,mag(1))) {^nooned &
4667 -(wct(ixo^s,
mom_c(2))*wct(ixo^s,
mom_c(3))/rho(ixo^s) &
4668 -wct(ixo^s,mag(2))*wct(ixo^s,mag(3))) &
4669 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2)) }
4671 tmp(ixo^s)=tmp(ixo^s)+
block%B0(ixo^s,1,0)*wct(ixo^s,mag(3)) &
4672 +wct(ixo^s,mag(1))*
block%B0(ixo^s,3,0) {^nooned &
4673 +(
block%B0(ixo^s,2,0)*wct(ixo^s,mag(3)) &
4674 +wct(ixo^s,mag(2))*
block%B0(ixo^s,3,0)) &
4675 *dcos(x(ixo^s,2))/dsin(x(ixo^s,2)) }
4677 w(ixo^s,
mom_c(3))=w(ixo^s,
mom_c(3))+qdt*tmp(ixo^s)/x(ixo^s,1)
4680 tmp(ixo^s)=(wct(ixo^s,
mom_c(1))*wct(ixo^s,mag(3)) &
4681 -wct(ixo^s,
mom_c(3))*wct(ixo^s,mag(1)))/rho(ixo^s) {^nooned &
4682 -(wct(ixo^s,
mom_c(3))*wct(ixo^s,mag(2)) &
4683 -wct(ixo^s,
mom_c(2))*wct(ixo^s,mag(3)))*dcos(x(ixo^s,2)) &
4684 /(rho(ixo^s)*dsin(x(ixo^s,2))) }
4686 tmp(ixo^s)=tmp(ixo^s)+(wct(ixo^s,
mom_c(1))*
block%B0(ixo^s,3,0) &
4687 -wct(ixo^s,
mom_c(3))*
block%B0(ixo^s,1,0))/rho(ixo^s){^nooned &
4689 -wct(ixo^s,
mom_c(2))*
block%B0(ixo^s,3,0))*dcos(x(ixo^s,2)) &
4690 /(rho(ixo^s)*dsin(x(ixo^s,2))) }
4692 w(ixo^s,mag(3))=w(ixo^s,mag(3))+qdt*tmp(ixo^s)/x(ixo^s,1)
4713 where (rho(ixo^s) > 0d0)
4714 tmp(ixo^s) = tmp1(ixo^s) + wct(ixo^s, mphi_)**2 / rho(ixo^s)
4715 w(ixo^s, mr_) = w(ixo^s, mr_) + qdt * tmp(ixo^s) / x(ixo^s,
r_)
4718 where (rho(ixo^s) > 0d0)
4719 tmp(ixo^s) = -wct(ixo^s, mphi_) * wct(ixo^s, mr_) / rho(ixo^s)
4720 w(ixo^s, mphi_) = w(ixo^s, mphi_) + qdt * tmp(ixo^s) / x(ixo^s,
r_)
4724 w(ixo^s, mr_) = w(ixo^s, mr_) + qdt * tmp1(ixo^s) / x(ixo^s,
r_)
4728 h1x^
l=ixo^
l-
kr(1,^
d); {^nooned h2x^
l=ixo^
l-
kr(2,^
d);}
4730 tmp(ixo^s) = tmp1(ixo^s) * x(ixo^s, 1) &
4731 *(
block%surfaceC(ixo^s, 1) -
block%surfaceC(h1x^s, 1)) &
4732 /
block%dvolume(ixo^s)
4735 tmp(ixo^s) = tmp(ixo^s) + wct(ixo^s,
mom_n(idir))**2 / rho(ixo^s)
4738 w(ixo^s, mr_) = w(ixo^s, mr_) + qdt * tmp(ixo^s) / x(ixo^s, 1)
4742 tmp(ixo^s) = tmp1(ixo^s) * x(ixo^s, 1) &
4743 * (
block%surfaceC(ixo^s, 2) -
block%surfaceC(h2x^s, 2)) &
4744 /
block%dvolume(ixo^s)
4746 tmp(ixo^s) = tmp(ixo^s) + (wct(ixo^s,
mom_n(3))**2 / rho(ixo^s)) / tan(x(ixo^s, 2))
4748 tmp(ixo^s) = tmp(ixo^s) - (wct(ixo^s,
mom_n(2)) * wct(ixo^s, mr_)) / rho(ixo^s)
4749 w(ixo^s,
mom_n(2)) = w(ixo^s,
mom_n(2)) + qdt * tmp(ixo^s) / x(ixo^s, 1)
4753 tmp(ixo^s) = -(wct(ixo^s,
mom_n(3)) * wct(ixo^s, mr_)) / rho(ixo^s)&
4754 - (wct(ixo^s,
mom_n(2)) * wct(ixo^s,
mom_n(3))) / rho(ixo^s) / tan(x(ixo^s, 2))
4755 w(ixo^s,
mom_n(3)) = w(ixo^s,
mom_n(3)) + qdt * tmp(ixo^s) / x(ixo^s, 1)
4764 integer,
intent(in) :: ixI^L, ixO^L
4765 double precision,
intent(in) :: w(ixI^S,nw)
4766 double precision,
intent(in) :: x(ixI^S,1:ndim)
4767 double precision,
intent(out) :: p(ixI^S)
4771 p(ixo^s) = p(ixo^s) + 0.5d0 * sum(w(ixo^s, mag(:))**2, dim=ndim+1)
4775 end subroutine twofl_add_source_geom
4777 subroutine twofl_get_temp_c_pert_from_etot(w, x, ixI^L, ixO^L, res)
4779 integer,
intent(in) :: ixI^L, ixO^L
4780 double precision,
intent(in) :: w(ixI^S, 1:nw)
4781 double precision,
intent(in) :: x(ixI^S, 1:ndim)
4782 double precision,
intent(out):: res(ixI^S)
4785 res(ixo^s)=(gamma_1*(w(ixo^s,
e_c_)&
4786 - twofl_kin_en_c(w,ixi^l,ixo^l)&
4787 - twofl_mag_en(w,ixi^l,ixo^l)))
4798 res(ixo^s) = res(ixo^s)/(
rc * w(ixo^s,
rho_c_))
4801 end subroutine twofl_get_temp_c_pert_from_etot
4804 function twofl_mag_en_all(w, ixI^L, ixO^L)
result(mge)
4806 integer,
intent(in) :: ixI^L, ixO^L
4807 double precision,
intent(in) :: w(ixI^S, nw)
4808 double precision :: mge(ixO^S)
4811 mge(ixo^s) = sum((w(ixo^s, mag(:))+
block%B0(ixo^s,:,
b0i))**2, dim=
ndim+1)
4813 mge(ixo^s) = sum(w(ixo^s, mag(:))**2, dim=
ndim+1)
4815 end function twofl_mag_en_all
4818 function twofl_mag_i_all(w, ixI^L, ixO^L,idir)
result(mgf)
4820 integer,
intent(in) :: ixI^L, ixO^L, idir
4821 double precision,
intent(in) :: w(ixI^S, nw)
4822 double precision :: mgf(ixO^S)
4825 mgf(ixo^s) = w(ixo^s, mag(idir))+
block%B0(ixo^s,idir,
b0i)
4827 mgf(ixo^s) = w(ixo^s, mag(idir))
4829 end function twofl_mag_i_all
4832 function twofl_mag_en(w, ixI^L, ixO^L)
result(mge)
4834 integer,
intent(in) :: ixI^L, ixO^L
4835 double precision,
intent(in) :: w(ixI^S, nw)
4836 double precision :: mge(ixO^S)
4838 mge(ixo^s) = 0.5d0 * sum(w(ixo^s, mag(:))**2, dim=
ndim+1)
4839 end function twofl_mag_en
4842 function twofl_kin_en_n(w, ixI^L, ixO^L)
result(ke)
4844 integer,
intent(in) :: ixI^L, ixO^L
4845 double precision,
intent(in) :: w(ixI^S, nw)
4846 double precision :: ke(ixO^S)
4851 ke(ixo^s) = 0.5d0 * sum(w(ixo^s,
mom_n(:))**2, dim=
ndim+1) / w(ixo^s,
rho_n_)
4854 end function twofl_kin_en_n
4856 subroutine twofl_get_temp_n_pert_from_etot(w, x, ixI^L, ixO^L, res)
4858 integer,
intent(in) :: ixI^L, ixO^L
4859 double precision,
intent(in) :: w(ixI^S, 1:nw)
4860 double precision,
intent(in) :: x(ixI^S, 1:ndim)
4861 double precision,
intent(out):: res(ixI^S)
4864 res(ixo^s)=(gamma_1*(w(ixo^s,
e_c_)- twofl_kin_en_c(w,ixi^l,ixo^l)))
4875 res(ixo^s) = res(ixo^s)/(
rn * w(ixo^s,
rho_n_))
4878 end subroutine twofl_get_temp_n_pert_from_etot
4882 function twofl_kin_en_c(w, ixI^L, ixO^L)
result(ke)
4884 integer,
intent(in) :: ixI^L, ixO^L
4885 double precision,
intent(in) :: w(ixI^S, nw)
4886 double precision :: ke(ixO^S)
4891 ke(ixo^s) = 0.5d0 * sum(w(ixo^s,
mom_c(:))**2, dim=
ndim+1) / w(ixo^s,
rho_c_)
4893 end function twofl_kin_en_c
4895 subroutine twofl_getv_hall(w,x,ixI^L,ixO^L,vHall)
4898 integer,
intent(in) :: ixI^L, ixO^L
4899 double precision,
intent(in) :: w(ixI^S,nw)
4900 double precision,
intent(in) :: x(ixI^S,1:ndim)
4901 double precision,
intent(inout) :: vHall(ixI^S,1:3)
4903 integer :: idir, idirmin
4904 double precision :: current(ixI^S,7-2*ndir:3)
4905 double precision :: rho(ixI^S)
4910 vhall(ixo^s,1:3) = zero
4911 vhall(ixo^s,idirmin:3) = -
twofl_etah*current(ixo^s,idirmin:3)
4912 do idir = idirmin, 3
4913 vhall(ixo^s,idir) = vhall(ixo^s,idir)/rho(ixo^s)
4916 end subroutine twofl_getv_hall
4951 subroutine twofl_modify_wlr(ixI^L,ixO^L,qt,wLC,wRC,wLp,wRp,s,idir)
4954 integer,
intent(in) :: ixI^L, ixO^L, idir
4955 double precision,
intent(in) :: qt
4956 double precision,
intent(inout) :: wLC(ixI^S,1:nw), wRC(ixI^S,1:nw)
4957 double precision,
intent(inout) :: wLp(ixI^S,1:nw), wRp(ixI^S,1:nw)
4959 double precision :: dB(ixI^S), dPsi(ixI^S)
4962 wlc(ixo^s,mag(idir))=s%ws(ixo^s,idir)
4963 wrc(ixo^s,mag(idir))=s%ws(ixo^s,idir)
4964 wlp(ixo^s,mag(idir))=s%ws(ixo^s,idir)
4965 wrp(ixo^s,mag(idir))=s%ws(ixo^s,idir)
4973 db(ixo^s) = wrp(ixo^s,mag(idir)) - wlp(ixo^s,mag(idir))
4974 dpsi(ixo^s) = wrp(ixo^s,
psi_) - wlp(ixo^s,
psi_)
4976 wlp(ixo^s,mag(idir)) = 0.5d0 * (wrp(ixo^s,mag(idir)) + wlp(ixo^s,mag(idir))) &
4978 wlp(ixo^s,
psi_) = 0.5d0 * (wrp(ixo^s,
psi_) + wlp(ixo^s,
psi_)) &
4981 wrp(ixo^s,mag(idir)) = wlp(ixo^s,mag(idir))
4984 if(phys_total_energy)
then
4985 wrc(ixo^s,
e_c_)=wrc(ixo^s,
e_c_)-half*wrc(ixo^s,mag(idir))**2
4986 wlc(ixo^s,
e_c_)=wlc(ixo^s,
e_c_)-half*wlc(ixo^s,mag(idir))**2
4988 wrc(ixo^s,mag(idir)) = wlp(ixo^s,mag(idir))
4990 wlc(ixo^s,mag(idir)) = wlp(ixo^s,mag(idir))
4993 if(phys_total_energy)
then
4994 wrc(ixo^s,
e_c_)=wrc(ixo^s,
e_c_)+half*wrc(ixo^s,mag(idir))**2
4995 wlc(ixo^s,
e_c_)=wlc(ixo^s,
e_c_)+half*wlc(ixo^s,mag(idir))**2
5001 end subroutine twofl_modify_wlr
5003 subroutine twofl_boundary_adjust(igrid,psb)
5005 integer,
intent(in) :: igrid
5006 type(state),
target :: psb(max_blocks)
5008 integer :: iB, idims, iside, ixO^L, i^D
5017 i^d=
kr(^d,idims)*(2*iside-3);
5018 if (neighbor_type(i^d,igrid)/=1) cycle
5019 ib=(idims-1)*2+iside
5037 call fixdivb_boundary(ixg^
ll,ixo^l,psb(igrid)%w,psb(igrid)%x,ib)
5042 end subroutine twofl_boundary_adjust
5044 subroutine fixdivb_boundary(ixG^L,ixO^L,w,x,iB)
5047 integer,
intent(in) :: ixG^L,ixO^L,iB
5048 double precision,
intent(inout) :: w(ixG^S,1:nw)
5049 double precision,
intent(in) :: x(ixG^S,1:ndim)
5051 double precision :: dx1x2,dx1x3,dx2x1,dx2x3,dx3x1,dx3x2
5052 integer :: ix^D,ixF^L
5064 do ix1=ixfmax1,ixfmin1,-1
5065 w(ix1-1,ixfmin2:ixfmax2,mag(1))=w(ix1+1,ixfmin2:ixfmax2,mag(1)) &
5066 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
5067 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
5070 do ix1=ixfmax1,ixfmin1,-1
5071 w(ix1-1,ixfmin2:ixfmax2,mag(1))=( (w(ix1+1,ixfmin2:ixfmax2,mag(1))+&
5072 w(ix1,ixfmin2:ixfmax2,mag(1)))*
block%surfaceC(ix1,ixfmin2:ixfmax2,1)&
5073 +(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
5074 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
5075 -(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
5076 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
5077 /
block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
5091 do ix1=ixfmax1,ixfmin1,-1
5092 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
5093 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
5094 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
5095 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
5096 +dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
5097 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
5100 do ix1=ixfmax1,ixfmin1,-1
5101 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
5102 ( (w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
5103 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
5104 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
5105 +(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
5106 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
5107 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
5108 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
5109 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
5110 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
5111 +(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
5112 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
5113 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
5114 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
5115 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
5116 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
5117 /
block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
5118 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
5130 do ix1=ixfmin1,ixfmax1
5131 w(ix1+1,ixfmin2:ixfmax2,mag(1))=w(ix1-1,ixfmin2:ixfmax2,mag(1)) &
5132 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
5133 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
5136 do ix1=ixfmin1,ixfmax1
5137 w(ix1+1,ixfmin2:ixfmax2,mag(1))=( (w(ix1-1,ixfmin2:ixfmax2,mag(1))+&
5138 w(ix1,ixfmin2:ixfmax2,mag(1)))*
block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)&
5139 -(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
5140 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
5141 +(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
5142 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
5143 /
block%surfaceC(ix1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
5157 do ix1=ixfmin1,ixfmax1
5158 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
5159 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
5160 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
5161 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
5162 -dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
5163 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
5166 do ix1=ixfmin1,ixfmax1
5167 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
5168 ( (w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
5169 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
5170 block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
5171 -(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
5172 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
5173 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
5174 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
5175 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
5176 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
5177 -(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
5178 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
5179 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
5180 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
5181 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
5182 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
5183 /
block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
5184 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
5196 do ix2=ixfmax2,ixfmin2,-1
5197 w(ixfmin1:ixfmax1,ix2-1,mag(2))=w(ixfmin1:ixfmax1,ix2+1,mag(2)) &
5198 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
5199 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
5202 do ix2=ixfmax2,ixfmin2,-1
5203 w(ixfmin1:ixfmax1,ix2-1,mag(2))=( (w(ixfmin1:ixfmax1,ix2+1,mag(2))+&
5204 w(ixfmin1:ixfmax1,ix2,mag(2)))*
block%surfaceC(ixfmin1:ixfmax1,ix2,2)&
5205 +(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
5206 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
5207 -(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
5208 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
5209 /
block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
5223 do ix2=ixfmax2,ixfmin2,-1
5224 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
5225 ix2+1,ixfmin3:ixfmax3,mag(2)) &
5226 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
5227 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
5228 +dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
5229 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
5232 do ix2=ixfmax2,ixfmin2,-1
5233 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=&
5234 ( (w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))+&
5235 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
5236 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)&
5237 +(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
5238 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
5239 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
5240 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
5241 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
5242 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
5243 +(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
5244 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
5245 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
5246 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
5247 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
5248 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
5249 /
block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)-&
5250 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
5262 do ix2=ixfmin2,ixfmax2
5263 w(ixfmin1:ixfmax1,ix2+1,mag(2))=w(ixfmin1:ixfmax1,ix2-1,mag(2)) &
5264 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
5265 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
5268 do ix2=ixfmin2,ixfmax2
5269 w(ixfmin1:ixfmax1,ix2+1,mag(2))=( (w(ixfmin1:ixfmax1,ix2-1,mag(2))+&
5270 w(ixfmin1:ixfmax1,ix2,mag(2)))*
block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)&
5271 -(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
5272 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
5273 +(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
5274 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
5275 /
block%surfaceC(ixfmin1:ixfmax1,ix2,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
5289 do ix2=ixfmin2,ixfmax2
5290 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
5291 ix2-1,ixfmin3:ixfmax3,mag(2)) &
5292 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
5293 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
5294 -dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
5295 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
5298 do ix2=ixfmin2,ixfmax2
5299 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=&
5300 ( (w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))+&
5301 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
5302 block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)&
5303 -(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
5304 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
5305 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
5306 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
5307 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
5308 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
5309 -(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
5310 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
5311 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
5312 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
5313 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
5314 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
5315 /
block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)-&
5316 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
5331 do ix3=ixfmax3,ixfmin3,-1
5332 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=w(ixfmin1:ixfmax1,&
5333 ixfmin2:ixfmax2,ix3+1,mag(3)) &
5334 +dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
5335 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
5336 +dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
5337 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
5340 do ix3=ixfmax3,ixfmin3,-1
5341 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=&
5342 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))+&
5343 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
5344 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)&
5345 +(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
5346 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
5347 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
5348 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
5349 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
5350 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
5351 +(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
5352 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
5353 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
5354 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
5355 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
5356 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
5357 /
block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)-&
5358 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
5371 do ix3=ixfmin3,ixfmax3
5372 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=w(ixfmin1:ixfmax1,&
5373 ixfmin2:ixfmax2,ix3-1,mag(3)) &
5374 -dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
5375 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
5376 -dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
5377 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
5380 do ix3=ixfmin3,ixfmax3
5381 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=&
5382 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))+&
5383 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
5384 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)&
5385 -(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
5386 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
5387 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
5388 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
5389 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
5390 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
5391 -(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
5392 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
5393 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
5394 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
5395 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
5396 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
5397 /
block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)-&
5398 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
5403 call mpistop(
"Special boundary is not defined for this region")
5406 end subroutine fixdivb_boundary
5415 double precision,
intent(in) :: qdt
5416 double precision,
intent(in) :: qt
5417 logical,
intent(inout) :: active
5418 integer :: iigrid, igrid, id
5419 integer :: n, nc, lvl, ix^
l, ixc^
l, idim
5421 double precision :: tmp(ixg^t), grad(ixg^t,
ndim)
5422 double precision :: res
5423 double precision,
parameter :: max_residual = 1
d-3
5424 double precision,
parameter :: residual_reduction = 1
d-10
5425 integer,
parameter :: max_its = 50
5426 double precision :: residual_it(max_its), max_divb
5428 mg%operator_type = mg_laplacian
5436 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
5437 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
5440 mg%bc(n, mg_iphi)%bc_type = mg_bc_neumann
5441 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
5443 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
5444 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
5447 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
5448 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
5452 print *,
"divb_multigrid warning: unknown b.c.: ", &
5454 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
5455 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
5463 do iigrid = 1, igridstail
5464 igrid = igrids(iigrid);
5467 lvl =
mg%boxes(id)%lvl
5468 nc =
mg%box_size_lvl(lvl)
5474 call get_divb(ps(igrid)%w(ixg^t, 1:nw), ixg^
ll,
ixm^
ll, tmp, &
5476 mg%boxes(id)%cc({1:nc}, mg_irhs) = tmp(
ixm^t)
5477 max_divb = max(max_divb, maxval(abs(tmp(
ixm^t))))
5482 call mpi_allreduce(mpi_in_place, max_divb, 1, mpi_double_precision, &
5485 if (
mype == 0) print *,
"Performing multigrid divB cleaning"
5486 if (
mype == 0) print *,
"iteration vs residual"
5489 call mg_fas_fmg(
mg, n>1, max_res=residual_it(n))
5490 if (
mype == 0)
write(*,
"(I4,E11.3)") n, residual_it(n)
5491 if (residual_it(n) < residual_reduction * max_divb)
exit
5493 if (
mype == 0 .and. n > max_its)
then
5494 print *,
"divb_multigrid warning: not fully converged"
5495 print *,
"current amplitude of divb: ", residual_it(max_its)
5496 print *,
"multigrid smallest grid: ", &
5497 mg%domain_size_lvl(:,
mg%lowest_lvl)
5498 print *,
"note: smallest grid ideally has <= 8 cells"
5499 print *,
"multigrid dx/dy/dz ratio: ",
mg%dr(:, 1)/
mg%dr(1, 1)
5500 print *,
"note: dx/dy/dz should be similar"
5504 call mg_fas_vcycle(
mg, max_res=res)
5505 if (res < max_residual)
exit
5507 if (res > max_residual)
call mpistop(
"divb_multigrid: no convergence")
5512 do iigrid = 1, igridstail
5513 igrid = igrids(iigrid);
5522 tmp(ix^s) =
mg%boxes(id)%cc({:,}, mg_iphi)
5526 ixcmin^
d=ixmlo^
d-
kr(idim,^
d);
5528 call gradientf(tmp,ps(igrid)%x,ixg^
ll,ixc^
l,idim,grad(ixg^t,idim))
5530 ps(igrid)%ws(ixc^s,idim)=ps(igrid)%ws(ixc^s,idim)-grad(ixc^s,idim)
5543 ps(igrid)%w(
ixm^t, mag(1:
ndim)) = &
5544 ps(igrid)%w(
ixm^t, mag(1:
ndim)) - grad(
ixm^t, :)
5547 if(phys_total_energy)
then
5549 tmp(
ixm^t) = 0.5_dp * (sum(ps(igrid)%w(
ixm^t, &
5561 subroutine twofl_update_faces(ixI^L,ixO^L,qt,qdt,wprim,fC,fE,sCT,s,vcts)
5564 integer,
intent(in) :: ixi^
l, ixo^
l
5565 double precision,
intent(in) :: qt,qdt
5567 double precision,
intent(in) :: wprim(ixi^s,1:nw)
5568 type(state) :: sct, s
5569 type(ct_velocity) :: vcts
5570 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
5571 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
5575 call update_faces_average(ixi^
l,ixo^
l,qt,qdt,fc,fe,sct,s)
5577 call update_faces_contact(ixi^
l,ixo^
l,qt,qdt,wprim,fc,fe,sct,s,vcts)
5579 call update_faces_hll(ixi^
l,ixo^
l,qt,qdt,fe,sct,s,vcts)
5581 call mpistop(
'choose average, uct_contact,or uct_hll for type_ct!')
5584 end subroutine twofl_update_faces
5587 subroutine update_faces_average(ixI^L,ixO^L,qt,qdt,fC,fE,sCT,s)
5591 integer,
intent(in) :: ixi^
l, ixo^
l
5592 double precision,
intent(in) :: qt, qdt
5593 type(state) :: sct, s
5594 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
5595 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
5597 integer :: hxc^
l,ixc^
l,jxc^
l,ixcm^
l
5598 integer :: idim1,idim2,idir,iwdim1,iwdim2
5599 double precision :: circ(ixi^s,1:
ndim)
5601 double precision,
dimension(ixI^S,sdim:3) :: e_resi
5603 associate(bfaces=>s%ws,x=>s%x)
5609 ixcmin^
d=ixomin^
d-1;
5612 if(
twofl_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
5622 if (
lvc(idim1,idim2,idir)==1)
then
5624 jxc^
l=ixc^
l+
kr(idim1,^
d);
5625 hxc^
l=ixc^
l+
kr(idim2,^
d);
5627 fe(ixc^s,idir)=quarter*(fc(ixc^s,iwdim1,idim2)+fc(jxc^s,iwdim1,idim2)&
5628 -fc(ixc^s,iwdim2,idim1)-fc(hxc^s,iwdim2,idim1))
5631 if(
twofl_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+e_resi(ixc^s,idir)
5632 fe(ixc^s,idir)=qdt*s%dsC(ixc^s,idir)*fe(ixc^s,idir)
5648 circ(ixi^s,1:
ndim)=zero
5656 hxc^
l=ixc^
l-
kr(idim2,^
d);
5658 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
5659 +
lvc(idim1,idim2,idir)&
5669 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
5670 where(s%surfaceC(ixc^s,idim1) > 1.0
d-9*s%dvolume(ixc^s))
5671 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
5673 circ(ixc^s,idim1)=zero
5676 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
5681 end subroutine update_faces_average
5684 subroutine update_faces_contact(ixI^L,ixO^L,qt,qdt,wp,fC,fE,sCT,s,vcts)
5688 integer,
intent(in) :: ixi^
l, ixo^
l
5689 double precision,
intent(in) :: qt, qdt
5691 double precision,
intent(in) :: wp(ixi^s,1:nw)
5692 type(state) :: sct, s
5693 type(ct_velocity) :: vcts
5694 double precision,
intent(in) :: fc(ixi^s,1:nwflux,1:
ndim)
5695 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
5697 double precision :: circ(ixi^s,1:
ndim)
5699 double precision :: ecc(ixi^s,
sdim:3)
5701 double precision :: el(ixi^s),er(ixi^s)
5703 double precision :: elc(ixi^s),erc(ixi^s)
5705 double precision,
dimension(ixI^S,sdim:3) :: e_resi, e_ambi
5707 double precision :: btot(ixi^s,1:
ndim)
5708 integer :: hxc^
l,ixc^
l,jxc^
l,ixa^
l,ixb^
l
5709 integer :: idim1,idim2,idir,iwdim1,iwdim2
5711 associate(bfaces=>s%ws,x=>s%x,w=>s%w,vnorm=>vcts%vnorm)
5716 btot(ixi^s,1:
ndim)=wp(ixi^s,mag(1:
ndim))
5721 if(
lvc(idim1,idim2,idir)==1)
then
5722 ecc(ixi^s,idir)=ecc(ixi^s,idir)+btot(ixi^s,idim1)*wp(ixi^s,
mom_c(idim2))
5723 else if(
lvc(idim1,idim2,idir)==-1)
then
5724 ecc(ixi^s,idir)=ecc(ixi^s,idir)-btot(ixi^s,idim1)*wp(ixi^s,
mom_c(idim2))
5729 if(
twofl_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
5741 if (
lvc(idim1,idim2,idir)==1)
then
5743 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
5745 jxc^
l=ixc^
l+
kr(idim1,^
d);
5746 hxc^
l=ixc^
l+
kr(idim2,^
d);
5748 fe(ixc^s,idir)=quarter*&
5749 (fc(ixc^s,iwdim1,idim2)+fc(jxc^s,iwdim1,idim2)&
5750 -fc(ixc^s,iwdim2,idim1)-fc(hxc^s,iwdim2,idim1))
5754 ixamax^
d=ixcmax^
d+
kr(idim1,^
d);
5755 el(ixa^s)=fc(ixa^s,iwdim1,idim2)-ecc(ixa^s,idir)
5756 hxc^
l=ixa^
l+
kr(idim2,^
d);
5757 er(ixa^s)=fc(ixa^s,iwdim1,idim2)-ecc(hxc^s,idir)
5758 where(vnorm(ixc^s,idim1)>0.d0)
5759 elc(ixc^s)=el(ixc^s)
5760 else where(vnorm(ixc^s,idim1)<0.d0)
5761 elc(ixc^s)=el(jxc^s)
5763 elc(ixc^s)=0.5d0*(el(ixc^s)+el(jxc^s))
5765 hxc^
l=ixc^
l+
kr(idim2,^
d);
5766 where(vnorm(hxc^s,idim1)>0.d0)
5767 erc(ixc^s)=er(ixc^s)
5768 else where(vnorm(hxc^s,idim1)<0.d0)
5769 erc(ixc^s)=er(jxc^s)
5771 erc(ixc^s)=0.5d0*(er(ixc^s)+er(jxc^s))
5773 fe(ixc^s,idir)=fe(ixc^s,idir)+0.25d0*(elc(ixc^s)+erc(ixc^s))
5776 jxc^
l=ixc^
l+
kr(idim2,^
d);
5778 ixamax^
d=ixcmax^
d+
kr(idim2,^
d);
5779 el(ixa^s)=-fc(ixa^s,iwdim2,idim1)-ecc(ixa^s,idir)
5780 hxc^
l=ixa^
l+
kr(idim1,^
d);
5781 er(ixa^s)=-fc(ixa^s,iwdim2,idim1)-ecc(hxc^s,idir)
5782 where(vnorm(ixc^s,idim2)>0.d0)
5783 elc(ixc^s)=el(ixc^s)
5784 else where(vnorm(ixc^s,idim2)<0.d0)
5785 elc(ixc^s)=el(jxc^s)
5787 elc(ixc^s)=0.5d0*(el(ixc^s)+el(jxc^s))
5789 hxc^
l=ixc^
l+
kr(idim1,^
d);
5790 where(vnorm(hxc^s,idim2)>0.d0)
5791 erc(ixc^s)=er(ixc^s)
5792 else where(vnorm(hxc^s,idim2)<0.d0)
5793 erc(ixc^s)=er(jxc^s)
5795 erc(ixc^s)=0.5d0*(er(ixc^s)+er(jxc^s))
5797 fe(ixc^s,idir)=fe(ixc^s,idir)+0.25d0*(elc(ixc^s)+erc(ixc^s))
5800 if(
twofl_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+e_resi(ixc^s,idir)
5802 fe(ixc^s,idir)=fe(ixc^s,idir)*qdt*s%dsC(ixc^s,idir)
5817 circ(ixi^s,1:
ndim)=zero
5822 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
5826 hxc^
l=ixc^
l-
kr(idim2,^
d);
5828 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
5829 +
lvc(idim1,idim2,idir)&
5836 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
5837 where(s%surfaceC(ixc^s,idim1) > 1.0
d-9*s%dvolume(ixc^s))
5838 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
5840 circ(ixc^s,idim1)=zero
5843 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
5848 end subroutine update_faces_contact
5851 subroutine update_faces_hll(ixI^L,ixO^L,qt,qdt,fE,sCT,s,vcts)
5856 integer,
intent(in) :: ixi^
l, ixo^
l
5857 double precision,
intent(in) :: qt, qdt
5858 double precision,
intent(inout) :: fe(ixi^s,
sdim:3)
5859 type(state) :: sct, s
5860 type(ct_velocity) :: vcts
5862 double precision :: vtill(ixi^s,2)
5863 double precision :: vtilr(ixi^s,2)
5864 double precision :: bfacetot(ixi^s,
ndim)
5865 double precision :: btill(s%ixgs^s,
ndim)
5866 double precision :: btilr(s%ixgs^s,
ndim)
5867 double precision :: cp(ixi^s,2)
5868 double precision :: cm(ixi^s,2)
5869 double precision :: circ(ixi^s,1:
ndim)
5871 double precision,
dimension(ixI^S,sdim:3) :: e_resi, e_ambi
5872 integer :: hxc^
l,ixc^
l,ixcp^
l,jxc^
l,ixcm^
l
5873 integer :: idim1,idim2,idir
5875 associate(bfaces=>s%ws,bfacesct=>sct%ws,x=>s%x,vbarc=>vcts%vbarC,cbarmin=>vcts%cbarmin,&
5876 cbarmax=>vcts%cbarmax)
5889 if(
twofl_eta/=zero)
call get_resistive_electric_field(ixi^
l,ixo^
l,sct,s,e_resi)
5903 ixcmin^
d=ixomin^
d-1+
kr(idir,^
d);
5907 idim2=mod(idir+1,3)+1
5909 jxc^
l=ixc^
l+
kr(idim1,^
d);
5910 ixcp^
l=ixc^
l+
kr(idim2,^
d);
5914 vtill(ixi^s,2),vtilr(ixi^s,2))
5917 vtill(ixi^s,1),vtilr(ixi^s,1))
5923 bfacetot(ixi^s,idim1)=bfacesct(ixi^s,idim1)+
block%B0(ixi^s,idim1,idim1)
5924 bfacetot(ixi^s,idim2)=bfacesct(ixi^s,idim2)+
block%B0(ixi^s,idim2,idim2)
5926 bfacetot(ixi^s,idim1)=bfacesct(ixi^s,idim1)
5927 bfacetot(ixi^s,idim2)=bfacesct(ixi^s,idim2)
5930 btill(ixi^s,idim1),btilr(ixi^s,idim1))
5933 btill(ixi^s,idim2),btilr(ixi^s,idim2))
5937 cm(ixc^s,1)=max(cbarmin(ixcp^s,idim1),cbarmin(ixc^s,idim1))
5938 cp(ixc^s,1)=max(cbarmax(ixcp^s,idim1),cbarmax(ixc^s,idim1))
5940 cm(ixc^s,2)=max(cbarmin(jxc^s,idim2),cbarmin(ixc^s,idim2))
5941 cp(ixc^s,2)=max(cbarmax(jxc^s,idim2),cbarmax(ixc^s,idim2))
5945 fe(ixc^s,idir)=-(cp(ixc^s,1)*vtill(ixc^s,1)*btill(ixc^s,idim2) &
5946 + cm(ixc^s,1)*vtilr(ixc^s,1)*btilr(ixc^s,idim2) &
5947 - cp(ixc^s,1)*cm(ixc^s,1)*(btilr(ixc^s,idim2)-btill(ixc^s,idim2)))&
5948 /(cp(ixc^s,1)+cm(ixc^s,1)) &
5949 +(cp(ixc^s,2)*vtill(ixc^s,2)*btill(ixc^s,idim1) &
5950 + cm(ixc^s,2)*vtilr(ixc^s,2)*btilr(ixc^s,idim1) &
5951 - cp(ixc^s,2)*cm(ixc^s,2)*(btilr(ixc^s,idim1)-btill(ixc^s,idim1)))&
5952 /(cp(ixc^s,2)+cm(ixc^s,2))
5955 if(
twofl_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+e_resi(ixc^s,idir)
5956 fe(ixc^s,idir)=qdt*s%dsC(ixc^s,idir)*fe(ixc^s,idir)
5970 circ(ixi^s,1:
ndim)=zero
5976 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
5980 hxc^
l=ixc^
l-
kr(idim2,^
d);
5982 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
5983 +
lvc(idim1,idim2,idir)&
5993 ixcmin^
d=ixomin^
d-
kr(idim1,^
d);
5994 where(s%surfaceC(ixc^s,idim1) > 1.0
d-9*s%dvolume(ixc^s))
5995 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
5997 circ(ixc^s,idim1)=zero
6000 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
6004 end subroutine update_faces_hll
6007 subroutine get_resistive_electric_field(ixI^L,ixO^L,sCT,s,jce)
6012 integer,
intent(in) :: ixi^
l, ixo^
l
6013 type(state),
intent(in) :: sct, s
6015 double precision :: jce(ixi^s,
sdim:3)
6018 double precision :: jcc(ixi^s,7-2*
ndir:3)
6020 double precision :: xs(ixgs^t,1:
ndim)
6022 double precision :: eta(ixi^s)
6023 double precision :: gradi(ixgs^t)
6024 integer :: ix^
d,ixc^
l,ixa^
l,ixb^
l,idir,idirmin,idim1,idim2
6026 associate(x=>s%x,
dx=>s%dx,w=>s%w,wct=>sct%w,wcts=>sct%ws)
6032 if (
lvc(idim1,idim2,idir)==0) cycle
6034 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
6035 ixbmax^
d=ixcmax^
d-
kr(idir,^
d)+1;
6038 xs(ixb^s,:)=x(ixb^s,:)
6039 xs(ixb^s,idim2)=x(ixb^s,idim2)+half*
dx(ixb^s,idim2)
6040 call gradientf(wcts(ixgs^t,idim2),xs,ixgs^
ll,ixc^
l,idim1,gradi,2)
6041 if (
lvc(idim1,idim2,idir)==1)
then
6042 jce(ixc^s,idir)=jce(ixc^s,idir)+gradi(ixc^s)
6044 jce(ixc^s,idir)=jce(ixc^s,idir)-gradi(ixc^s)
6059 ixcmin^
d=ixomin^
d+
kr(idir,^
d)-1;
6060 jcc(ixc^s,idir)=0.d0
6062 if({ ix^
d==1 .and. ^
d==idir | .or.}) cycle
6063 ixamin^
d=ixcmin^
d+ix^
d;
6064 ixamax^
d=ixcmax^
d+ix^
d;
6065 jcc(ixc^s,idir)=jcc(ixc^s,idir)+eta(ixa^s)
6067 jcc(ixc^s,idir)=jcc(ixc^s,idir)*0.25d0
6068 jce(ixc^s,idir)=jce(ixc^s,idir)*jcc(ixc^s,idir)
6073 end subroutine get_resistive_electric_field
6079 integer,
intent(in) :: ixo^
l
6082 integer :: fxo^
l, gxo^
l, hxo^
l, jxo^
l, kxo^
l, idim
6084 associate(w=>s%w, ws=>s%ws)
6091 hxo^
l=ixo^
l-
kr(idim,^
d);
6094 w(ixo^s,mag(idim))=half/s%surface(ixo^s,idim)*&
6095 (ws(ixo^s,idim)*s%surfaceC(ixo^s,idim)&
6096 +ws(hxo^s,idim)*s%surfaceC(hxo^s,idim))
6140 integer,
intent(in) :: ixis^
l, ixi^
l, ixo^
l
6141 double precision,
intent(inout) :: ws(ixis^s,1:nws)
6142 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6144 double precision :: adummy(ixis^s,1:3)
6150 subroutine hyperdiffusivity_get_dt(w,ixI^L,ixO^L,dtnew,dx^D,x)
6153 integer,
intent(in) :: ixi^
l, ixo^
l
6154 double precision,
intent(in) :: w(ixi^s,1:nw)
6155 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6156 double precision,
intent(in) ::
dx^
d
6157 double precision,
intent(inout) :: dtnew
6159 double precision :: nu(ixi^s),tmp(ixi^s),rho(ixi^s),temp(ixi^s)
6160 double precision :: divv(ixi^s,1:
ndim)
6161 double precision :: vel(ixi^s,1:
ndir)
6162 double precision :: csound(ixi^s),csound_dim(ixi^s,1:
ndim)
6163 double precision :: dxarr(
ndim)
6164 double precision :: maxcoef
6165 integer :: ixoo^
l, hxb^
l, hx^
l, ii, jj
6169 maxcoef = smalldouble
6172 call twofl_get_v_c(w,x,ixi^
l,ixi^
l,vel)
6175 csound(ixi^s) = sqrt(csound(ixi^s)) + sqrt(twofl_mag_en_all(w,ixi^
l,ixi^
l) /rho(ixi^s))
6176 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:
ndir)**2 ,dim=
ndim+1))
6181 hxb^
l=hx^
l-
kr(ii,^
d);
6182 csound_dim(hx^s,ii) = (csound(hxb^s)+csound(hx^s))/2d0
6184 call twofl_get_temp_c_pert_from_etot(w, x, ixi^
l, ixi^
l, temp)
6191 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6194 call hyp_coeff(ixi^
l, ixoo^
l, temp(ixi^s), ii, tmp(ixi^s))
6195 nu(ixo^s) =
c_hyp(
e_c_) * csound_dim(ixo^s,ii) *
dxlevel(ii) * tmp(ixo^s) + &
6198 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6202 call hyp_coeff(ixi^
l, ixoo^
l, vel(ixi^s,jj), ii, tmp(ixi^s))
6203 nu(ixo^s) =
c_hyp(
mom_c(jj)) * csound_dim(ixo^s,ii) *
dxlevel(ii) * tmp(ixo^s) + &
6205 nu(ixo^s) = nu(ixo^s) * rho(ixo^s)
6206 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6212 call hyp_coeff(ixi^
l, ixoo^
l, w(ixi^s,mag(jj)), ii, tmp(ixi^s))
6213 nu(ixo^s) =
c_hyp(mag(jj)) * csound_dim(ixo^s,ii) *
dxlevel(ii) * tmp(ixo^s) + &
6215 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6223 call twofl_get_v_n(w,x,ixi^
l,ixi^
l,vel)
6224 call twofl_get_csound_n(w,x,ixi^
l,ixi^
l,csound)
6225 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:
ndir)**2 ,dim=
ndim+1))
6230 hxb^
l=hx^
l-
kr(ii,^
d);
6231 csound_dim(hx^s,ii) = (csound(hxb^s)+csound(hx^s))/2d0
6234 call twofl_get_temp_n_pert_from_etot(w, x, ixi^
l, ixi^
l, temp)
6240 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6243 call hyp_coeff(ixi^
l, ixoo^
l, temp(ixi^s), ii, tmp(ixi^s))
6244 nu(ixo^s) =
c_hyp(
e_n_) * csound_dim(ixo^s,ii) *
dxlevel(ii) * tmp(ixo^s) + &
6247 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6251 call hyp_coeff(ixi^
l, ixoo^
l, vel(ixi^s,jj), ii, tmp(ixi^s))
6252 nu(ixo^s) =
c_hyp(
mom_n(jj)) * csound_dim(ixo^s,ii) *
dxlevel(ii) * tmp(ixo^s) + &
6254 nu(ixo^s) = nu(ixo^s) * rho(ixo^s)
6255 maxcoef = max(maxcoef,maxval(nu(ixo^s)))
6260 end subroutine hyperdiffusivity_get_dt
6262 subroutine add_source_hyperdiffusive(qdt,ixI^L,ixO^L,w,wCT,x)
6266 integer,
intent(in) :: ixi^
l, ixo^
l
6267 double precision,
intent(in) :: qdt, x(ixi^s,1:
ndim)
6268 double precision,
intent(inout) :: w(ixi^s,1:nw)
6269 double precision,
intent(in) :: wct(ixi^s,1:nw)
6271 double precision :: divv(ixi^s,1:
ndim)
6272 double precision :: vel(ixi^s,1:
ndir)
6273 double precision :: csound(ixi^s),csound_dim(ixi^s,1:
ndim)
6274 integer :: ii,ixoo^
l,hxb^
l,hx^
l
6275 double precision :: rho(ixi^s)
6277 call twofl_get_v_c(wct,x,ixi^
l,ixi^
l,vel)
6280 csound(ixi^s) = sqrt(csound(ixi^s)) + sqrt(twofl_mag_en_all(wct,ixi^
l,ixi^
l) /rho(ixi^s))
6281 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:
ndir)**2 ,dim=
ndim+1))
6286 hxb^
l=hx^
l-
kr(ii,^
d);
6287 csound_dim(hx^s,ii) = (csound(hxb^s)+csound(hx^s))/2d0
6290 call add_viscosity_hyper_source(rho,
mom_c(1),
e_c_)
6291 call add_th_cond_c_hyper_source(rho)
6292 call add_ohmic_hyper_source()
6294 call twofl_get_v_n(wct,x,ixi^
l,ixi^
l,vel)
6295 call twofl_get_csound_n(wct,x,ixi^
l,ixi^
l,csound)
6296 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:
ndir)**2 ,dim=
ndim+1))
6301 hxb^
l=hx^
l-
kr(ii,^
d);
6302 csound_dim(hx^s,ii) = (csound(hxb^s)+csound(hx^s))/2d0
6306 call add_viscosity_hyper_source(rho,
mom_n(1),
e_n_)
6307 call add_th_cond_n_hyper_source(rho)
6312 integer,
intent(in) :: index_rho
6314 double precision :: nu(ixI^S), tmp(ixI^S)
6317 call hyp_coeff(ixi^
l, ixoo^
l, wct(ixi^s,index_rho), ii, tmp(ixi^s))
6318 nu(ixoo^s) =
c_hyp(index_rho) * csound_dim(ixoo^s,ii) *
dxlevel(ii) * tmp(ixoo^s) + &
6323 w(ixo^s,index_rho) = w(ixo^s,index_rho) + qdt * tmp(ixo^s)
6328 subroutine add_th_cond_c_hyper_source(var2)
6329 double precision,
intent(in) :: var2(ixI^S)
6330 double precision :: nu(ixI^S), tmp(ixI^S), var(ixI^S)
6331 call twofl_get_temp_c_pert_from_etot(wct, x, ixi^
l, ixi^
l, var)
6333 call hyp_coeff(ixi^
l, ixoo^
l, var(ixi^s), ii, tmp(ixi^s))
6334 nu(ixoo^s) =
c_hyp(
e_c_) * csound_dim(ixoo^s,ii) *
dxlevel(ii) * tmp(ixoo^s) + &
6340 end subroutine add_th_cond_c_hyper_source
6342 subroutine add_th_cond_n_hyper_source(var2)
6343 double precision,
intent(in) :: var2(ixI^S)
6344 double precision :: nu(ixI^S), tmp(ixI^S), var(ixI^S)
6345 call twofl_get_temp_n_pert_from_etot(wct, x, ixi^
l, ixi^
l, var)
6347 call hyp_coeff(ixi^
l, ixoo^
l, var(ixi^s), ii, tmp(ixi^s))
6348 nu(ixoo^s) =
c_hyp(
e_n_) * csound_dim(ixoo^s,ii) *
dxlevel(ii) * tmp(ixoo^s) + &
6354 end subroutine add_th_cond_n_hyper_source
6356 subroutine add_viscosity_hyper_source(rho,index_mom1, index_e)
6357 double precision,
intent(in) :: rho(ixI^S)
6358 integer,
intent(in) :: index_mom1, index_e
6360 double precision :: nu(ixI^S,1:ndir,1:ndim), tmp(ixI^S),tmp2(ixI^S)
6365 call hyp_coeff(ixi^
l, ixoo^
l, vel(ixi^s,jj), ii, tmp(ixi^s))
6366 nu(ixoo^s,jj,ii) =
c_hyp(index_mom1-1+jj) * csound_dim(ixoo^s,ii) *
dxlevel(ii) * tmp(ixoo^s) + &
6367 c_shk(index_mom1-1+jj) * (
dxlevel(ii)**2) *divv(ixoo^s,ii)
6374 call second_same_deriv2(ixi^
l, ixoo^
l, nu(ixi^s,jj,ii), wct(ixi^s,index_mom1-1+jj), vel(ixi^s,jj), ii, tmp2)
6376 w(ixo^s,index_mom1-1+jj) = w(ixo^s,index_mom1-1+jj) + qdt * tmp(ixo^s)
6377 w(ixo^s,index_e) = w(ixo^s,index_e) + qdt * tmp2(ixo^s)
6380 w(ixo^s,index_mom1-1+jj) = w(ixo^s,index_mom1-1+jj) + 0.5*qdt * tmp(ixo^s)
6381 w(ixo^s,index_e) = w(ixo^s,index_e) + 0.5*qdt * tmp2(ixo^s)
6382 call second_cross_deriv2(ixi^
l, ixoo^
l, nu(ixi^s,ii,jj), rho(ixi^s), vel(ixi^s,ii), jj, ii, tmp)
6383 w(ixo^s,index_mom1-1+jj) = w(ixo^s,index_mom1-1+jj) + 0.5*qdt * tmp(ixo^s)
6384 call second_cross_deriv2(ixi^
l, ixoo^
l, nu(ixi^s,jj,ii), wct(ixi^s,index_mom1-1+jj), vel(ixi^s,jj), ii, jj, tmp2)
6385 w(ixo^s,index_e) = w(ixo^s,index_e) + 0.5*qdt * tmp2(ixo^s)
6391 end subroutine add_viscosity_hyper_source
6393 subroutine add_ohmic_hyper_source()
6394 double precision :: nu(ixI^S,1:ndir,1:ndim), tmp(ixI^S)
6400 call hyp_coeff(ixi^
l, ixoo^
l, wct(ixi^s,mag(jj)), ii, tmp(ixi^s))
6401 nu(ixoo^s,jj,ii) =
c_hyp(mag(jj)) * csound_dim(ixoo^s,ii) *
dxlevel(ii) * tmp(ixoo^s) + &
6412 w(ixo^s,mag(jj)) = w(ixo^s,mag(jj)) + qdt * tmp(ixo^s)
6414 w(ixo^s,mag(jj)) = w(ixo^s,mag(jj)) + qdt * tmp(ixo^s)
6417 w(ixo^s,
e_c_) = w(ixo^s,
e_c_) + qdt * tmp(ixo^s)
6418 call second_cross_deriv2(ixi^
l, ixoo^
l, nu(ixi^s,ii,jj), wct(ixi^s,mag(jj)), wct(ixi^s,mag(ii)), jj, ii, tmp)
6419 w(ixo^s,
e_c_) = w(ixo^s,
e_c_) + qdt * tmp(ixo^s)
6425 end subroutine add_ohmic_hyper_source
6427 end subroutine add_source_hyperdiffusive
6429 function dump_hyperdiffusivity_coef_x(ixI^L,ixO^L, w, x, nwc)
result(wnew)
6432 integer,
intent(in) :: ixI^L, ixO^L, nwc
6433 double precision,
intent(in) :: w(ixI^S, 1:nw)
6434 double precision,
intent(in) :: x(ixI^S,1:ndim)
6435 double precision :: wnew(ixO^S, 1:nwc)
6437 if(nw .ne. nwc)
call mpistop(
"nw != nwc")
6438 wnew(ixo^s,1:nw) = dump_hyperdiffusivity_coef_dim(ixi^l,ixo^l, w, x, 1)
6440 end function dump_hyperdiffusivity_coef_x
6442 function dump_hyperdiffusivity_coef_y(ixI^L,ixO^L, w, x, nwc)
result(wnew)
6445 integer,
intent(in) :: ixI^L, ixO^L, nwc
6446 double precision,
intent(in) :: w(ixI^S, 1:nw)
6447 double precision,
intent(in) :: x(ixI^S,1:ndim)
6448 double precision :: wnew(ixO^S, 1:nwc)
6450 if(nw .ne. nwc)
call mpistop(
"nw != nwc")
6451 wnew(ixo^s,1:nw) = dump_hyperdiffusivity_coef_dim(ixi^l,ixo^l, w, x, 2)
6453 end function dump_hyperdiffusivity_coef_y
6455 function dump_hyperdiffusivity_coef_z(ixI^L,ixO^L, w, x, nwc)
result(wnew)
6458 integer,
intent(in) :: ixI^L, ixO^L, nwc
6459 double precision,
intent(in) :: w(ixI^S, 1:nw)
6460 double precision,
intent(in) :: x(ixI^S,1:ndim)
6461 double precision :: wnew(ixO^S, 1:nwc)
6463 if(nw .ne. nwc)
call mpistop(
"nw != nwc")
6464 wnew(ixo^s,1:nw) = dump_hyperdiffusivity_coef_dim(ixi^l,ixo^l, w, x, 3)
6466 end function dump_hyperdiffusivity_coef_z
6468 function dump_hyperdiffusivity_coef_dim(ixI^L,ixOP^L, w, x, ii)
result(wnew)
6471 integer,
intent(in) :: ixI^L, ixOP^L, ii
6472 double precision,
intent(in) :: w(ixI^S, 1:nw)
6473 double precision,
intent(in) :: x(ixI^S,1:ndim)
6474 double precision :: wnew(ixOP^S, 1:nw)
6476 double precision :: nu(ixI^S),tmp(ixI^S),rho(ixI^S),temp(ixI^S)
6477 double precision :: divv(ixI^S)
6478 double precision :: vel(ixI^S,1:ndir)
6479 double precision :: csound(ixI^S),csound_dim(ixI^S)
6480 double precision :: dxarr(ndim)
6481 integer :: ixOO^L, hxb^L, hx^L, jj, ixO^L
6484 ixomin^
d=max(ixopmin^
d,iximin^
d+3);
6485 ixomax^
d=min(ixopmax^
d,iximax^
d-3);
6487 wnew(ixop^s,1:nw) = 0d0
6490 call twofl_get_temp_c_pert_from_etot(w, x, ixi^l, ixi^l, temp)
6491 call twofl_get_v_c(w,x,ixi^l,ixi^l,vel)
6494 csound(ixi^s) = sqrt(csound(ixi^s)) + sqrt(twofl_mag_en_all(w,ixi^l,ixi^l) /rho(ixi^s))
6495 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:ndir)**2 ,dim=ndim+1))
6500 hxb^l=hx^l-
kr(ii,^
d);
6501 csound_dim(hx^s) = (csound(hxb^s)+csound(hx^s))/2d0
6509 wnew(ixo^s,
rho_c_) = nu(ixo^s)
6512 call hyp_coeff(ixi^l, ixoo^l, temp(ixi^s), ii, tmp(ixi^s))
6516 wnew(ixo^s,
e_c_) = nu(ixo^s)
6520 call hyp_coeff(ixi^l, ixoo^l, vel(ixi^s,jj), ii, tmp(ixi^s))
6523 nu(ixo^s) = nu(ixo^s) * rho(ixo^s)
6524 wnew(ixo^s,
mom_c(jj)) = nu(ixo^s)
6530 call hyp_coeff(ixi^l, ixoo^l, w(ixi^s,mag(jj)), ii, tmp(ixi^s))
6531 nu(ixo^s) =
c_hyp(mag(jj)) * csound_dim(ixo^s) *
dxlevel(ii) * tmp(ixo^s) + &
6533 wnew(ixo^s,mag(jj)) = nu(ixo^s)
6541 call twofl_get_temp_n_pert_from_etot(w, x, ixi^l, ixi^l, temp)
6542 call twofl_get_v_n(w,x,ixi^l,ixi^l,vel)
6543 call twofl_get_csound_n(w,x,ixi^l,ixi^l,csound)
6544 csound(ixi^s) = csound(ixi^s) + sqrt(sum(vel(ixi^s,1:ndir)**2 ,dim=ndim+1))
6547 hxb^l=ixoo^l-
kr(ii,^
d);
6548 csound_dim(ixoo^s) = (csound(hxb^s)+csound(ixoo^s))/2d0
6553 wnew(ixo^s,
rho_n_) = nu(ixo^s)
6556 call hyp_coeff(ixi^l, ixoo^l, temp(ixi^s), ii, tmp(ixi^s))
6560 wnew(ixo^s,
e_n_) = nu(ixo^s)
6564 call hyp_coeff(ixi^l, ixoo^l, vel(ixi^s,jj), ii, tmp(ixi^s))
6567 nu(ixo^s) = nu(ixo^s) * rho(ixo^s)
6568 wnew(ixo^s,
mom_n(jj)) = nu(ixo^s)
6572 end function dump_hyperdiffusivity_coef_dim
6574 function dump_coll_terms(ixI^L,ixO^L, w, x, nwc)
result(wnew)
6576 integer,
intent(in) :: ixI^L,ixO^L, nwc
6577 double precision,
intent(in) :: w(ixI^S, 1:nw)
6578 double precision,
intent(in) :: x(ixI^S,1:ndim)
6579 double precision :: wnew(ixO^S, 1:nwc)
6580 double precision :: tmp(ixI^S),tmp2(ixI^S)
6583 wnew(ixo^s,1)= tmp(ixo^s)
6585 wnew(ixo^s,2)= tmp(ixo^s)
6586 wnew(ixo^s,3)= tmp2(ixo^s)
6588 end function dump_coll_terms
6593 integer,
intent(in) :: ixi^
l, ixo^
l
6594 double precision,
intent(in) :: w(ixi^s,1:nw)
6595 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6596 double precision,
intent(out) :: gamma_rec(ixi^s),gamma_ion(ixi^s)
6598 double precision,
parameter :: a = 2.91e-14, &
6602 double precision,
parameter :: echarge=1.6022
d-19
6603 double precision :: rho(ixi^s), tmp(ixi^s)
6607 tmp(ixo^s) = tmp(ixo^s)/(
rc * rho(ixo^s))
6615 rho(ixo^s) = rho(ixo^s) * 1d6
6617 gamma_rec(ixo^s) = rho(ixo^s) /sqrt(tmp(ixo^s)) * 2.6e-19
6618 gamma_ion(ixo^s) = ((rho(ixo^s) * a) /(xx + eion/tmp(ixo^s))) * ((eion/tmp(ixo^s))**k) * exp(-eion/tmp(ixo^s))
6621 gamma_rec(ixo^s) = gamma_rec(ixo^s) *
unit_time
6622 gamma_ion(ixo^s) = gamma_ion(ixo^s) *
unit_time
6631 integer,
intent(in) :: ixi^
l, ixo^
l
6632 double precision,
intent(in) :: w(ixi^s,1:nw)
6633 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6634 double precision,
intent(out) :: alpha(ixi^s)
6638 call get_alpha_coll_plasma(ixi^
l, ixo^
l, w, x, alpha)
6645 subroutine get_alpha_coll_plasma(ixI^L, ixO^L, w, x, alpha)
6647 integer,
intent(in) :: ixi^
l, ixo^
l
6648 double precision,
intent(in) :: w(ixi^s,1:nw)
6649 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6650 double precision,
intent(out) :: alpha(ixi^s)
6651 double precision :: pe(ixi^s),rho(ixi^s), tmp(ixi^s), tmp2(ixi^s)
6653 double precision :: sigma_in = 1e-19
6658 tmp(ixo^s) = pe(ixo^s)/(
rc * rho(ixo^s))
6661 tmp2(ixo^s) = pe(ixo^s)/(
rn * rho(ixo^s))
6664 alpha(ixo^s) = alpha(ixo^s) * 1d3
6667 end subroutine get_alpha_coll_plasma
6669 subroutine calc_mult_factor1(ixI^L, ixO^L, step_dt, JJ, res)
6670 integer,
intent(in) :: ixi^l, ixo^l
6671 double precision,
intent(in) :: step_dt
6672 double precision,
intent(in) :: jj(ixi^s)
6673 double precision,
intent(out) :: res(ixi^s)
6675 res(ixo^s) = step_dt/(1d0 + step_dt * jj(ixo^s))
6677 end subroutine calc_mult_factor1
6679 subroutine calc_mult_factor2(ixI^L, ixO^L, step_dt, JJ, res)
6680 integer,
intent(in) :: ixi^l, ixo^l
6681 double precision,
intent(in) :: step_dt
6682 double precision,
intent(in) :: jj(ixi^s)
6683 double precision,
intent(out) :: res(ixi^s)
6685 res(ixo^s) = (1d0 - exp(-step_dt * jj(ixo^s)))/jj(ixo^s)
6687 end subroutine calc_mult_factor2
6689 subroutine advance_implicit_grid(ixI^L, ixO^L, w, wout, x, dtfactor,qdt)
6691 integer,
intent(in) :: ixi^
l, ixo^
l
6692 double precision,
intent(in) :: qdt
6693 double precision,
intent(in) :: dtfactor
6694 double precision,
intent(in) :: w(ixi^s,1:nw)
6695 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6696 double precision,
intent(out) :: wout(ixi^s,1:nw)
6699 double precision :: tmp(ixi^s),tmp1(ixi^s),tmp2(ixi^s),tmp3(ixi^s),tmp4(ixi^s),tmp5(ixi^s)
6700 double precision :: v_c(ixi^s,
ndir), v_n(ixi^s,
ndir)
6701 double precision :: rhon(ixi^s), rhoc(ixi^s), alpha(ixi^s)
6702 double precision,
allocatable :: gamma_rec(:^
d&), gamma_ion(:^D&)
6708 wout(ixo^s,mag(:)) = w(ixo^s,mag(:))
6714 allocate(gamma_ion(ixi^s), gamma_rec(ixi^s))
6716 tmp2(ixo^s) = gamma_rec(ixo^s) + gamma_ion(ixo^s)
6717 call calc_mult_factor(ixi^
l, ixo^
l, dtfactor * qdt, tmp2, tmp3)
6718 tmp(ixo^s) = (-gamma_ion(ixo^s) * rhon(ixo^s) + &
6719 gamma_rec(ixo^s) * rhoc(ixo^s))
6720 wout(ixo^s,
rho_n_) = w(ixo^s,
rho_n_) + tmp(ixo^s) * tmp3(ixo^s)
6721 wout(ixo^s,
rho_c_) = w(ixo^s,
rho_c_) - tmp(ixo^s) * tmp3(ixo^s)
6730 tmp2(ixo^s) = alpha(ixo^s) * (rhon(ixo^s) + rhoc(ixo^s))
6732 tmp2(ixo^s) = tmp2(ixo^s) + gamma_ion(ixo^s) + gamma_rec(ixo^s)
6734 call calc_mult_factor(ixi^
l, ixo^
l, dtfactor * qdt, tmp2, tmp3)
6739 tmp(ixo^s) = alpha(ixo^s)* (-rhoc(ixo^s) * w(ixo^s,
mom_n(idir)) + rhon(ixo^s) * w(ixo^s,
mom_c(idir)))
6741 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * w(ixo^s,
mom_n(idir)) + gamma_rec(ixo^s) * w(ixo^s,
mom_c(idir))
6744 wout(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir)) + tmp(ixo^s) * tmp3(ixo^s)
6745 wout(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir)) - tmp(ixo^s) * tmp3(ixo^s)
6751 if(.not. phys_internal_e)
then
6753 tmp1(ixo^s) = twofl_kin_en_n(w,ixi^
l,ixo^
l)
6754 tmp2(ixo^s) = twofl_kin_en_c(w,ixi^
l,ixo^
l)
6755 tmp4(ixo^s) = w(ixo^s,
e_n_) - tmp1(ixo^s)
6756 tmp5(ixo^s) = w(ixo^s,
e_c_) - tmp2(ixo^s)
6757 if(phys_total_energy)
then
6758 tmp5(ixo^s) = tmp5(ixo^s) - twofl_mag_en(w,ixi^
l,ixo^
l)
6762 tmp(ixo^s) = alpha(ixo^s)*(-rhoc(ixo^s) * tmp1(ixo^s) + rhon(ixo^s) * tmp2(ixo^s))
6764 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * tmp1(ixo^s) + gamma_rec(ixo^s) * tmp2(ixo^s)
6767 wout(ixo^s,
e_n_) = w(ixo^s,
e_n_) + tmp(ixo^s) * tmp3(ixo^s)
6768 wout(ixo^s,
e_c_) = w(ixo^s,
e_c_) - tmp(ixo^s) * tmp3(ixo^s)
6771 tmp4(ixo^s) = w(ixo^s,
e_n_)
6772 tmp5(ixo^s) = w(ixo^s,
e_c_)
6774 call twofl_get_v_n(wout,x,ixi^
l,ixo^
l,v_n)
6775 call twofl_get_v_c(wout,x,ixi^
l,ixo^
l,v_c)
6776 tmp1(ixo^s) = alpha(ixo^s) * rhoc(ixo^s) * rhon(ixo^s)
6777 tmp2(ixo^s) = tmp1(ixo^s)
6779 tmp1(ixo^s) = tmp1(ixo^s) + rhoc(ixo^s) * gamma_rec(ixo^s)
6780 tmp2(ixo^s) = tmp2(ixo^s) + rhon(ixo^s) * gamma_ion(ixo^s)
6783 tmp(ixo^s) = 0.5d0 * sum((v_c(ixo^s,1:
ndir) - v_n(ixo^s,1:
ndir))**2, dim=
ndim+1) &
6785 wout(ixo^s,
e_n_) = w(ixo^s,
e_n_) + tmp(ixo^s)*tmp1(ixo^s)
6786 wout(ixo^s,
e_c_) = w(ixo^s,
e_c_) + tmp(ixo^s)*tmp2(ixo^s)
6798 tmp(ixo^s) = alpha(ixo^s) *(-1d0/
rn*(rhoc(ixo^s) * tmp4(ixo^s) + &
6799 tmp2(ixo^s)*w(ixo^s,
rho_c_)) + 1d0/
rc*(rhon(ixo^s) * tmp5(ixo^s) +&
6800 tmp3(ixo^s)*w(ixo^s,
rho_n_)))
6803 tmp4(ixo^s) = tmp2(ixo^s) + tmp4(ixo^s)
6806 tmp5(ixo^s) = tmp3(ixo^s) + tmp5(ixo^s)
6809 tmp(ixo^s) = alpha(ixo^s) *(-rhoc(ixo^s)/
rn * tmp4(ixo^s) + rhon(ixo^s)/
rc * tmp5(ixo^s))
6811 tmp2(ixo^s) = alpha(ixo^s) * (rhon(ixo^s)/
rc + rhoc(ixo^s)/
rn)
6813 tmp2(ixo^s) = tmp2(ixo^s) + gamma_rec(ixo^s)/
rc + gamma_ion(ixo^s)/
rn
6814 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s)/
rn * tmp4(ixo^s) + gamma_rec(ixo^s)/
rc * tmp5(ixo^s)
6816 call calc_mult_factor(ixi^
l, ixo^
l, dtfactor * qdt, tmp2, tmp3)
6817 wout(ixo^s,
e_n_) = wout(ixo^s,
e_n_)+tmp(ixo^s)*tmp3(ixo^s)
6818 wout(ixo^s,
e_c_) = wout(ixo^s,
e_c_)-tmp(ixo^s)*tmp3(ixo^s)
6821 deallocate(gamma_ion, gamma_rec)
6823 end subroutine advance_implicit_grid
6826 subroutine twofl_implicit_coll_terms_update(dtfactor,qdt,qtC,psb,psa)
6832 double precision,
intent(in) :: qdt
6833 double precision,
intent(in) :: qtc
6834 double precision,
intent(in) :: dtfactor
6836 integer :: iigrid, igrid
6841 do iigrid=1,igridstail; igrid=igrids(iigrid);
6844 call advance_implicit_grid(ixg^
ll, ixg^
ll, psa(igrid)%w, psb(igrid)%w, psa(igrid)%x, dtfactor,qdt)
6848 end subroutine twofl_implicit_coll_terms_update
6851 subroutine twofl_evaluate_implicit(qtC,psa)
6854 double precision,
intent(in) :: qtc
6856 integer :: iigrid, igrid, level
6859 do iigrid=1,igridstail; igrid=igrids(iigrid);
6862 call coll_terms(ixg^
ll,
ixm^
ll,psa(igrid)%w,psa(igrid)%x)
6866 end subroutine twofl_evaluate_implicit
6868 subroutine coll_terms(ixI^L,ixO^L,w,x)
6870 integer,
intent(in) :: ixi^
l, ixo^
l
6871 double precision,
intent(inout) :: w(ixi^s, 1:nw)
6872 double precision,
intent(in) :: x(ixi^s,1:
ndim)
6875 double precision :: tmp(ixi^s),tmp1(ixi^s),tmp2(ixi^s),tmp3(ixi^s),tmp4(ixi^s),tmp5(ixi^s)
6877 double precision,
allocatable :: v_c(:^
d&,:), v_n(:^D&,:)
6878 double precision,
allocatable :: rho_c1(:^
d&), rho_n1(:^D&)
6879 double precision :: rhon(ixi^s), rhoc(ixi^s), alpha(ixi^s)
6880 double precision,
allocatable :: gamma_rec(:^
d&), gamma_ion(:^D&)
6884 allocate(rho_n1(ixi^s), rho_c1(ixi^s))
6885 rho_n1(ixo^s) = w(ixo^s,
rho_n_)
6886 rho_c1(ixo^s) = w(ixo^s,
rho_c_)
6892 if(phys_internal_e)
then
6894 allocate(v_n(ixi^s,
ndir), v_c(ixi^s,
ndir))
6895 call twofl_get_v_n(w,x,ixi^
l,ixo^
l,v_n)
6896 call twofl_get_v_c(w,x,ixi^
l,ixo^
l,v_c)
6899 tmp1(ixo^s) = twofl_kin_en_n(w,ixi^
l,ixo^
l)
6900 tmp2(ixo^s) = twofl_kin_en_c(w,ixi^
l,ixo^
l)
6905 allocate(gamma_ion(ixi^s), gamma_rec(ixi^s))
6907 tmp(ixo^s) = -gamma_ion(ixo^s) * rhon(ixo^s) + &
6908 gamma_rec(ixo^s) * rhoc(ixo^s)
6909 w(ixo^s,
rho_n_) = tmp(ixo^s)
6910 w(ixo^s,
rho_c_) = -tmp(ixo^s)
6922 tmp(ixo^s) = alpha(ixo^s)* (-rhoc(ixo^s) * w(ixo^s,
mom_n(idir)) + rhon(ixo^s) * w(ixo^s,
mom_c(idir)))
6924 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * w(ixo^s,
mom_n(idir)) + gamma_rec(ixo^s) * w(ixo^s,
mom_c(idir))
6927 w(ixo^s,
mom_n(idir)) = tmp(ixo^s)
6928 w(ixo^s,
mom_c(idir)) = -tmp(ixo^s)
6934 if(.not. phys_internal_e)
then
6936 tmp4(ixo^s) = w(ixo^s,
e_n_) - tmp1(ixo^s)
6937 tmp5(ixo^s) = w(ixo^s,
e_c_) - tmp2(ixo^s)
6938 if(phys_total_energy)
then
6939 tmp5(ixo^s) = tmp5(ixo^s) - twofl_mag_en(w,ixi^
l,ixo^
l)
6943 tmp(ixo^s) = alpha(ixo^s)*(-rhoc(ixo^s) * tmp1(ixo^s) + rhon(ixo^s) * tmp2(ixo^s))
6945 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * tmp1(ixo^s) + gamma_rec(ixo^s) * tmp2(ixo^s)
6948 w(ixo^s,
e_n_) = tmp(ixo^s)
6949 w(ixo^s,
e_c_) = -tmp(ixo^s)
6952 tmp4(ixo^s) = w(ixo^s,
e_n_)
6953 tmp5(ixo^s) = w(ixo^s,
e_c_)
6954 tmp1(ixo^s) = alpha(ixo^s) * rhoc(ixo^s) * rhon(ixo^s)
6955 tmp2(ixo^s) = tmp1(ixo^s)
6957 tmp1(ixo^s) = tmp1(ixo^s) + rhoc(ixo^s) * gamma_rec(ixo^s)
6958 tmp2(ixo^s) = tmp2(ixo^s) + rhon(ixo^s) * gamma_ion(ixo^s)
6961 tmp(ixo^s) = 0.5d0 * sum((v_c(ixo^s,1:
ndir) - v_n(ixo^s,1:
ndir))**2, dim=
ndim+1)
6962 w(ixo^s,
e_n_) = tmp(ixo^s)*tmp1(ixo^s)
6963 w(ixo^s,
e_c_) = tmp(ixo^s)*tmp2(ixo^s)
6976 tmp(ixo^s) = alpha(ixo^s) *(-1d0/
rn*(rhoc(ixo^s) * tmp4(ixo^s) + &
6977 tmp2(ixo^s)*rho_c1(ixo^s)) + 1d0/
rc*(rhon(ixo^s) * tmp5(ixo^s) +&
6978 tmp3(ixo^s)*rho_n1(ixo^s)))
6981 tmp4(ixo^s) = tmp2(ixo^s) + tmp4(ixo^s)
6984 tmp5(ixo^s) = tmp3(ixo^s) + tmp5(ixo^s)
6987 tmp(ixo^s) = alpha(ixo^s) *(-rhoc(ixo^s)/
rn * tmp4(ixo^s) + rhon(ixo^s)/
rc * tmp5(ixo^s))
6991 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s)/
rn * tmp4(ixo^s) + gamma_rec(ixo^s)/
rc * tmp5(ixo^s)
6994 w(ixo^s,
e_n_) = w(ixo^s,
e_n_)+tmp(ixo^s)
6995 w(ixo^s,
e_c_) = w(ixo^s,
e_c_)-tmp(ixo^s)
6998 deallocate(gamma_ion, gamma_rec)
7000 if(phys_internal_e)
then
7001 deallocate(v_n, v_c)
7004 deallocate(rho_n1, rho_c1)
7007 w(ixo^s,mag(1:
ndir)) = 0d0
7009 end subroutine coll_terms
7011 subroutine twofl_explicit_coll_terms_update(qdt,ixI^L,ixO^L,w,wCT,x)
7014 integer,
intent(in) :: ixi^
l, ixo^
l
7015 double precision,
intent(in) :: qdt, x(ixi^s,1:
ndim)
7016 double precision,
intent(inout) :: w(ixi^s,1:nw)
7017 double precision,
intent(in) :: wct(ixi^s,1:nw)
7020 double precision :: tmp(ixi^s),tmp1(ixi^s),tmp2(ixi^s),tmp3(ixi^s),tmp4(ixi^s),tmp5(ixi^s)
7021 double precision :: v_c(ixi^s,
ndir), v_n(ixi^s,
ndir)
7022 double precision :: rhon(ixi^s), rhoc(ixi^s), alpha(ixi^s)
7023 double precision,
allocatable :: gamma_rec(:^
d&), gamma_ion(:^D&)
7029 allocate(gamma_ion(ixi^s), gamma_rec(ixi^s))
7031 tmp(ixo^s) = qdt *(-gamma_ion(ixo^s) * rhon(ixo^s) + &
7032 gamma_rec(ixo^s) * rhoc(ixo^s))
7042 tmp(ixo^s) = alpha(ixo^s)* (-rhoc(ixo^s) * wct(ixo^s,
mom_n(idir)) + rhon(ixo^s) * wct(ixo^s,
mom_c(idir)))
7044 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * wct(ixo^s,
mom_n(idir)) + gamma_rec(ixo^s) * wct(ixo^s,
mom_c(idir))
7046 tmp(ixo^s) =tmp(ixo^s) * qdt
7048 w(ixo^s,
mom_n(idir)) = w(ixo^s,
mom_n(idir)) + tmp(ixo^s)
7049 w(ixo^s,
mom_c(idir)) = w(ixo^s,
mom_c(idir)) - tmp(ixo^s)
7055 if(.not. phys_internal_e)
then
7057 tmp1(ixo^s) = twofl_kin_en_n(wct,ixi^
l,ixo^
l)
7058 tmp2(ixo^s) = twofl_kin_en_c(wct,ixi^
l,ixo^
l)
7059 tmp4(ixo^s) = wct(ixo^s,
e_n_) - tmp1(ixo^s)
7060 tmp5(ixo^s) = wct(ixo^s,
e_c_) - tmp2(ixo^s)
7061 if(phys_total_energy)
then
7062 tmp5(ixo^s) = tmp5(ixo^s) - twofl_mag_en(wct,ixi^
l,ixo^
l)
7065 tmp(ixo^s) = alpha(ixo^s)*(-rhoc(ixo^s) * tmp1(ixo^s) + rhon(ixo^s) * tmp2(ixo^s))
7067 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s) * tmp1(ixo^s) + gamma_rec(ixo^s) * tmp2(ixo^s)
7069 tmp(ixo^s) =tmp(ixo^s) * qdt
7071 w(ixo^s,
e_n_) = w(ixo^s,
e_n_) + tmp(ixo^s)
7072 w(ixo^s,
e_c_) = w(ixo^s,
e_c_) - tmp(ixo^s)
7075 tmp4(ixo^s) = w(ixo^s,
e_n_)
7076 tmp5(ixo^s) = w(ixo^s,
e_c_)
7077 call twofl_get_v_n(wct,x,ixi^
l,ixo^
l,v_n)
7078 call twofl_get_v_c(wct,x,ixi^
l,ixo^
l,v_c)
7079 tmp1(ixo^s) = alpha(ixo^s) * rhoc(ixo^s) * rhon(ixo^s)
7080 tmp2(ixo^s) = tmp1(ixo^s)
7082 tmp1(ixo^s) = tmp1(ixo^s) + rhoc(ixo^s) * gamma_rec(ixo^s)
7083 tmp2(ixo^s) = tmp2(ixo^s) + rhon(ixo^s) * gamma_ion(ixo^s)
7086 tmp(ixo^s) = 0.5d0 * sum((v_c(ixo^s,1:
ndir) - v_n(ixo^s,1:
ndir))**2, dim=
ndim+1) * qdt
7087 w(ixo^s,
e_n_) = w(ixo^s,
e_n_) + tmp(ixo^s)*tmp1(ixo^s)
7088 w(ixo^s,
e_c_) = w(ixo^s,
e_c_) + tmp(ixo^s)*tmp2(ixo^s)
7100 tmp(ixo^s) = alpha(ixo^s) *(-1d0/
rn*(rhoc(ixo^s) * tmp4(ixo^s) + &
7101 tmp2(ixo^s)*wct(ixo^s,
rho_c_)) + 1d0/
rc*(rhon(ixo^s) * tmp5(ixo^s) +&
7102 tmp3(ixo^s)*wct(ixo^s,
rho_n_)))
7105 tmp4(ixo^s) = tmp2(ixo^s) + tmp4(ixo^s)
7108 tmp5(ixo^s) = tmp3(ixo^s) + tmp5(ixo^s)
7111 tmp(ixo^s) = alpha(ixo^s) *(-rhoc(ixo^s)/
rn * tmp4(ixo^s) + rhon(ixo^s)/
rc * tmp5(ixo^s))
7115 tmp(ixo^s) = tmp(ixo^s) - gamma_ion(ixo^s)/
rn * tmp4(ixo^s) + gamma_rec(ixo^s)/
rc * tmp5(ixo^s)
7118 tmp(ixo^s) =tmp(ixo^s) * qdt
7120 w(ixo^s,
e_n_) = w(ixo^s,
e_n_)+tmp(ixo^s)
7121 w(ixo^s,
e_c_) = w(ixo^s,
e_c_)-tmp(ixo^s)
7124 deallocate(gamma_ion, gamma_rec)
7126 end subroutine twofl_explicit_coll_terms_update
7128 subroutine rfactor_c(w,x,ixI^L,ixO^L,Rfactor)
7130 integer,
intent(in) :: ixi^
l, ixo^
l
7131 double precision,
intent(in) :: w(ixi^s,1:nw)
7132 double precision,
intent(in) :: x(ixi^s,1:
ndim)
7133 double precision,
intent(out):: rfactor(ixi^s)
7137 end subroutine rfactor_c
subroutine twofl_get_p_c_total(w, x, ixil, ixol, p)
subroutine twofl_get_csound2_primitive(w, x, ixil, ixol, csound2)
subroutine add_density_hyper_source(index_rho)
subroutine, public mpistop(message)
Exit MPI-AMRVAC with an error message.
Module for physical and numeric constants.
double precision, parameter bigdouble
A very large real number.
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.
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)
update ghost cells of all blocks including physical boundaries
subroutine getbc(time, qdt, psb, nwstart, nwbc)
do update ghost cells of all blocks including physical boundaries
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.
logical h_correction
If true, do H-correction to fix the carbuncle problem at grid-aligned shocks.
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.
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.
integer, parameter unitpar
file handle for IO
integer, parameter bc_asymm
double precision global_time
The global simulation time.
double precision unit_mass
Physical scaling factor for mass.
logical use_imex_scheme
whether IMEX in use or not
integer, dimension(3, 3) kr
Kronecker delta tensor.
double precision phys_trac_mask
integer it
Number of time steps taken.
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
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
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.
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
logical crash
Save a snapshot before crash a run met unphysical values.
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, parameter unitconvert
integer number_equi_vars
number of equilibrium set variables, besides the mag field
logical check_small_values
check and optionally fix unphysical small values (density, gas pressure)
integer, parameter ixglo
Lower index of grid block arrays (always 1)
Subroutines for Roe-type Riemann solver for HD.
subroutine second_same_deriv(ixil, ixol, nu_hyper, var, idimm, res)
subroutine div_vel_coeff(ixil, ixol, vel, idimm, nu_vel)
subroutine second_cross_deriv2(ixil, ixol, nu_hyper, var2, var, idimm, idimm2, res)
subroutine hyp_coeff(ixil, ixol, var, idimm, nu_hyp)
subroutine second_cross_deriv(ixil, ixol, nu_hyper, var, idimm, idimm2, res)
subroutine hyperdiffusivity_init()
subroutine second_same_deriv2(ixil, ixol, nu_hyper, var2, var, idimm, res)
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.
This module defines the procedures of a physics module. It contains function pointers for the various...
module radiative cooling – add optically thin radiative cooling for HD and MHD
subroutine radiative_cooling_init_params(phys_gamma, he_abund)
Radiative cooling initialization.
subroutine cooling_get_dt(w, ixil, ixol, dtnew, dxd, x, fl)
subroutine radiative_cooling_init(fl, read_params)
subroutine radiative_cooling_add_source(qdt, ixil, ixol, wct, wctprim, w, x, qsourcesplit, active, fl)
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_...
subroutine, public tc_get_hd_params(fl, read_hd_params)
Init TC coefficients: HD case.
double precision function, public get_tc_dt_mhd(w, ixil, ixol, dxd, x, fl)
Get the explicut timestep for the TC (mhd implementation)
double precision function, public get_tc_dt_hd(w, ixil, ixol, dxd, x, fl)
Get the explicit timestep for the TC (hd implementation)
subroutine tc_init_params(phys_gamma)
subroutine, public sts_set_source_tc_hd(ixil, ixol, w, x, wres, fix_conserve_at_step, my_dt, igrid, nflux, fl)
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)
Magneto-hydrodynamics module.
logical, public twofl_coll_inc_ionrec
whether include ionization/recombination inelastic collisional terms
subroutine, public b_from_vector_potential(ixisl, ixil, ixol, ws, x)
calculate magnetic field from vector potential
logical, public, protected twofl_dump_full_vars
whether dump full variables (when splitting is used) in a separate dat file
subroutine, public get_gamma_ion_rec(ixil, ixol, w, x, gamma_rec, gamma_ion)
subroutine, public twofl_get_v_c_idim(w, x, ixil, ixol, idim, v)
Calculate v_c component.
double precision, public, protected rn
logical, public clean_initial_divb
clean initial divB
double precision, public twofl_eta_hyper
The MHD hyper-resistivity.
subroutine, public twofl_get_csound2_c_from_conserved(w, x, ixil, ixol, csound2)
double precision, public twofl_eta
The MHD resistivity.
integer, public, protected twofl_trac_type
Which TRAC method is used
logical, public has_equi_pe_c0
type(tc_fluid), allocatable, public tc_fl_c
logical, public twofl_alpha_coll_constant
double precision, dimension(:), allocatable, public, protected c_shk
subroutine, public twofl_face_to_center(ixol, s)
calculate cell-center values from face-center values
logical, public, protected twofl_dump_hyperdiffusivity_coef
double precision, public twofl_glm_alpha
GLM-MHD parameter: ratio of the diffusive and advective time scales for div b taking values within [0...
integer, parameter, public eq_energy_ki
logical, public, protected twofl_thermal_conduction_n
subroutine, public twofl_phys_init()
subroutine, public get_rhon_tot(w, x, ixil, ixol, rhon)
logical, public, protected twofl_thermal_conduction_c
Whether thermal conduction is used.
double precision, public twofl_adiab
The adiabatic constant.
logical, public twofl_equi_thermal_c
character(len=std_len), public, protected type_ct
Method type of constrained transport.
integer, public tweight_c_
subroutine, public twofl_get_pthermal_c(w, x, ixil, ixol, pth)
logical, public, protected twofl_radiative_cooling_n
integer, parameter, public eq_energy_none
type(te_fluid), allocatable, public te_fl_c
procedure(mask_subroutine2), pointer, public usr_mask_gamma_ion_rec
double precision, public, protected rc
logical, public, protected twofl_dump_coll_terms
whether dump collisional terms in a separte dat file
logical, public twofl_equi_thermal_n
logical, public, protected twofl_radiative_cooling_c
Whether radiative cooling is added.
logical, public, protected b0field_forcefree
B0 field is force-free.
integer, public e_c_
Index of the energy density (-1 if not present)
integer, public equi_rho_n0_
subroutine, public twofl_get_v_n_idim(w, x, ixil, ixol, idim, v)
Calculate v component.
integer, parameter, public eq_energy_int
integer, dimension(:), allocatable, public mom_c
Indices of the momentum density.
logical, public twofl_coll_inc_te
whether include thermal exchange collisional terms
logical, public has_equi_rho_c0
equi vars flags
logical, public, protected twofl_viscosity
Whether viscosity is added.
double precision, public dtcollpar
logical, public divbwave
Add divB wave in Roe solver.
subroutine, public twofl_to_primitive(ixil, ixol, w, x)
Transform conservative variables into primitive ones.
logical, public, protected twofl_4th_order
MHD fourth order.
double precision, dimension(:), allocatable, public, protected c_hyp
integer, public equi_rho_c0_
equi vars indices in the stateequi_vars array
logical, public, protected twofl_glm
Whether GLM-MHD is used.
double precision, public twofl_alpha_coll
collisional alpha
logical, public, protected twofl_trac
Whether TRAC method is used.
double precision, public twofl_etah
The MHD Hall coefficient.
subroutine, public get_alpha_coll(ixil, ixol, w, x, alpha)
logical, dimension(2 *^nd), public, protected boundary_divbfix
To control divB=0 fix for boundary.
integer, public equi_pe_c0_
integer, parameter, public eq_energy_tot
integer, dimension(:), allocatable, public mom_n
logical, public, protected twofl_gravity
Whether gravity is added: common flag for charges and neutrals.
integer, public tcoff_c_
Index of the cutoff temperature for the TRAC method.
subroutine, public twofl_clean_divb_multigrid(qdt, qt, active)
double precision, public, protected twofl_trac_mask
Height of the mask used in the TRAC method.
logical, public has_equi_pe_n0
procedure(mask_subroutine), pointer, public usr_mask_alpha
integer, public, protected twofl_divb_nth
Whether divB is computed with a fourth order approximation.
integer, public rho_c_
Index of the density (in the w array)
subroutine, public get_normalized_divb(w, ixil, ixol, divb)
get dimensionless div B = |divB| * volume / area / |B|
type(rc_fluid), allocatable, public rc_fl_c
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)...
subroutine, public twofl_to_conserved(ixil, ixol, w, x)
Transform primitive variables into conservative ones.
logical, public twofl_equi_thermal
logical, public has_equi_rho_n0
subroutine, public get_rhoc_tot(w, x, ixil, ixol, rhoc)
subroutine, public twofl_get_pthermal_n(w, x, ixil, ixol, pth)
logical, public, protected twofl_hyperdiffusivity
Whether hyperdiffusivity is used.
integer, public, protected twofl_eq_energy
integer, dimension(2 *^nd), public, protected boundary_divbfix_skip
To skip * layer of ghost cells during divB=0 fix for boundary.
character(len=std_len), public, protected typedivbfix
Method type to clean divergence of B.
double precision, public twofl_gamma
The adiabatic index.
integer, public equi_pe_n0_
logical, public, protected twofl_hall
Whether Hall-MHD is used.
integer, public tweight_n_
integer, public, protected psi_
Indices of the GLM psi.
logical, public, protected source_split_divb
Whether divB cleaning sources are added splitting from fluid solver.
Module with all the methods that users can customize in AMRVAC.
procedure(special_resistivity), pointer usr_special_resistivity
procedure(phys_gravity), pointer usr_gravity
procedure(set_equi_vars), pointer usr_set_equi_vars
procedure(set_electric_field), pointer usr_set_electric_field
procedure(set_wlr), pointer usr_set_wlr
integer nw
Total number of variables.
integer number_species
number of species: each species has different characterictic speeds and should be used accordingly in...
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.
The data structure that contains information about a tree node/grid block.