21 integer,
protected,
public ::
u_ = 1
22 integer,
protected,
public ::
v_ = 2
23 integer,
protected,
public ::
w_ = 3
29 double precision,
public,
protected ::
dtreacpar = 0.5d0
33 integer :: number_of_species = 2
34 integer :: equation_type = 1
35 integer,
parameter :: eq_gray_scott = 1
36 integer,
parameter :: eq_schnakenberg = 2
37 integer,
parameter :: eq_brusselator = 3
38 integer,
parameter :: eq_logistic = 4
39 integer,
parameter :: eq_analyt_hunds = 5
40 integer,
parameter :: eq_belousov_fn = 6
41 integer,
parameter :: eq_ext_brusselator = 7
42 integer,
parameter :: eq_lorenz = 8
45 double precision,
public,
protected ::
d1 = 0.05d0
47 double precision,
public,
protected ::
d2 = 1.0d0
49 double precision,
public,
protected ::
d3 = 1.0d0
52 double precision,
public,
protected ::
sb_alpha = 0.1305d0
54 double precision,
public,
protected ::
sb_beta = 0.7695d0
56 double precision,
public,
protected ::
sb_kappa = 100.0d0
59 double precision,
public,
protected ::
gs_f = 0.046d0
61 double precision,
public,
protected ::
gs_k = 0.063d0
64 double precision,
public,
protected ::
br_a = 4.5d0
66 double precision,
public,
protected ::
br_b = 8.0d0
68 double precision,
public,
protected ::
br_c = 1.0d0
70 double precision,
public,
protected ::
br_d = 1.0d0
73 double precision,
public,
protected ::
lg_lambda = 1.0d0
78 double precision,
public,
protected ::
bzfn_delta = 1.0d0
82 double precision,
public,
protected ::
bzfn_mu = 1.0d0
85 double precision,
public,
protected ::
lor_r = 28.0d0
87 double precision,
public,
protected ::
lor_sigma = 10.0d0
89 double precision,
public,
protected ::
lor_b = 8.0d0 / 3.0d0
92 logical :: rd_source_split = .false.
95 type(mg_bc_t),
public ::
rd_mg_bc(3, mg_num_neighbors)
102 subroutine rd_params_read(files)
104 character(len=*),
intent(in) :: files(:)
112 do n = 1,
size(files)
113 open(
unitpar, file=trim(files(n)), status=
'old')
114 read(
unitpar, rd_list,
end=111)
120 equation_type = eq_gray_scott
121 number_of_species = 2
122 case (
"schnakenberg")
123 equation_type = eq_schnakenberg
124 number_of_species = 2
126 equation_type = eq_brusselator
127 number_of_species = 2
129 equation_type = eq_logistic
130 number_of_species = 1
131 case (
"analyt_hunds")
132 equation_type = eq_analyt_hunds
133 number_of_species = 1
134 case (
"belousov_fieldnoyes")
135 equation_type = eq_belousov_fn
136 number_of_species = 3
137 case (
"ext_brusselator")
138 equation_type = eq_ext_brusselator
139 number_of_species = 3
141 equation_type = eq_lorenz
142 number_of_species = 3
144 call mpistop(
"Unknown equation_name (valid: gray-scott, schnakenberg, ...)")
147 end subroutine rd_params_read
150 subroutine rd_write_info(fh)
152 integer,
intent(in) :: fh
153 integer,
parameter :: n_par = 0
154 integer,
dimension(MPI_STATUS_SIZE) :: st
158 call mpi_file_write(fh, n_par, 1, mpi_integer, st, er)
159 end subroutine rd_write_info
173 allocate(start_indices(number_species),stop_indices(number_species))
177 u_ = var_set_fluxvar(
"u",
"u")
178 if (number_of_species >= 2)
then
179 v_ = var_set_fluxvar(
"v",
"v")
181 if (number_of_species >= 3)
then
182 w_ = var_set_fluxvar(
"w",
"w")
189 stop_indices(1)=nwflux
213 subroutine rd_check_params
215 integer :: n, i, iw, species_list(number_of_species)
219 call mpistop(
"mod_rd requires flux_scheme = source")
224 select case(number_of_species)
225 case(1); species_list = [
u_]
226 case(2); species_list = [
u_,
v_]
227 case(3); species_list = [
u_,
v_,
w_]
230 do i = 1, number_of_species
238 rd_mg_bc(i, n)%bc_type = mg_bc_neumann
242 rd_mg_bc(i, n)%bc_type = mg_bc_dirichlet
246 rd_mg_bc(i, n)%bc_type = mg_bc_neumann
251 if (.not.
associated(
rd_mg_bc(i, n)%boundary_cond))
then
252 write(*,
"(A,I0,A,I0,A)")
"typeboundary(", iw,
",", n, &
253 ") is 'special', but the corresponding method " // &
254 "rd_mg_bc(i, n)%boundary_cond is not set"
255 call mpistop(
"rd_mg_bc(i, n)%boundary_cond not set")
258 write(*,*)
"rd_check_params warning: unknown boundary type"
259 rd_mg_bc(i, n)%bc_type = mg_bc_dirichlet
266 end subroutine rd_check_params
268 subroutine rd_to_conserved(ixI^L, ixO^L, w, x)
270 integer,
intent(in) :: ixi^
l, ixo^
l
271 double precision,
intent(inout) :: w(ixi^s, nw)
272 double precision,
intent(in) :: x(ixi^s, 1:^nd)
275 end subroutine rd_to_conserved
277 subroutine rd_to_primitive(ixI^L, ixO^L, w, x)
279 integer,
intent(in) :: ixi^
l, ixo^
l
280 double precision,
intent(inout) :: w(ixi^s, nw)
281 double precision,
intent(in) :: x(ixi^s, 1:^nd)
284 end subroutine rd_to_primitive
286 subroutine rd_get_cmax(w, x, ixI^L, ixO^L, idim, cmax)
288 integer,
intent(in) :: ixi^
l, ixo^
l, idim
289 double precision,
intent(in) :: w(ixi^s, nw), x(ixi^s, 1:^nd)
290 double precision,
intent(inout) :: cmax(ixi^s)
293 end subroutine rd_get_cmax
295 subroutine rd_get_cbounds(wLC, wRC, wLp, wRp, x, ixI^L, ixO^L, idim,Hspeed, cmax, cmin)
298 integer,
intent(in) :: ixi^
l, ixo^
l, idim
299 double precision,
intent(in) :: wlc(ixi^s,
nw), wrc(ixi^s,
nw)
300 double precision,
intent(in) :: wlp(ixi^s,
nw), wrp(ixi^s,
nw)
301 double precision,
intent(in) :: x(ixi^s, 1:^nd)
303 double precision,
intent(inout),
optional :: cmin(ixi^s,1:
number_species)
306 if (
present(cmin))
then
307 cmin(ixo^s,1) = 0.0d0
308 cmax(ixo^s,1) = 0.0d0
310 cmax(ixo^s,1) = 0.0d0
313 end subroutine rd_get_cbounds
315 subroutine rd_get_dt(w, ixI^L, ixO^L, dtnew, dx^D, x)
317 integer,
intent(in) :: ixi^
l, ixo^
l
318 double precision,
intent(in) ::
dx^
d, x(ixi^s, 1:^nd)
319 double precision,
intent(in) :: w(ixi^s, 1:nw)
320 double precision,
intent(inout) :: dtnew
321 double precision :: maxrate
322 double precision :: maxd
327 if (number_of_species >= 2)
then
330 if (number_of_species >= 3)
then
336 select case (equation_type)
338 maxrate = max(maxval(w(ixo^s,
v_))**2 +
gs_f, &
340 case (eq_schnakenberg)
341 maxrate = max(maxval(abs(w(ixo^s,
v_) * w(ixo^s,
u_) - 1)), &
342 maxval(w(ixo^s,
u_))**2)
343 case (eq_brusselator)
344 maxrate = max( maxval(w(ixo^s,
u_)*w(ixo^s,
v_) - (
br_b+1)), &
345 maxval(w(ixo^s,
u_)**2) )
346 case (eq_ext_brusselator)
347 maxrate = max( maxval(w(ixo^s,
u_)*w(ixo^s,
v_) - (
br_b+1)) +
br_c, &
348 maxval(w(ixo^s,
u_)**2) )
349 maxrate = max(maxrate,
br_d)
352 case (eq_analyt_hunds)
353 maxrate = maxval(w(ixo^s,
u_)*abs(1 - w(ixo^s,
u_))) /
d1
354 case (eq_belousov_fn)
364 call mpistop(
"Unknown equation type")
369 end subroutine rd_get_dt
372 subroutine rd_get_flux(wC, w, x, ixI^L, ixO^L, idim, f)
374 integer,
intent(in) :: ixi^
l, ixo^
l, idim
375 double precision,
intent(in) :: wc(ixi^s, 1:nw)
376 double precision,
intent(in) :: w(ixi^s, 1:nw)
377 double precision,
intent(in) :: x(ixi^s, 1:^nd)
378 double precision,
intent(out) :: f(ixi^s, nwflux)
381 end subroutine rd_get_flux
384 subroutine rd_add_source(qdt,dtfactor,ixI^L,ixO^L,wCT,wCTprim,w,x,qsourcesplit,active)
386 integer,
intent(in) :: ixi^
l, ixo^
l
387 double precision,
intent(in) :: qdt, dtfactor
388 double precision,
intent(in) :: wct(ixi^s, 1:nw),wctprim(ixi^s,1:nw),x(ixi^s, 1:
ndim)
389 double precision,
intent(inout) :: w(ixi^s, 1:nw)
390 double precision :: lpl_u(ixo^s), lpl_v(ixo^s), lpl_w(ixo^s)
391 logical,
intent(in) :: qsourcesplit
392 logical,
intent(inout) :: active
395 if (qsourcesplit .eqv. rd_source_split)
then
397 call rd_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
u_), lpl_u)
398 if (number_of_species >= 2)
then
399 call rd_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
v_), lpl_v)
401 if (number_of_species >= 3)
then
402 call rd_laplacian(ixi^
l, ixo^
l, wct(ixi^s,
w_), lpl_w)
411 select case (equation_type)
413 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u - &
414 wct(ixo^s,
u_) * wct(ixo^s,
v_)**2 + &
415 gs_f * (1 - wct(ixo^s,
u_)))
416 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v + &
417 wct(ixo^s,
u_) * wct(ixo^s,
v_)**2 - &
419 case (eq_schnakenberg)
420 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
422 wct(ixo^s,
u_)**2 * wct(ixo^s,
v_)))
423 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
425 case (eq_brusselator)
426 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
428 + wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
429 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
430 +
br_b * wct(ixo^s,
u_) - wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
431 case (eq_ext_brusselator)
432 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
434 + wct(ixo^s,
u_)**2 * wct(ixo^s,
v_) &
436 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
438 - wct(ixo^s,
u_)**2 * wct(ixo^s,
v_))
439 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
442 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
444 case (eq_analyt_hunds)
445 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
446 + 1.0d0/
d1 * w(ixo^s,
u_)**2 * (1 - w(ixo^s,
u_)))
447 case (eq_belousov_fn)
448 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
450 - wct(ixo^s,
u_)*wct(ixo^s,
w_) + wct(ixo^s,
u_) &
451 - wct(ixo^s,
u_)**2))
452 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
453 + wct(ixo^s,
u_) - wct(ixo^s,
v_))
454 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
459 w(ixo^s,
u_) = w(ixo^s,
u_) + qdt * (
d1 * lpl_u &
462 w(ixo^s,
v_) = w(ixo^s,
v_) + qdt * (
d2 * lpl_v &
463 +
lor_r * wct(ixo^s,
u_) - wct(ixo^s,
v_) &
464 - wct(ixo^s,
u_)*wct(ixo^s,
w_))
466 w(ixo^s,
w_) = w(ixo^s,
w_) + qdt * (
d3 * lpl_w &
467 + wct(ixo^s,
u_)*wct(ixo^s,
v_) -
lor_b * wct(ixo^s,
w_))
469 call mpistop(
"Unknown equation type")
476 end subroutine rd_add_source
480 subroutine rd_laplacian(ixI^L,ixO^L,var,lpl)
482 integer,
intent(in) :: ixi^
l, ixo^
l
483 double precision,
intent(in) :: var(ixi^s)
484 double precision,
intent(out) :: lpl(ixo^s)
485 integer :: idir, jxo^
l, hxo^
l
486 double precision :: h_inv2
491 hxo^
l=ixo^
l-
kr(idir,^
d);
492 jxo^
l=ixo^
l+
kr(idir,^
d);
494 lpl(ixo^s) = lpl(ixo^s) + h_inv2 * &
495 (var(jxo^s) - 2 * var(ixo^s) + var(hxo^s))
498 call mpistop(
"rd_laplacian not implemented in this geometry")
501 end subroutine rd_laplacian
503 subroutine put_laplacians_onegrid(ixI^L,ixO^L,w)
505 integer,
intent(in) :: ixi^
l, ixo^
l
506 double precision,
intent(inout) :: w(ixi^s, 1:nw)
508 double precision :: lpl_u(ixo^s), lpl_v(ixo^s), lpl_w(ixo^s)
510 call rd_laplacian(ixi^
l, ixo^
l, w(ixi^s,
u_), lpl_u)
511 if (number_of_species >= 2)
then
512 call rd_laplacian(ixi^
l, ixo^
l, w(ixi^s,
v_), lpl_v)
514 if (number_of_species >= 3)
then
515 call rd_laplacian(ixi^
l, ixo^
l, w(ixi^s,
w_), lpl_w)
518 w(ixo^s,
u_) =
d1*lpl_u
519 if (number_of_species >= 2)
then
520 w(ixo^s,
v_) =
d2*lpl_v
522 if (number_of_species >= 3)
then
523 w(ixo^s,
w_) =
d3*lpl_w
526 end subroutine put_laplacians_onegrid
529 subroutine rd_evaluate_implicit(qtC,psa)
532 double precision,
intent(in) :: qtc
534 integer :: iigrid, igrid, level
540 do iigrid=1,igridstail; igrid=igrids(iigrid);
542 call put_laplacians_onegrid(ixg^
ll,ixo^
l,psa(igrid)%w)
546 end subroutine rd_evaluate_implicit
549 subroutine rd_implicit_update(dtfactor,qdt,qtC,psa,psb)
555 double precision,
intent(in) :: qdt
556 double precision,
intent(in) :: qtc
557 double precision,
intent(in) :: dtfactor
560 double precision :: res, max_residual, lambda
562 integer :: iw_to,iw_from
563 integer :: iigrid, igrid, id
570 if (qdt <
dtmin)
then
572 print *,
'skipping implicit solve: dt too small!'
577 max_residual = 1
d-7/qdt
579 mg%operator_type = mg_helmholtz
580 call mg_set_methods(mg)
582 if (.not. mg%is_allocated)
call mpistop(
"multigrid tree not allocated yet")
585 lambda = 1/(dtfactor * qdt *
d1)
586 call helmholtz_set_lambda(lambda)
589 call mg_copy_to_tree(
u_, mg_irhs, factor=-lambda, state_from=psb)
590 call mg_copy_to_tree(
u_, mg_iphi, state_from=psb)
592 call mg_fas_fmg(mg, .true., max_res=res)
594 call mg_fas_vcycle(mg, max_res=res)
595 if (res < max_residual)
exit
598 call mg_copy_from_tree_gc(mg_iphi,
u_, state_to=psa)
602 if (number_of_species >= 2)
then
603 lambda = 1/(dtfactor * qdt *
d2)
604 call helmholtz_set_lambda(lambda)
607 call mg_copy_to_tree(
v_, mg_irhs, factor=-lambda, state_from=psb)
608 call mg_copy_to_tree(
v_, mg_iphi, state_from=psb)
610 call mg_fas_fmg(mg, .true., max_res=res)
612 call mg_fas_vcycle(mg, max_res=res)
613 if (res < max_residual)
exit
616 call mg_copy_from_tree_gc(mg_iphi,
v_, state_to=psa)
621 if (number_of_species >= 3)
then
622 lambda = 1/(dtfactor * qdt *
d3)
623 call helmholtz_set_lambda(lambda)
625 call mg_copy_to_tree(
w_, mg_irhs, factor=-lambda, state_from=psb)
626 call mg_copy_to_tree(
w_, mg_iphi, state_from=psb)
628 call mg_fas_fmg(mg, .true., max_res=res)
630 call mg_fas_vcycle(mg, max_res=res)
631 if (res < max_residual)
exit
634 call mg_copy_from_tree_gc(mg_iphi,
w_, state_to=psa)
638 end subroutine rd_implicit_update
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 ixm
the mesh range of a physical block without ghost cells
integer, dimension(:), allocatable flux_method
Which flux scheme of spatial discretization to use (per grid level)
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
logical fix_conserve_global
Whether to apply flux conservation at refinement boundaries.
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.
integer, parameter fs_source
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_check_params), pointer phys_check_params
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.
Reaction-diffusion module (physics routines)
double precision, public, protected gs_f
Feed rate for Gray-Scott model.
double precision, public, protected lor_b
Parameter for Lorenz system (aspect ratio of the convection rolls)
integer, public, protected u_
double precision, public, protected bzfn_lambda
Parameter for the Field-Noyes model of the Belousov-Zhabotinsky reaction.
type(mg_bc_t), dimension(3, mg_num_neighbors), public rd_mg_bc
Boundary condition information for the multigrid method.
subroutine, public rd_phys_init()
double precision, public, protected d3
Diffusion coefficient for third species (w) (if applicable)
logical, public, protected rd_particles
Whether particles module is added.
double precision, public, protected sb_kappa
Parameter for Schnakenberg model.
double precision, public, protected br_d
Parameter for extended Brusselator model.
double precision, public, protected gs_k
Kill rate for Gray-Scott model.
double precision, public, protected d2
Diffusion coefficient for second species (v) (if applicable)
double precision, public, protected dtreacpar
Parameter with which to multiply the reaction timestep restriction.
integer, public, protected w_
For 3 or more equations.
double precision, public, protected bzfn_epsilon
Parameter for the Field-Noyes model of the Belousov-Zhabotinsky reaction.
double precision, public, protected d1
Diffusion coefficient for first species (u)
double precision, public, protected lg_lambda
Parameter for logistic model (Fisher / KPP equation)
integer, public, protected v_
For 2 or more equations.
double precision, public, protected sb_beta
Parameter for Schnakenberg model.
double precision, public, protected bzfn_mu
Parameter for the Field-Noyes model of the Belousov-Zhabotinsky reaction.
double precision, public, protected sb_alpha
Parameter for Schnakenberg model.
double precision, public, protected bzfn_delta
Parameter for the Field-Noyes model of the Belousov-Zhabotinsky reaction.
double precision, public, protected lor_r
Parameter for Lorenz system (Rayleigh number)
double precision, public, protected br_a
Parameter for Brusselator model.
double precision, public, protected lor_sigma
Parameter for Lorenz system (Prandtl number)
double precision, public, protected br_c
Parameter for extended Brusselator model.
character(len=20), public, protected equation_name
Name of the system to be solved.
double precision, public, protected br_b
Parameter for Brusselator model.
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 data structure that contains information about a tree node/grid block.