28 integer,
protected,
public ::
u_ = 1
29 integer,
protected,
public ::
v_ = 2
30 integer,
protected,
public ::
w_ = 3
36 double precision,
public,
protected ::
dtreacpar = 0.5d0
40 integer :: number_of_species = 2
41 integer :: equation_type = 1
42 integer,
parameter :: eq_gray_scott = 1
43 integer,
parameter :: eq_schnakenberg = 2
44 integer,
parameter :: eq_brusselator = 3
45 integer,
parameter :: eq_logistic = 4
46 integer,
parameter :: eq_analyt_hunds = 5
47 integer,
parameter :: eq_belousov_fn = 6
48 integer,
parameter :: eq_ext_brusselator = 7
49 integer,
parameter :: eq_lorenz = 8
50 integer,
parameter :: eq_no_reac = 9
53 double precision,
public,
protected ::
d1 = 0.05d0
55 double precision,
public,
protected ::
d2 = 1.0d0
57 double precision,
public,
protected ::
d3 = 1.0d0
63 double precision,
public,
protected ::
a1(^nd) = 0.0d0
65 double precision,
public,
protected ::
a2(^nd) = 0.0d0
67 double precision,
public,
protected ::
a3(^nd) = 0.0d0
70 double precision,
public,
protected ::
sb_alpha = 0.1305d0
71 double precision,
public,
protected ::
sb_beta = 0.7695d0
72 double precision,
public,
protected ::
sb_kappa = 100.0d0
75 double precision,
public,
protected ::
gs_f = 0.046d0
77 double precision,
public,
protected ::
gs_k = 0.063d0
80 double precision,
public,
protected ::
br_a = 4.5d0
81 double precision,
public,
protected ::
br_b = 8.0d0
82 double precision,
public,
protected ::
br_c = 1.0d0
83 double precision,
public,
protected ::
br_d = 1.0d0
86 double precision,
public,
protected ::
lg_lambda = 1.0d0
90 double precision,
public,
protected ::
bzfn_delta = 1.0d0
92 double precision,
public,
protected ::
bzfn_mu = 1.0d0
95 double precision,
public,
protected ::
lor_r = 28.0d0
97 double precision,
public,
protected ::
lor_sigma = 10.0d0
99 double precision,
public,
protected ::
lor_b = 8.0d0 / 3.0d0
102 logical :: ard_source_split = .false.
113 subroutine ard_params_read(files)
115 character(len=*),
intent(in) :: files(:)
118 namelist /ard_list/
d1,
d2,
d3,
adv_pow,
a1,
a2,
a3,
sb_alpha,
sb_beta,
sb_kappa, &
123 do n = 1,
size(files)
124 open(
unitpar, file=trim(files(n)), status=
'old')
125 read(
unitpar, ard_list,
end=111)
132 equation_type = eq_gray_scott
133 number_of_species = 2
134 case (
"schnakenberg")
135 equation_type = eq_schnakenberg
136 number_of_species = 2
138 equation_type = eq_brusselator
139 number_of_species = 2
141 equation_type = eq_logistic
142 number_of_species = 1
143 case (
"analyt_hunds")
144 equation_type = eq_analyt_hunds
145 number_of_species = 1
146 case (
"belousov_fieldnoyes")
147 equation_type = eq_belousov_fn
148 number_of_species = 3
149 case (
"ext_brusselator")
150 equation_type = eq_ext_brusselator
151 number_of_species = 3
153 equation_type = eq_lorenz
154 number_of_species = 3
156 equation_type = eq_no_reac
157 number_of_species = 1
159 call mpistop(
"Unknown equation_name (valid: gray-scott, schnakenberg, ...)")
162 end subroutine ard_params_read
165 subroutine ard_write_info(fh)
167 integer,
intent(in) :: fh
168 integer,
parameter :: n_par = 0
169 integer,
dimension(MPI_STATUS_SIZE) :: st
173 call mpi_file_write(fh, n_par, 1, mpi_integer, st, er)
174 end subroutine ard_write_info
188 allocate(start_indices(number_species),stop_indices(number_species))
192 u_ = var_set_fluxvar(
"u",
"u")
193 if (number_of_species >= 2)
then
194 v_ = var_set_fluxvar(
"v",
"v")
196 if (number_of_species >= 3)
then
197 w_ = var_set_fluxvar(
"w",
"w")
203 stop_indices(1)=nwflux
210 call mpistop(
"phys_check error: flux_type has wrong shape")
233 subroutine ard_check_params
235 integer :: n, i, iw, species_list(number_of_species)
239 select case(number_of_species)
242 if (
d1 == 0.0d0)
then
243 write(*, *)
"Diffusion coefficient cannot be zero in IMEX scheme"
244 call mpistop(
"Zero diffusion in IMEX scheme")
247 species_list = [
u_,
v_]
248 if ((
d1 == 0.0d0) .or. (
d2 == 0.0d0))
then
249 write(*, *)
"Diffusion coefficient cannot be zero in IMEX scheme"
250 call mpistop(
"Zero diffusion in IMEX scheme")
253 species_list = [
u_,
v_,
w_]
254 if ((
d1 == 0.0d0) .or. (
d2 == 0.0d0) .or. (
d3 == 0.0d0))
then
255 write(*, *)
"Diffusion coefficient cannot be zero in IMEX scheme"
256 call mpistop(
"Zero diffusion in IMEX scheme")
260 do i = 1, number_of_species
272 ard_mg_bc(i, n)%bc_type = mg_bc_dirichlet
281 if (.not.
associated(
ard_mg_bc(i, n)%boundary_cond))
then
282 write(*,
"(A,I0,A,I0,A)")
"typeboundary(", iw,
",", n, &
283 ") is 'special', but the corresponding method " // &
284 "ard_mg_bc(i, n)%boundary_cond is not set"
285 call mpistop(
"ard_mg_bc(i, n)%boundary_cond not set")
288 write(*,*)
"ard_check_params warning: unknown boundary type"
289 ard_mg_bc(i, n)%bc_type = mg_bc_dirichlet
296 end subroutine ard_check_params
298 subroutine ard_to_conserved(ixI^L, ixO^L, w, x)
300 integer,
intent(in) :: ixi^
l, ixo^
l
301 double precision,
intent(inout) :: w(ixi^s, nw)
302 double precision,
intent(in) :: x(ixi^s, 1:^nd)
305 end subroutine ard_to_conserved
307 subroutine ard_to_primitive(ixI^L, ixO^L, w, x)
309 integer,
intent(in) :: ixi^
l, ixo^
l
310 double precision,
intent(inout) :: w(ixi^s, nw)
311 double precision,
intent(in) :: x(ixi^s, 1:^nd)
314 end subroutine ard_to_primitive
316 subroutine ard_get_cmax(w, x, ixI^L, ixO^L, idim, cmax)
318 integer,
intent(in) :: ixi^
l, ixo^
l, idim
319 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s, 1:^nd)
320 double precision,
intent(inout) :: cmax(ixi^s)
322 cmax(ixo^s) = abs(
a1(idim) * w(ixo^s,
u_)**(
adv_pow-1))
323 if (number_of_species >= 2)
then
324 cmax(ixo^s) = max(cmax(ixo^s), abs(
a2(idim) * w(ixo^s,
v_)**(
adv_pow-1)))
326 if (number_of_species >= 3)
then
327 cmax(ixo^s) = max(cmax(ixo^s), abs(
a3(idim) * w(ixo^s,
w_)**(
adv_pow-1)))
330 end subroutine ard_get_cmax
332 subroutine ard_get_cbounds(wLC, wRC, wLp, wRp, x, ixI^L, ixO^L, idim,Hspeed, cmax, cmin)
335 integer,
intent(in) :: ixi^
l, ixo^
l, idim
336 double precision,
intent(in) :: wlc(ixi^s,
nw), wrc(ixi^s,
nw)
337 double precision,
intent(in) :: wlp(ixi^s,
nw), wrp(ixi^s,
nw)
338 double precision,
intent(in) :: x(ixi^s, 1:^nd)
341 double precision,
intent(inout),
optional :: cmin(ixi^s,1:
number_species)
343 double precision :: wmean(ixi^s,
nw)
349 if (
present(cmin))
then
350 cmin(ixo^s,1) = min(
a1(idim) * wmean(ixo^s,
u_)**(
adv_pow-1), zero)
351 cmax(ixo^s,1) = max(
a1(idim) * wmean(ixo^s,
u_)**(
adv_pow-1), zero)
352 if (number_of_species >= 2)
then
353 cmin(ixo^s,1) = min(cmin(ixo^s,1),
a2(idim) * wmean(ixo^s,
v_)**(
adv_pow-1))
354 cmax(ixo^s,1) = max(cmax(ixo^s,1),
a2(idim) * wmean(ixo^s,
v_)**(
adv_pow-1))
356 if (number_of_species >= 3)
then
357 cmin(ixo^s,1) = min(cmin(ixo^s,1),
a3(idim) * wmean(ixo^s,
w_)**(
adv_pow-1))
358 cmax(ixo^s,1) = max(cmax(ixo^s,1),
a3(idim) * wmean(ixo^s,
w_)**(
adv_pow-1))
361 cmax(ixo^s,1) = maxval(abs(
a1(idim) * wmean(ixo^s,
u_)**(
adv_pow-1)))
362 if (number_of_species >=2)
then
363 cmax(ixo^s,1) = max(cmax(ixo^s,1), maxval(abs(
a2(idim) * wmean(ixo^s,
v_)**(
adv_pow-1))))
365 if (number_of_species >=3)
then
366 cmax(ixo^s,1) = max(cmax(ixo^s,1), maxval(abs(
a3(idim) * wmean(ixo^s,
w_)**(
adv_pow-1))))
370 end subroutine ard_get_cbounds
372 subroutine ard_get_dt(w, ixI^L, ixO^L, dtnew, dx^D, x)
374 integer,
intent(in) :: ixi^
l, ixo^
l
375 double precision,
intent(in) ::
dx^
d, x(ixi^s, 1:^nd)
376 double precision,
intent(in) :: w(ixi^s, 1:nw)
377 double precision,
intent(inout) :: dtnew
378 double precision :: maxrate
379 double precision :: maxd
380 double precision :: maxa
387 if (number_of_species >= 2)
then
390 if (number_of_species >= 3)
then
396 select case (equation_type)
398 maxrate = max(maxval(w(ixo^s,
v_))**2 +
gs_f, &
400 case (eq_schnakenberg)
401 maxrate = max(maxval(abs(w(ixo^s,
v_) * w(ixo^s,
u_) - 1)), &
402 maxval(w(ixo^s,
u_))**2)
403 case (eq_brusselator)
404 maxrate = max( maxval(w(ixo^s,
u_)*w(ixo^s,
v_) - (
br_b+1)), &
405 maxval(w(ixo^s,
u_)**2) )
406 case (eq_ext_brusselator)
407 maxrate = max( maxval(w(ixo^s,
u_)*w(ixo^s,
v_) - (
br_b+1)) +
br_c, &
408 maxval(w(ixo^s,
u_)**2) )
409 maxrate = max(maxrate,
br_d)
412 case (eq_analyt_hunds)
413 maxrate = maxval(w(ixo^s,
u_)*abs(1 - w(ixo^s,
u_))) /
d1
414 case (eq_belousov_fn)
427 call mpistop(
"Unknown equation type")
432 end subroutine ard_get_dt
435 subroutine ard_get_flux(wC, w, x, ixI^L, ixO^L, idim, f)
437 integer,
intent(in) :: ixi^
l, ixo^
l, idim
438 double precision,
intent(in) :: wc(ixi^s, 1:nw)
439 double precision,
intent(in) :: w(ixi^s, 1:nw)
440 double precision,
intent(in) :: x(ixi^s, 1:^nd)
441 double precision,
intent(out) :: f(ixi^s, nwflux)
444 if (number_of_species >=2)
then
447 if (number_of_species >=3)
then
451 end subroutine ard_get_flux
453 subroutine ard_add_source_geom(qdt, dtfactor, ixI^L, ixO^L, wCT, wprim,w, x)
460 integer,
intent(in) :: ixi^
l, ixo^
l
461 double precision,
intent(in) :: qdt, dtfactor, x(ixi^s, 1:^nd)
462 double precision,
intent(inout) :: wct(ixi^s, 1:nw), wprim(ixi^s,1:nw),w(ixi^s, 1:nw)
464 end subroutine ard_add_source_geom
467 subroutine ard_add_source(qdt,dtfactor,ixI^L,ixO^L,wCT,wCTprim,w,x,qsourcesplit,active)
469 integer,
intent(in) :: ixi^
l, ixo^
l
470 double precision,
intent(in) :: qdt, dtfactor
471 double precision,
intent(in) :: wct(ixi^s, 1:nw),wctprim(ixi^s,1:nw), x(ixi^s, 1:
ndim)
472 double precision,
intent(inout) :: w(ixi^s, 1:nw)
473 double precision :: lpl_u(ixo^s), lpl_v(ixo^s), lpl_w(ixo^s)
474 logical,
intent(in) :: qsourcesplit
475 logical,
intent(inout) :: active
478 if (qsourcesplit .eqv. ard_source_split)
then
480 call ard_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
u_), lpl_u)
481 if (number_of_species >= 2)
then
482 call ard_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
v_), lpl_v)
484 if (number_of_species >= 3)
then
485 call ard_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
w_), lpl_w)
494 select case (equation_type)
496 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u - &
497 wct(ixo^s,
u_) * wct(ixo^s,
v_)**2 + &
498 gs_f * (1 - wct(ixo^s,
u_)))
499 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v + &
500 wct(ixo^s,
u_) * wct(ixo^s,
v_)**2 - &
502 case (eq_schnakenberg)
503 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
505 wct(ixo^s,
u_)**2 * wct(ixo^s,
v_)))
506 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
508 case (eq_brusselator)
509 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
511 + wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
512 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
513 +
br_b * wct(ixo^s,
u_) - wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
514 case (eq_ext_brusselator)
515 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
517 + wct(ixo^s,
u_)**2 * wct(ixo^s,
v_) &
519 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
521 - wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
522 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
525 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
527 case (eq_analyt_hunds)
528 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
529 + 1.0d0/
d1 * w(ixo^s,
u_)**2 * (1 - w(ixo^s,
u_)))
530 case (eq_belousov_fn)
531 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
533 - wct(ixo^s,
u_)*wct(ixo^s,
w_) + wct(ixo^s,
u_) &
534 - wct(ixo^s,
u_)**2))
535 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
536 + wct(ixo^s,
u_) - wct(ixo^s,
v_))
537 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
542 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
545 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
546 +
lor_r * wct(ixo^s,
u_) - wct(ixo^s,
v_) &
547 - wct(ixo^s,
u_)*wct(ixo^s,
w_))
549 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
550 + wct(ixo^s,
u_)*wct(ixo^s,
v_) -
lor_b * wct(ixo^s,
w_))
552 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt *
d1 * lpl_u
554 call mpistop(
"Unknown equation type")
561 end subroutine ard_add_source
565 subroutine ard_laplacian(ixI^L,ixO^L,var,lpl)
567 integer,
intent(in) :: ixi^
l, ixo^
l
568 double precision,
intent(in) :: var(ixi^s)
569 double precision,
intent(out) :: lpl(ixo^s)
570 integer :: idir, jxo^
l, hxo^
l
571 double precision :: h_inv2
576 hxo^
l=ixo^
l-
kr(idir,^
d);
577 jxo^
l=ixo^
l+
kr(idir,^
d);
579 lpl(ixo^s) = lpl(ixo^s) + h_inv2 * &
580 (var(jxo^s) - 2 * var(ixo^s) + var(hxo^s))
583 call mpistop(
"ard_laplacian not implemented in this geometry")
586 end subroutine ard_laplacian
588 subroutine put_laplacians_onegrid(ixI^L,ixO^L,w)
590 integer,
intent(in) :: ixi^
l, ixo^
l
591 double precision,
intent(inout) :: w(ixi^s, 1:nw)
593 double precision :: lpl_u(ixo^s), lpl_v(ixo^s), lpl_w(ixo^s)
595 call ard_laplacian(ixi^
l, ixo^
l, w(ixi^s,
u_), lpl_u)
596 if (number_of_species >= 2)
then
597 call ard_laplacian(ixi^
l, ixo^
l, w(ixi^s,
v_), lpl_v)
599 if (number_of_species >= 3)
then
600 call ard_laplacian(ixi^
l, ixo^
l, w(ixi^s,
w_), lpl_w)
603 w(ixo^s,
u_) =
d1*lpl_u
604 if (number_of_species >= 2)
then
605 w(ixo^s,
v_) =
d2*lpl_v
607 if (number_of_species >= 3)
then
608 w(ixo^s,
w_) =
d3*lpl_w
611 end subroutine put_laplacians_onegrid
614 subroutine ard_evaluate_implicit(qtC,psa)
617 double precision,
intent(in) :: qtc
619 integer :: iigrid, igrid, level
625 do iigrid=1,igridstail; igrid=igrids(iigrid);
627 call put_laplacians_onegrid(ixg^
ll,ixo^
l,psa(igrid)%w)
631 end subroutine ard_evaluate_implicit
634 subroutine ard_implicit_update(dtfactor,qdt,qtC,psa,psb)
640 double precision,
intent(in) :: qdt
641 double precision,
intent(in) :: qtc
642 double precision,
intent(in) :: dtfactor
645 double precision :: res, max_residual, lambda
647 integer :: iw_to,iw_from
648 integer :: iigrid, igrid, id
655 if (qdt <
dtmin)
then
657 print *,
'skipping implicit solve: dt too small!'
662 max_residual = 1
d-7/qdt
664 mg%operator_type = mg_helmholtz
665 call mg_set_methods(mg)
667 if (.not. mg%is_allocated)
call mpistop(
"multigrid tree not allocated yet")
670 lambda = 1/(dtfactor * qdt *
d1)
671 call helmholtz_set_lambda(lambda)
674 call mg_copy_to_tree(
u_, mg_irhs, factor=-lambda, state_from=psb)
675 call mg_copy_to_tree(
u_, mg_iphi, state_from=psb)
677 call mg_fas_fmg(mg, .true., max_res=res)
679 call mg_fas_vcycle(mg, max_res=res)
680 if (res < max_residual)
exit
683 call mg_copy_from_tree_gc(mg_iphi,
u_, state_to=psa)
687 if (number_of_species >= 2)
then
688 lambda = 1/(dtfactor * qdt *
d2)
689 call helmholtz_set_lambda(lambda)
692 call mg_copy_to_tree(
v_, mg_irhs, factor=-lambda, state_from=psb)
693 call mg_copy_to_tree(
v_, mg_iphi, state_from=psb)
695 call mg_fas_fmg(mg, .true., max_res=res)
697 call mg_fas_vcycle(mg, max_res=res)
698 if (res < max_residual)
exit
701 call mg_copy_from_tree_gc(mg_iphi,
v_, state_to=psa)
706 if (number_of_species >= 3)
then
707 lambda = 1/(dtfactor * qdt *
d3)
708 call helmholtz_set_lambda(lambda)
710 call mg_copy_to_tree(
w_, mg_irhs, factor=-lambda, state_from=psb)
711 call mg_copy_to_tree(
w_, mg_iphi, state_from=psb)
713 call mg_fas_fmg(mg, .true., max_res=res)
715 call mg_fas_vcycle(mg, max_res=res)
716 if (res < max_residual)
exit
719 call mg_copy_from_tree_gc(mg_iphi,
w_, state_to=psa)
723 end subroutine ard_implicit_update
Module containing the physics routines for advection-reaction-diffusion equations.
double precision, public, protected br_a
Parameters for Brusselator model.
double precision, dimension(^nd), public, protected a3
Advection coefficients for third species (w) (if applicable)
double precision, public, protected lg_lambda
Parameter for logistic model (Fisher / KPP equation)
double precision, public, protected gs_k
Kill rate for Gray-Scott model.
integer, public, protected v_
For 2 or more equations.
double precision, public, protected sb_alpha
Parameters for Schnakenberg model.
double precision, public, protected gs_f
Feed rate for Gray-Scott model.
double precision, public, protected sb_beta
double precision, public, protected br_b
double precision, public, protected br_c
subroutine, public ard_phys_init()
double precision, public, protected sb_kappa
character(len=20), public, protected equation_name
Name of the system to be solved.
integer, public, protected u_
Indices of the unknowns.
double precision, public, protected lor_b
Parameter for Lorenz system (aspect ratio of the convection rolls)
double precision, public, protected dtreacpar
Parameter with which to multiply the reaction timestep restriction.
double precision, public, protected bzfn_mu
double precision, public, protected lor_sigma
Parameter for Lorenz system (Prandtl number)
integer, public, protected adv_pow
Power of the unknown in the advection term (1 for linear)
double precision, public, protected d1
Diffusion coefficient for first species (u)
double precision, public, protected d2
Diffusion coefficient for second species (v) (if applicable)
type(mg_bc_t), dimension(3, mg_num_neighbors), public ard_mg_bc
Boundary condition information for the multigrid method.
double precision, public, protected bzfn_epsilon
Parameters for the Field-Noyes model of the Belousov-Zhabotinsky reaction.
logical, public, protected ard_particles
Whether particles module is added.
double precision, public, protected lor_r
Parameter for Lorenz system (Rayleigh number)
double precision, dimension(^nd), public, protected a2
Advection coefficients for second species (v) (if applicable)
double precision, public, protected d3
Diffusion coefficient for third species (w) (if applicable)
double precision, public, protected bzfn_lambda
integer, public, protected w_
For 3 or more equations.
double precision, dimension(^nd), public, protected a1
Advection coefficients for first species (u)
double precision, public, protected bzfn_delta
double precision, public, protected br_d
subroutine, public mpistop(message)
Exit MPI-AMRVAC with an error message.
Module with basic grid data structures.
This module contains definitions of global parameters and variables and some generic functions/subrou...
double precision dtdiffpar
For resistive MHD, the time step is also limited by the diffusion time: .
integer, parameter unitpar
file handle for IO
integer, parameter bc_asymm
double precision global_time
The global simulation time.
logical use_imex_scheme
whether IMEX in use or not
integer, dimension(3, 3) kr
Kronecker delta tensor.
integer, dimension(:, :), allocatable typeboundary
Array indicating the type of boundary condition per variable and per physical boundary.
integer, parameter ndim
Number of spatial dimensions for grid variables.
logical use_particles
Use particles module or not.
character(len=std_len), dimension(:), allocatable par_files
Which par files are used as input.
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
logical slab
Cartesian geometry or not.
integer, parameter bc_periodic
integer, parameter bc_special
boundary condition types
double precision, dimension(:,:), allocatable rnode
Corner coordinates.
integer, parameter bc_cont
double precision, dimension(:,:), allocatable dx
integer, parameter bc_symm
double precision, dimension(^nd) dxlevel
store unstretched cell size of current level
logical use_multigrid
Use multigrid (only available in 2D and 3D)
double precision dtmin
Stop the simulation when the time step becomes smaller than this value.
integer max_blocks
The maximum number of grid blocks in a processor.
Module to couple the octree-mg library to AMRVAC. This file uses the VACPP preprocessor,...
Module containing all the particle routines.
subroutine particles_init()
Initialize particle data and parameters.
This module defines the procedures of a physics module. It contains function pointers for the various...
procedure(sub_convert), pointer phys_to_primitive
procedure(sub_write_info), pointer phys_write_info
procedure(sub_get_flux), pointer phys_get_flux
procedure(sub_evaluate_implicit), pointer phys_evaluate_implicit
procedure(sub_get_cbounds), pointer phys_get_cbounds
procedure(sub_get_dt), pointer phys_get_dt
procedure(sub_add_source_geom), pointer phys_add_source_geom
procedure(sub_check_params), pointer phys_check_params
integer, parameter flux_default
Indicates a normal flux.
integer, dimension(:, :), allocatable flux_type
Array per direction per variable, which can be used to specify that certain fluxes have to be treated...
procedure(sub_convert), pointer phys_to_conserved
character(len=name_len) physics_type
String describing the physics type of the simulation.
procedure(sub_implicit_update), pointer phys_implicit_update
procedure(sub_add_source), pointer phys_add_source
procedure(sub_get_cmax), pointer phys_get_cmax
logical phys_energy
Solve energy equation or not.
integer nw
Total number of variables.
integer number_species
number of species: each species has different characterictic speeds and should be used accordingly in...
integer nwflux
Number of flux variables.
The data structure that contains information about a tree node/grid block.