MPI-AMRVAC 3.1
The MPI - Adaptive Mesh Refinement - Versatile Advection Code (development version)
Loading...
Searching...
No Matches
mod_mf_phys.t
Go to the documentation of this file.
1!> Magnetofriction module
3 use mod_global_parameters, only: std_len
5 use mod_comm_lib, only: mpistop
6
7
8 implicit none
9 private
10
11 !> viscosity coefficient in s cm^-2 for solar corona (Cheung 2012 ApJ)
12 double precision, public :: mf_nu = 1.d-15
13
14 !> maximal limit of magnetofrictional velocity in cm s^-1 (Pomoell 2019 A&A)
15 double precision, public :: mf_vmax = 3.d6
16
17 !> decay scale of frictional velocity near boundaries
18 double precision, public :: mf_decay_scale(2*^nd)=0.d0
19
20 !> GLM-MHD parameter: ratio of the diffusive and advective time scales for div b
21 !> taking values within [0, 1]
22 double precision, public :: mf_glm_alpha = 0.5d0
23
24 !> The resistivity
25 double precision, public :: mf_eta = 0.0d0
26
27 !> The hyper-resistivity
28 double precision, public :: mf_eta_hyper = 0.0d0
29
30 !> Coefficient of diffusive divB cleaning
31 double precision :: divbdiff = 0.8d0
32
33 !> Helium abundance over Hydrogen
34 double precision, public, protected :: he_abundance=0.1d0
35
36 !> Method type in a integer for good performance
37 integer :: type_divb
38
39 !> Indices of the momentum density
40 integer, allocatable, public, protected :: mom(:)
41
42 !> Indices of the GLM psi
43 integer, public, protected :: psi_
44
45 !> To skip * layer of ghost cells during divB=0 fix for boundary
46 integer, public, protected :: boundary_divbfix_skip(2*^nd)=0
47
48 ! DivB cleaning methods
49 integer, parameter :: divb_none = 0
50 integer, parameter :: divb_multigrid = -1
51 integer, parameter :: divb_glm = 1
52 integer, parameter :: divb_powel = 2
53 integer, parameter :: divb_janhunen = 3
54 integer, parameter :: divb_linde = 4
55 integer, parameter :: divb_lindejanhunen = 5
56 integer, parameter :: divb_lindepowel = 6
57 integer, parameter :: divb_lindeglm = 7
58 integer, parameter :: divb_ct = 8
59
60 !> Whether particles module is added
61 logical, public, protected :: mf_particles = .false.
62
63 !> Whether GLM-MHD is used
64 logical, public, protected :: mf_glm = .false.
65
66 !> Whether divB cleaning sources are added splitting from fluid solver
67 logical, public, protected :: source_split_divb = .false.
68
69 !> MHD fourth order
70 logical, public, protected :: mf_4th_order = .false.
71
72 !> set to true if need to record electric field on cell edges
73 logical, public, protected :: mf_record_electric_field = .false.
74
75 !> Whether divB is computed with a fourth order approximation
76 integer, public, protected :: mf_divb_nth = 1
77
78 !> To control divB=0 fix for boundary
79 logical, public, protected :: boundary_divbfix(2*^nd)=.true.
80
81 !> Use a compact way to add resistivity
82 logical :: compactres = .false.
83
84 !> Add divB wave in Roe solver
85 logical, public :: divbwave = .true.
86
87 !> clean divb in the initial condition
88 logical, public, protected :: clean_initial_divb=.false.
89
90 !> Method type to clean divergence of B
91 character(len=std_len), public, protected :: typedivbfix = 'ct'
92
93 !> Method type of constrained transport
94 character(len=std_len), public, protected :: type_ct = 'average'
95
96 !> Update all equations due to divB cleaning
97 character(len=std_len) :: typedivbdiff = 'all'
98
99
100 ! Public methods
101 public :: mf_phys_init
102 public :: mf_to_conserved
103 public :: mf_to_primitive
104 public :: mf_face_to_center
105 public :: get_divb
106 public :: get_current
107 public :: get_normalized_divb
110 {^nooned
112 }
113
114contains
115
116 !> Read this module's parameters from a file
117 subroutine mf_read_params(files)
119 use mod_particles, only: particles_eta
120 character(len=*), intent(in) :: files(:)
121 integer :: n
122
123 namelist /mf_list/ mf_nu, mf_vmax, mf_decay_scale, &
125 particles_eta, mf_record_electric_field,&
127 typedivbdiff, type_ct, compactres, divbwave, he_abundance, si_unit, &
130
131 do n = 1, size(files)
132 open(unitpar, file=trim(files(n)), status="old")
133 read(unitpar, mf_list, end=111)
134111 close(unitpar)
135 end do
136
137 end subroutine mf_read_params
138
139 !> Write this module's parameters to a snapsoht
140 subroutine mf_write_info(fh)
142 integer, intent(in) :: fh
143 integer, parameter :: n_par = 1
144 double precision :: values(n_par)
145 character(len=name_len) :: names(n_par)
146 integer, dimension(MPI_STATUS_SIZE) :: st
147 integer :: er
148
149 call mpi_file_write(fh, n_par, 1, mpi_integer, st, er)
150
151 names(1) = "nu"
152 values(1) = mf_nu
153 call mpi_file_write(fh, values, n_par, mpi_double_precision, st, er)
154 call mpi_file_write(fh, names, n_par * name_len, mpi_character, st, er)
155 end subroutine mf_write_info
156
157 subroutine mf_phys_init()
159 use mod_physics
160 use mod_particles, only: particles_init, particles_eta, particles_etah
161 {^nooned
163 }
164
165 integer :: itr, idir
166
167 call mf_read_params(par_files)
168
169 physics_type = "mf"
170 phys_energy = .false.
172
173 if(ndim==1) typedivbfix='none'
174 select case (typedivbfix)
175 case ('none')
176 type_divb = divb_none
177 {^nooned
178 case ('multigrid')
179 type_divb = divb_multigrid
180 use_multigrid = .true.
181 mg%operator_type = mg_laplacian
183 }
184 case ('glm')
185 mf_glm = .true.
186 need_global_cmax = .true.
187 type_divb = divb_glm
188 case ('powel', 'powell')
189 type_divb = divb_powel
190 case ('janhunen')
191 type_divb = divb_janhunen
192 case ('linde')
193 type_divb = divb_linde
194 case ('lindejanhunen')
195 type_divb = divb_lindejanhunen
196 case ('lindepowel')
197 type_divb = divb_lindepowel
198 case ('lindeglm')
199 mf_glm = .true.
200 need_global_cmax = .true.
201 type_divb = divb_lindeglm
202 case ('ct')
203 type_divb = divb_ct
204 stagger_grid = .true.
205 case default
206 call mpistop('Unknown divB fix')
207 end select
208
209 ! set velocity field as flux variables
210 allocate(mom(ndir))
211 mom(:) = var_set_momentum(ndir)
212
213 ! set magnetic field as flux variables
214 allocate(mag(ndir))
215 mag(:) = var_set_bfield(ndir)
216
217 ! start with magnetic field and skip velocity when update ghostcells
218 iwstart=mag(1)
219 allocate(start_indices(number_species),stop_indices(number_species))
220 ! set the index of the first flux variable for species 1
221 start_indices(1)=mag(1)
222
223 if (mf_glm) then
224 psi_ = var_set_fluxvar('psi', 'psi', need_bc=.false.)
225 else
226 psi_ = -1
227 end if
228
229 ! set number of variables which need update ghostcells
230 nwgc=nwflux-ndir
231
232 ! set the index of the last flux variable for species 1
233 stop_indices(1)=nwflux
234
235 ! determine number of stagger variables
236 nws=ndim
237
238 nvector = 2 ! No. vector vars
239 allocate(iw_vector(nvector))
240 iw_vector(1) = mom(1) - 1 ! TODO: why like this?
241 iw_vector(2) = mag(1) - 1 ! TODO: why like this?
242
243 ! Check whether custom flux types have been defined
244 if (.not. allocated(flux_type)) then
245 allocate(flux_type(ndir, nw))
247 else if (any(shape(flux_type) /= [ndir, nw])) then
248 call mpistop("phys_check error: flux_type has wrong shape")
249 end if
250 do idir=1,ndir
251 if(ndim>1) flux_type(idir,mag(idir))=flux_tvdlf
252 end do
253 if(mf_glm .and. ndim>1) flux_type(:,psi_)=flux_tvdlf
254
255 phys_get_dt => mf_get_dt
256 phys_get_cmax => mf_get_cmax
257 phys_get_cbounds => mf_get_cbounds
258 phys_get_flux => mf_get_flux
259 phys_add_source_geom => mf_add_source_geom
260 phys_add_source => mf_add_source
263 phys_check_params => mf_check_params
264 phys_write_info => mf_write_info
265 phys_special_advance => mf_velocity_update
266
267 if(type_divb==divb_glm) then
268 phys_modify_wlr => mf_modify_wlr
269 end if
270
271 ! pass to global variable to record electric field
273
274 ! Initialize particles module
275 if(mf_particles) then
276 call particles_init()
277 ! never allow Hall effects in particles when doing magnetofrictional
278 particles_etah=0.0d0
279 if(mype==0) then
280 write(*,*) '*****Using particles: with mf_eta, mf_eta_hyper :', mf_eta, mf_eta_hyper
281 write(*,*) '*****Using particles: particles_eta, particles_etah :', particles_eta, particles_etah
282 end if
283 end if
284
285 ! if using ct stagger grid, boundary divb=0 is not done here
286 if(stagger_grid) then
287 phys_get_ct_velocity => mf_get_ct_velocity
288 phys_update_faces => mf_update_faces
290 else if(ndim>1) then
291 phys_boundary_adjust => mf_boundary_adjust
292 end if
293
294 {^nooned
295 ! clean initial divb
297 }
298
299 ! derive units from basic units
300 call mf_physical_units()
301
302 end subroutine mf_phys_init
303
304 subroutine mf_check_params
306
307 end subroutine mf_check_params
308
309 subroutine mf_physical_units()
311 double precision :: mp,kb,miu0,c_lightspeed
312 ! Derive scaling units
313 if(si_unit) then
314 mp=mp_si
315 kb=kb_si
316 miu0=miu0_si
317 c_lightspeed=c_si
318 else
319 mp=mp_cgs
320 kb=kb_cgs
321 miu0=4.d0*dpi
322 c_lightspeed=const_c
323 end if
324 if(unit_density/=1.d0) then
326 else
327 ! unit of numberdensity is independent by default
329 end if
330 if(unit_velocity/=1.d0) then
334 else if(unit_pressure/=1.d0) then
338 else if(unit_magneticfield/=1.d0) then
342 else
343 ! unit of temperature is independent by default
347 end if
348 if(unit_time/=1.d0) then
350 else
351 ! unit of length is independent by default
353 end if
354 ! Additional units needed for the particles
355 c_norm=c_lightspeed/unit_velocity
357 if (.not. si_unit) unit_charge = unit_charge*const_c
359
360 ! get dimensionless mf nu
362
363 ! get dimensionless maximal mf velocity limit
365
366 end subroutine mf_physical_units
367
368 !> Transform primitive variables into conservative ones
369 subroutine mf_to_conserved(ixI^L,ixO^L,w,x)
371 integer, intent(in) :: ixi^l, ixo^l
372 double precision, intent(inout) :: w(ixi^s, nw)
373 double precision, intent(in) :: x(ixi^s, 1:ndim)
374
375 ! nothing to do for mf
376 end subroutine mf_to_conserved
377
378 !> Transform conservative variables into primitive ones
379 subroutine mf_to_primitive(ixI^L,ixO^L,w,x)
381 integer, intent(in) :: ixi^l, ixo^l
382 double precision, intent(inout) :: w(ixi^s, nw)
383 double precision, intent(in) :: x(ixi^s, 1:ndim)
384
385 ! nothing to do for mf
386 end subroutine mf_to_primitive
387
388 !> Calculate cmax_idim=csound+abs(v_idim) within ixO^L
389 subroutine mf_get_cmax(w,x,ixI^L,ixO^L,idim,cmax)
391
392 integer, intent(in) :: ixi^l, ixo^l, idim
393 double precision, intent(in) :: w(ixi^s, nw), x(ixi^s,1:ndim)
394 double precision, intent(inout) :: cmax(ixi^s)
395
396 cmax(ixo^s)=abs(w(ixo^s,mom(idim)))+one
397
398 end subroutine mf_get_cmax
399
400 !> Estimating bounds for the minimum and maximum signal velocities
401 subroutine mf_get_cbounds(wLC,wRC,wLp,wRp,x,ixI^L,ixO^L,idim,Hspeed,cmax,cmin)
403 use mod_variables
404
405 integer, intent(in) :: ixi^l, ixo^l, idim
406 double precision, intent(in) :: wlc(ixi^s, nw), wrc(ixi^s, nw)
407 double precision, intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
408 double precision, intent(in) :: x(ixi^s,1:ndim)
409 double precision, intent(inout) :: cmax(ixi^s,1:number_species)
410 double precision, intent(inout), optional :: cmin(ixi^s,1:number_species)
411 double precision, intent(in) :: hspeed(ixi^s,1:number_species)
412
413 double precision, dimension(ixI^S) :: tmp1
414
415 tmp1(ixo^s)=0.5d0*(wlc(ixo^s,mom(idim))+wrc(ixo^s,mom(idim)))
416 if(present(cmin)) then
417 cmax(ixo^s,1)=max(tmp1(ixo^s)+one,zero)
418 cmin(ixo^s,1)=min(tmp1(ixo^s)-one,zero)
419 else
420 cmax(ixo^s,1)=abs(tmp1(ixo^s))+one
421 end if
422
423 end subroutine mf_get_cbounds
424
425 !> prepare velocities for ct methods
426 subroutine mf_get_ct_velocity(vcts,wLp,wRp,ixI^L,ixO^L,idim,cmax,cmin)
428
429 integer, intent(in) :: ixi^l, ixo^l, idim
430 double precision, intent(in) :: wlp(ixi^s, nw), wrp(ixi^s, nw)
431 double precision, intent(in) :: cmax(ixi^s)
432 double precision, intent(in), optional :: cmin(ixi^s)
433 type(ct_velocity), intent(inout):: vcts
434
435 integer :: idime,idimn
436
437 ! calculate velocities related to different UCT schemes
438 select case(type_ct)
439 case('average')
440 case('uct_contact')
441 if(.not.allocated(vcts%vnorm)) allocate(vcts%vnorm(ixi^s,1:ndim))
442 ! get average normal velocity at cell faces
443 vcts%vnorm(ixo^s,idim)=0.5d0*(wlp(ixo^s,mom(idim))+wrp(ixo^s,mom(idim)))
444 case('uct_hll')
445 if(.not.allocated(vcts%vbarC)) then
446 allocate(vcts%vbarC(ixi^s,1:ndir,2),vcts%vbarLC(ixi^s,1:ndir,2),vcts%vbarRC(ixi^s,1:ndir,2))
447 allocate(vcts%cbarmin(ixi^s,1:ndim),vcts%cbarmax(ixi^s,1:ndim))
448 end if
449 ! Store magnitude of characteristics
450 if(present(cmin)) then
451 vcts%cbarmin(ixo^s,idim)=max(-cmin(ixo^s),zero)
452 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
453 else
454 vcts%cbarmax(ixo^s,idim)=max( cmax(ixo^s),zero)
455 vcts%cbarmin(ixo^s,idim)=vcts%cbarmax(ixo^s,idim)
456 end if
457
458 idimn=mod(idim,ndir)+1 ! 'Next' direction
459 idime=mod(idim+1,ndir)+1 ! Electric field direction
460 ! Store velocities
461 vcts%vbarLC(ixo^s,idim,1)=wlp(ixo^s,mom(idimn))
462 vcts%vbarRC(ixo^s,idim,1)=wrp(ixo^s,mom(idimn))
463 vcts%vbarC(ixo^s,idim,1)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,1) &
464 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
465 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
466
467 vcts%vbarLC(ixo^s,idim,2)=wlp(ixo^s,mom(idime))
468 vcts%vbarRC(ixo^s,idim,2)=wrp(ixo^s,mom(idime))
469 vcts%vbarC(ixo^s,idim,2)=(vcts%cbarmax(ixo^s,idim)*vcts%vbarLC(ixo^s,idim,2) &
470 +vcts%cbarmin(ixo^s,idim)*vcts%vbarRC(ixo^s,idim,1))&
471 /(vcts%cbarmax(ixo^s,idim)+vcts%cbarmin(ixo^s,idim))
472 case default
473 call mpistop('choose average, uct_contact,or uct_hll for type_ct!')
474 end select
475
476 end subroutine mf_get_ct_velocity
477
478 !> Calculate fluxes within ixO^L.
479 subroutine mf_get_flux(wC,w,x,ixI^L,ixO^L,idim,f)
482 use mod_geometry
483
484 integer, intent(in) :: ixi^l, ixo^l, idim
485 ! conservative w
486 double precision, intent(in) :: wc(ixi^s,nw)
487 ! primitive w
488 double precision, intent(in) :: w(ixi^s,nw)
489 double precision, intent(in) :: x(ixi^s,1:ndim)
490 double precision,intent(out) :: f(ixi^s,nwflux)
491
492 integer :: idir, ix^d
493
494 do idir=1,ndir
495 {do ix^db=ixomin^db,ixomax^db\}
496 ! compute flux of magnetic field
497 ! f_i[b_k]=v_i*b_k-v_k*b_i
498 f(ix^d,mag(idir))=w(ix^d,mom(idim))*w(ix^d,mag(idir))-w(ix^d,mag(idim))*w(ix^d,mom(idir))
499 {end do\}
500 end do
501 if(mf_glm) then
502 {do ix^db=ixomin^db,ixomax^db\}
503 f(ix^d,mag(idim))=w(ix^d,psi_)
504 !f_i[psi]=Ch^2*b_{i} Eq. 24e and Eq. 38c Dedner et al 2002 JCP, 175, 645
505 f(ix^d,psi_)=cmax_global**2*w(ix^d,mag(idim))
506 {end do\}
507 end if
508
509 end subroutine mf_get_flux
510
511 !> Add global source terms to update frictional velocity on complete domain
512 subroutine mf_velocity_update(qt,psa)
515 double precision, intent(in) :: qt !< Current time
516 type(state), target :: psa(max_blocks) !< Compute based on this state
517
518 integer :: iigrid,igrid
519 logical :: stagger_flag
520 logical :: firstmf=.true.
521
522 if(firstmf) then
523 ! point bc mpi datatype to partial type for velocity field
531 firstmf=.false.
532 end if
533
534 !$OMP PARALLEL DO PRIVATE(igrid)
535 do iigrid=1,igridstail_active; igrid=igrids_active(iigrid);
536 block=>psa(igrid)
537 call frictional_velocity(psa(igrid)%w,psa(igrid)%x,ixg^ll,ixm^ll)
538 end do
539 !$OMP END PARALLEL DO
540
541 ! only update mf velocity in ghost cells
542 stagger_flag=stagger_grid
549 stagger_grid=.false.
550 bcphys=.false.
551 call getbc(qt,0.d0,psa,mom(1),ndir)
552 bcphys=.true.
559 stagger_grid=stagger_flag
560
561 end subroutine mf_velocity_update
562
563 !> w[iws]=w[iws]+qdt*S[iws,wCT] where S is the source based on wCT within ixO
564 subroutine mf_add_source(qdt,dtfactor,ixI^L,ixO^L,wCT,wCTprim,w,x,qsourcesplit,active)
566
567 integer, intent(in) :: ixi^l, ixo^l
568 double precision, intent(in) :: qdt, dtfactor
569 double precision, intent(in) :: wct(ixi^s,1:nw),wctprim(ixi^s,1:nw), x(ixi^s,1:ndim)
570 double precision, intent(inout) :: w(ixi^s,1:nw)
571 logical, intent(in) :: qsourcesplit
572 logical, intent(inout) :: active
573
574 if (.not. qsourcesplit) then
575
576 ! Sources for resistivity in eqs. for e, B1, B2 and B3
577 if (abs(mf_eta)>smalldouble)then
578 active = .true.
579 call add_source_res2(qdt,ixi^l,ixo^l,wct,w,x)
580 end if
581
582 if (mf_eta_hyper>0.d0)then
583 active = .true.
584 call add_source_hyperres(qdt,ixi^l,ixo^l,wct,w,x)
585 end if
586
587 end if
588
589 {^nooned
590 if(source_split_divb .eqv. qsourcesplit) then
591 ! Sources related to div B
592 select case (type_divb)
593 case (divb_none)
594 ! Do nothing
595 case (divb_glm)
596 active = .true.
597 call add_source_glm(qdt,ixi^l,ixo^l,wct,w,x)
598 case (divb_powel)
599 active = .true.
600 call add_source_powel(qdt,ixi^l,ixo^l,wct,w,x)
601 case (divb_janhunen)
602 active = .true.
603 call add_source_janhunen(qdt,ixi^l,ixo^l,wct,w,x)
604 case (divb_linde)
605 active = .true.
606 call add_source_linde(qdt,ixi^l,ixo^l,wct,w,x)
607 case (divb_lindejanhunen)
608 active = .true.
609 call add_source_linde(qdt,ixi^l,ixo^l,wct,w,x)
610 call add_source_janhunen(qdt,ixi^l,ixo^l,wct,w,x)
611 case (divb_lindepowel)
612 active = .true.
613 call add_source_linde(qdt,ixi^l,ixo^l,wct,w,x)
614 call add_source_powel(qdt,ixi^l,ixo^l,wct,w,x)
615 case (divb_lindeglm)
616 active = .true.
617 call add_source_linde(qdt,ixi^l,ixo^l,wct,w,x)
618 call add_source_glm(qdt,ixi^l,ixo^l,wct,w,x)
619 case (divb_ct)
620 continue ! Do nothing
621 case (divb_multigrid)
622 continue ! Do nothing
623 case default
624 call mpistop('Unknown divB fix')
625 end select
626 end if
627 }
628
629 end subroutine mf_add_source
630
631 subroutine frictional_velocity(w,x,ixI^L,ixO^L)
633
634 integer, intent(in) :: ixi^l, ixo^l
635 double precision, intent(in) :: x(ixi^s,1:ndim)
636 double precision, intent(inout) :: w(ixi^s,1:nw)
637
638 double precision :: xmin(ndim),xmax(ndim)
639 double precision :: decay(ixo^s)
640 double precision :: current(ixi^s,7-2*ndir:3),tmp(ixo^s)
641 integer :: ix^d, idirmin,idir,jdir,kdir
642
643 call get_current(w,ixi^l,ixo^l,idirmin,current)
644 ! extrapolate current for the outmost layer,
645 ! because extrapolation of B at boundaries introduces artificial current
646{
647 if(block%is_physical_boundary(2*^d-1)) then
648 if(slab) then
649 ! exclude boundary 5 in 3D Cartesian
650 if(2*^d-1==5.and.ndim==3) then
651 else
652 current(ixomin^d^d%ixO^s,:)=current(ixomin^d+1^d%ixO^s,:)
653 end if
654 else
655 ! exclude boundary 1 spherical/cylindrical
656 if(2*^d-1>1) then
657 current(ixomin^d^d%ixO^s,:)=current(ixomin^d+1^d%ixO^s,:)
658 end if
659 end if
660 end if
661 if(block%is_physical_boundary(2*^d)) then
662 current(ixomax^d^d%ixO^s,:)=current(ixomax^d-1^d%ixO^s,:)
663 end if
664\}
665 w(ixo^s,mom(:))=0.d0
666 ! calculate Lorentz force
667 do idir=1,ndir; do jdir=idirmin,3; do kdir=1,ndir
668 if(lvc(idir,jdir,kdir)/=0) then
669 if(lvc(idir,jdir,kdir)==1) then
670 w(ixo^s,mom(idir))=w(ixo^s,mom(idir))+current(ixo^s,jdir)*w(ixo^s,mag(kdir))
671 else
672 w(ixo^s,mom(idir))=w(ixo^s,mom(idir))-current(ixo^s,jdir)*w(ixo^s,mag(kdir))
673 end if
674 end if
675 end do; end do; end do
676
677 tmp(ixo^s)=sum(w(ixo^s,mag(:))**2,dim=ndim+1)
678 ! frictional coefficient
679 where(tmp(ixo^s)/=0.d0)
680 tmp(ixo^s)=1.d0/(tmp(ixo^s)*mf_nu)
681 endwhere
682
683 do idir=1,ndir
684 w(ixo^s,mom(idir))=w(ixo^s,mom(idir))*tmp(ixo^s)
685 end do
686
687 ! decay frictional velocity near selected boundaries
688 ^d&xmin(^d)=xprobmin^d\
689 ^d&xmax(^d)=xprobmax^d\
690 decay(ixo^s)=1.d0
691 do idir=1,ndim
692 if(mf_decay_scale(2*idir-1)>0.d0) decay(ixo^s)=decay(ixo^s)*&
693 (1.d0-exp(-(x(ixo^s,idir)-xmin(idir))/mf_decay_scale(2*idir-1)))
694 if(mf_decay_scale(2*idir)>0.d0) decay(ixo^s)=decay(ixo^s)*&
695 (1.d0-exp((x(ixo^s,idir)-xmax(idir))/mf_decay_scale(2*idir)))
696 end do
697
698 ! saturate mf velocity at mf_vmax
699 tmp(ixo^s)=sqrt(sum(w(ixo^s,mom(:))**2,dim=ndim+1))/mf_vmax+1.d-12
700 tmp(ixo^s)=dtanh(tmp(ixo^s))/tmp(ixo^s)
701 do idir=1,ndir
702 w(ixo^s,mom(idir))=w(ixo^s,mom(idir))*tmp(ixo^s)*decay(ixo^s)
703 end do
704
705 end subroutine frictional_velocity
706
707 !> Add resistive source to w within ixO Uses 3 point stencil (1 neighbour) in
708 !> each direction, non-conservative. If the fourthorder precompiler flag is
709 !> set, uses fourth order central difference for the laplacian. Then the
710 !> stencil is 5 (2 neighbours).
711 subroutine add_source_res1(qdt,ixI^L,ixO^L,wCT,w,x)
714 use mod_geometry
715
716 integer, intent(in) :: ixi^l, ixo^l
717 double precision, intent(in) :: qdt
718 double precision, intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:ndim)
719 double precision, intent(inout) :: w(ixi^s,1:nw)
720
721 ! For ndir=2 only 3rd component of J can exist, ndir=1 is impossible for MHD
722 double precision :: current(ixi^s,7-2*ndir:3),eta(ixi^s)
723 double precision :: gradeta(ixi^s,1:ndim), bf(ixi^s,1:ndir)
724 double precision :: tmp(ixi^s),tmp2(ixi^s)
725 integer :: ixa^l,idir,jdir,kdir,idirmin,idim,jxo^l,hxo^l,ix
726 integer :: lxo^l, kxo^l
727
728 ! Calculating resistive sources involve one extra layer
729 if (mf_4th_order) then
730 ixa^l=ixo^l^ladd2;
731 else
732 ixa^l=ixo^l^ladd1;
733 end if
734
735 if (iximin^d>ixamin^d.or.iximax^d<ixamax^d|.or.) &
736 call mpistop("Error in add_source_res1: Non-conforming input limits")
737
738 ! Calculate current density and idirmin
739 call get_current(wct,ixi^l,ixo^l,idirmin,current)
740
741 if (mf_eta>zero)then
742 eta(ixa^s)=mf_eta
743 gradeta(ixo^s,1:ndim)=zero
744 else
745 call usr_special_resistivity(wct,ixi^l,ixa^l,idirmin,x,current,eta)
746 ! assumes that eta is not function of current?
747 do idim=1,ndim
748 call gradient(eta,ixi^l,ixo^l,idim,tmp)
749 gradeta(ixo^s,idim)=tmp(ixo^s)
750 end do
751 end if
752
753 bf(ixi^s,1:ndir)=wct(ixi^s,mag(1:ndir))
754
755 do idir=1,ndir
756 ! Put B_idir into tmp2 and eta*Laplace B_idir into tmp
757 if (mf_4th_order) then
758 tmp(ixo^s)=zero
759 tmp2(ixi^s)=bf(ixi^s,idir)
760 do idim=1,ndim
761 lxo^l=ixo^l+2*kr(idim,^d);
762 jxo^l=ixo^l+kr(idim,^d);
763 hxo^l=ixo^l-kr(idim,^d);
764 kxo^l=ixo^l-2*kr(idim,^d);
765 tmp(ixo^s)=tmp(ixo^s)+&
766 (-tmp2(lxo^s)+16.0d0*tmp2(jxo^s)-30.0d0*tmp2(ixo^s)+16.0d0*tmp2(hxo^s)-tmp2(kxo^s)) &
767 /(12.0d0 * dxlevel(idim)**2)
768 end do
769 else
770 tmp(ixo^s)=zero
771 tmp2(ixi^s)=bf(ixi^s,idir)
772 do idim=1,ndim
773 jxo^l=ixo^l+kr(idim,^d);
774 hxo^l=ixo^l-kr(idim,^d);
775 tmp(ixo^s)=tmp(ixo^s)+&
776 (tmp2(jxo^s)-2.0d0*tmp2(ixo^s)+tmp2(hxo^s))/dxlevel(idim)**2
777 end do
778 end if
779
780 ! Multiply by eta
781 tmp(ixo^s)=tmp(ixo^s)*eta(ixo^s)
782
783 ! Subtract grad(eta) x J = eps_ijk d_j eta J_k if eta is non-constant
784 if (mf_eta<zero)then
785 do jdir=1,ndim; do kdir=idirmin,3
786 if (lvc(idir,jdir,kdir)/=0)then
787 if (lvc(idir,jdir,kdir)==1)then
788 tmp(ixo^s)=tmp(ixo^s)-gradeta(ixo^s,jdir)*current(ixo^s,kdir)
789 else
790 tmp(ixo^s)=tmp(ixo^s)+gradeta(ixo^s,jdir)*current(ixo^s,kdir)
791 end if
792 end if
793 end do; end do
794 end if
795
796 ! Add sources related to eta*laplB-grad(eta) x J to B and e
797 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))+qdt*tmp(ixo^s)
798
799 end do ! idir
800
801 end subroutine add_source_res1
802
803 !> Add resistive source to w within ixO
804 !> Uses 5 point stencil (2 neighbours) in each direction, conservative
805 subroutine add_source_res2(qdt,ixI^L,ixO^L,wCT,w,x)
808 use mod_geometry
809
810 integer, intent(in) :: ixi^l, ixo^l
811 double precision, intent(in) :: qdt
812 double precision, intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:ndim)
813 double precision, intent(inout) :: w(ixi^s,1:nw)
814
815 ! For ndir=2 only 3rd component of J can exist, ndir=1 is impossible for MHD
816 double precision :: current(ixi^s,7-2*ndir:3),eta(ixi^s),curlj(ixi^s,1:3)
817 double precision :: tmpvec(ixi^s,1:3)
818 integer :: ixa^l,idir,idirmin,idirmin1
819
820 ! resistive term already added as an electric field component
821 if(stagger_grid .and. ndim==ndir) return
822
823 ixa^l=ixo^l^ladd2;
824
825 if (iximin^d>ixamin^d.or.iximax^d<ixamax^d|.or.) &
826 call mpistop("Error in add_source_res2: Non-conforming input limits")
827
828 ixa^l=ixo^l^ladd1;
829 ! Calculate current density within ixL: J=curl B, thus J_i=eps_ijk*d_j B_k
830 ! Determine exact value of idirmin while doing the loop.
831 call get_current(wct,ixi^l,ixa^l,idirmin,current)
832
833 if (mf_eta>zero)then
834 eta(ixa^s)=mf_eta
835 else
836 call usr_special_resistivity(wct,ixi^l,ixa^l,idirmin,x,current,eta)
837 end if
838
839 ! dB/dt= -curl(J*eta), thus B_i=B_i-eps_ijk d_j Jeta_k
840 tmpvec(ixa^s,1:ndir)=zero
841 do idir=idirmin,3
842 tmpvec(ixa^s,idir)=current(ixa^s,idir)*eta(ixa^s)
843 end do
844 curlj=0.d0
845 call curlvector(tmpvec,ixi^l,ixo^l,curlj,idirmin1,1,3)
846 if(stagger_grid) then
847 if(ndim==2.and.ndir==3) then
848 ! if 2.5D
849 w(ixo^s,mag(ndir)) = w(ixo^s,mag(ndir))-qdt*curlj(ixo^s,ndir)
850 end if
851 else
852 w(ixo^s,mag(1:ndir)) = w(ixo^s,mag(1:ndir))-qdt*curlj(ixo^s,1:ndir)
853 end if
854
855 end subroutine add_source_res2
856
857 !> Add Hyper-resistive source to w within ixO
858 !> Uses 9 point stencil (4 neighbours) in each direction.
859 subroutine add_source_hyperres(qdt,ixI^L,ixO^L,wCT,w,x)
861 use mod_geometry
862
863 integer, intent(in) :: ixi^l, ixo^l
864 double precision, intent(in) :: qdt
865 double precision, intent(in) :: wct(ixi^s,1:nw), x(ixi^s,1:ndim)
866 double precision, intent(inout) :: w(ixi^s,1:nw)
867 !.. local ..
868 double precision :: current(ixi^s,7-2*ndir:3)
869 double precision :: tmpvec(ixi^s,1:3),tmpvec2(ixi^s,1:3),tmp(ixi^s),ehyper(ixi^s,1:3)
870 integer :: ixa^l,idir,jdir,kdir,idirmin,idirmin1
871
872 ixa^l=ixo^l^ladd3;
873 if (iximin^d>ixamin^d.or.iximax^d<ixamax^d|.or.) &
874 call mpistop("Error in add_source_hyperres: Non-conforming input limits")
875
876 call get_current(wct,ixi^l,ixa^l,idirmin,current)
877 tmpvec(ixa^s,1:ndir)=zero
878 do jdir=idirmin,3
879 tmpvec(ixa^s,jdir)=current(ixa^s,jdir)
880 end do
881
882 ixa^l=ixo^l^ladd2;
883 call curlvector(tmpvec,ixi^l,ixa^l,tmpvec2,idirmin1,1,3)
884
885 ixa^l=ixo^l^ladd1;
886 tmpvec(ixa^s,1:ndir)=zero
887 call curlvector(tmpvec2,ixi^l,ixa^l,tmpvec,idirmin1,1,3)
888 ehyper(ixa^s,1:ndir) = - tmpvec(ixa^s,1:ndir)*mf_eta_hyper
889
890 ixa^l=ixo^l;
891 tmpvec2(ixa^s,1:ndir)=zero
892 call curlvector(ehyper,ixi^l,ixa^l,tmpvec2,idirmin1,1,3)
893
894 do idir=1,ndir
895 w(ixo^s,mag(idir)) = w(ixo^s,mag(idir))-tmpvec2(ixo^s,idir)*qdt
896 end do
897
898 end subroutine add_source_hyperres
899
900 subroutine add_source_glm(qdt,ixI^L,ixO^L,wCT,w,x)
901 ! Add divB related sources to w within ixO
902 ! corresponding to Dedner JCP 2002, 175, 645 _equation 24_
903 ! giving the EGLM-MHD scheme
905 use mod_geometry
906
907 integer, intent(in) :: ixi^l, ixo^l
908 double precision, intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:ndim)
909 double precision, intent(inout) :: w(ixi^s,1:nw)
910 double precision:: divb(ixi^s)
911 double precision :: gradpsi(ixi^s)
912 integer :: idim,idir
913
914 ! We calculate now div B
915 call get_divb(wct,ixi^l,ixo^l,divb,mf_divb_nth)
916
917 ! dPsi/dt = - Ch^2/Cp^2 Psi
918 if (mf_glm_alpha < zero) then
919 w(ixo^s,psi_) = abs(mf_glm_alpha)*wct(ixo^s,psi_)
920 else
921 ! implicit update of Psi variable
922 ! equation (27) in Mignone 2010 J. Com. Phys. 229, 2117
923 if(slab_uniform) then
924 w(ixo^s,psi_) = dexp(-qdt*cmax_global*mf_glm_alpha/minval(dxlevel(:)))*w(ixo^s,psi_)
925 else
926 w(ixo^s,psi_) = dexp(-qdt*cmax_global*mf_glm_alpha/minval(block%ds(ixo^s,:),dim=ndim+1))*w(ixo^s,psi_)
927 end if
928 end if
929
930 ! gradient of Psi
931 do idim=1,ndim
932 select case(typegrad)
933 case("central")
934 call gradient(wct(ixi^s,psi_),ixi^l,ixo^l,idim,gradpsi)
935 case("limited")
936 call gradientl(wct(ixi^s,psi_),ixi^l,ixo^l,idim,gradpsi)
937 end select
938 end do
939 end subroutine add_source_glm
940
941 !> Add divB related sources to w within ixO corresponding to Powel
942 subroutine add_source_powel(qdt,ixI^L,ixO^L,wCT,w,x)
944
945 integer, intent(in) :: ixi^l, ixo^l
946 double precision, intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:ndim)
947 double precision, intent(inout) :: w(ixi^s,1:nw)
948
949 double precision :: divb(ixi^s)
950 integer :: idir
951
952 ! We calculate now div B
953 call get_divb(wct,ixi^l,ixo^l,divb,mf_divb_nth)
954
955 ! b = b - qdt v * div b
956 do idir=1,ndir
957 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))-qdt*wct(ixo^s,mom(idir))*divb(ixo^s)
958 end do
959
960 end subroutine add_source_powel
961
962 subroutine add_source_janhunen(qdt,ixI^L,ixO^L,wCT,w,x)
963 ! Add divB related sources to w within ixO
964 ! corresponding to Janhunen, just the term in the induction equation.
966
967 integer, intent(in) :: ixi^l, ixo^l
968 double precision, intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:ndim)
969 double precision, intent(inout) :: w(ixi^s,1:nw)
970 double precision :: divb(ixi^s)
971 integer :: idir
972
973 ! We calculate now div B
974 call get_divb(wct,ixi^l,ixo^l,divb,mf_divb_nth)
975
976 ! b = b - qdt v * div b
977 do idir=1,ndir
978 w(ixo^s,mag(idir))=w(ixo^s,mag(idir))-qdt*wct(ixo^s,mom(idir))*divb(ixo^s)
979 end do
980
981 end subroutine add_source_janhunen
982
983 subroutine add_source_linde(qdt,ixI^L,ixO^L,wCT,w,x)
984 ! Add Linde's divB related sources to wnew within ixO
986 use mod_geometry
987
988 integer, intent(in) :: ixi^l, ixo^l
989 double precision, intent(in) :: qdt, wct(ixi^s,1:nw), x(ixi^s,1:ndim)
990 double precision, intent(inout) :: w(ixi^s,1:nw)
991 double precision :: divb(ixi^s),graddivb(ixi^s)
992 integer :: idim, idir, ixp^l, i^d, iside
993 logical, dimension(-1:1^D&) :: leveljump
994
995 ! Calculate div B
996 ixp^l=ixo^l^ladd1;
997 call get_divb(wct,ixi^l,ixp^l,divb,mf_divb_nth)
998
999 ! for AMR stability, retreat one cell layer from the boarders of level jump
1000 {do i^db=-1,1\}
1001 if(i^d==0|.and.) cycle
1002 if(neighbor_type(i^d,block%igrid)==2 .or. neighbor_type(i^d,block%igrid)==4) then
1003 leveljump(i^d)=.true.
1004 else
1005 leveljump(i^d)=.false.
1006 end if
1007 {end do\}
1008
1009 ixp^l=ixo^l;
1010 do idim=1,ndim
1011 select case(idim)
1012 {case(^d)
1013 do iside=1,2
1014 i^dd=kr(^dd,^d)*(2*iside-3);
1015 if (leveljump(i^dd)) then
1016 if (iside==1) then
1017 ixpmin^d=ixomin^d-i^d
1018 else
1019 ixpmax^d=ixomax^d-i^d
1020 end if
1021 end if
1022 end do
1023 \}
1024 end select
1025 end do
1026
1027 ! Add Linde's diffusive terms
1028 do idim=1,ndim
1029 ! Calculate grad_idim(divb)
1030 select case(typegrad)
1031 case("central")
1032 call gradient(divb,ixi^l,ixp^l,idim,graddivb)
1033 case("limited")
1034 call gradientl(divb,ixi^l,ixp^l,idim,graddivb)
1035 end select
1036
1037 ! Multiply by Linde's eta*dt = divbdiff*(c_max*dx)*dt = divbdiff*dx**2
1038 if (slab_uniform) then
1039 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff/(^d&1.0d0/dxlevel(^d)**2+)
1040 else
1041 graddivb(ixp^s)=graddivb(ixp^s)*divbdiff &
1042 /(^d&1.0d0/block%ds(ixp^s,^d)**2+)
1043 end if
1044
1045 w(ixp^s,mag(idim))=w(ixp^s,mag(idim))+graddivb(ixp^s)
1046 end do
1047
1048 end subroutine add_source_linde
1049
1050
1051 !> get dimensionless div B = |divB| * volume / area / |B|
1052 subroutine get_normalized_divb(w,ixI^L,ixO^L,divb)
1053
1055
1056 integer, intent(in) :: ixi^l, ixo^l
1057 double precision, intent(in) :: w(ixi^s,1:nw)
1058 double precision :: divb(ixi^s), dsurface(ixi^s)
1059
1060 double precision :: invb(ixo^s)
1061 integer :: ixa^l,idims
1062
1063 call get_divb(w,ixi^l,ixo^l,divb)
1064 invb(ixo^s)=sqrt(sum(w(ixo^s, mag(:))**2, dim=ndim+1))
1065 where(invb(ixo^s)/=0.d0)
1066 invb(ixo^s)=1.d0/invb(ixo^s)
1067 end where
1068 if(slab_uniform) then
1069 divb(ixo^s)=0.5d0*abs(divb(ixo^s))*invb(ixo^s)/sum(1.d0/dxlevel(:))
1070 else
1071 ixamin^d=ixomin^d-1;
1072 ixamax^d=ixomax^d-1;
1073 dsurface(ixo^s)= sum(block%surfaceC(ixo^s,:),dim=ndim+1)
1074 do idims=1,ndim
1075 ixa^l=ixo^l-kr(idims,^d);
1076 dsurface(ixo^s)=dsurface(ixo^s)+block%surfaceC(ixa^s,idims)
1077 end do
1078 divb(ixo^s)=abs(divb(ixo^s))*invb(ixo^s)*&
1079 block%dvolume(ixo^s)/dsurface(ixo^s)
1080 end if
1081
1082 end subroutine get_normalized_divb
1083
1084 !> Calculate idirmin and the idirmin:3 components of the common current array
1085 !> make sure that dxlevel(^D) is set correctly.
1086 subroutine get_current(w,ixI^L,ixO^L,idirmin,current,fourthorder)
1088 use mod_geometry
1089
1090 integer, intent(in) :: ixo^l, ixi^l
1091 double precision, intent(in) :: w(ixi^s,1:nw)
1092 integer, intent(out) :: idirmin
1093 logical, intent(in), optional :: fourthorder
1094
1095 ! For ndir=2 only 3rd component of J can exist, ndir=1 is impossible for MHD
1096 double precision :: current(ixi^s,7-2*ndir:3)
1097 integer :: idir, idirmin0
1098
1099 idirmin0 = 7-2*ndir
1100
1101 if(present(fourthorder)) then
1102 call curlvector(w(ixi^s,mag(1:ndir)),ixi^l,ixo^l,current,idirmin,idirmin0,ndir,fourthorder)
1103 else
1104 call curlvector(w(ixi^s,mag(1:ndir)),ixi^l,ixo^l,current,idirmin,idirmin0,ndir)
1105 end if
1106
1107 end subroutine get_current
1108
1109 !> If resistivity is not zero, check diffusion time limit for dt
1110 subroutine mf_get_dt(w,ixI^L,ixO^L,dtnew,dx^D,x)
1112 use mod_usr_methods
1113
1114 integer, intent(in) :: ixi^l, ixo^l
1115 double precision, intent(inout) :: dtnew
1116 double precision, intent(in) :: dx^d
1117 double precision, intent(in) :: w(ixi^s,1:nw)
1118 double precision, intent(in) :: x(ixi^s,1:ndim)
1119
1120 double precision :: dxarr(ndim)
1121 double precision :: current(ixi^s,7-2*ndir:3),eta(ixi^s)
1122 integer :: idirmin,idim
1123
1124 dtnew = bigdouble
1125
1126 ^d&dxarr(^d)=dx^d;
1127 if (mf_eta>zero)then
1128 dtnew=dtdiffpar*minval(dxarr(1:ndim))**2/mf_eta
1129 else if (mf_eta<zero)then
1130 call get_current(w,ixi^l,ixo^l,idirmin,current)
1131 call usr_special_resistivity(w,ixi^l,ixo^l,idirmin,x,current,eta)
1132 dtnew=bigdouble
1133 do idim=1,ndim
1134 if(slab_uniform) then
1135 dtnew=min(dtnew,&
1136 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/dxarr(idim)**2)))
1137 else
1138 dtnew=min(dtnew,&
1139 dtdiffpar/(smalldouble+maxval(eta(ixo^s)/block%ds(ixo^s,idim)**2)))
1140 end if
1141 end do
1142 end if
1143
1144 if(mf_eta_hyper>zero) then
1145 if(slab_uniform) then
1146 dtnew=min(dtdiffpar*minval(dxarr(1:ndim))**4/mf_eta_hyper,dtnew)
1147 else
1148 dtnew=min(dtdiffpar*minval(block%ds(ixo^s,1:ndim))**4/mf_eta_hyper,dtnew)
1149 end if
1150 end if
1151 end subroutine mf_get_dt
1152
1153 ! Add geometrical source terms to w
1154 subroutine mf_add_source_geom(qdt,dtfactor, ixI^L,ixO^L,wCT,wprim,w,x)
1156 use mod_geometry
1157
1158 integer, intent(in) :: ixi^l, ixo^l
1159 double precision, intent(in) :: qdt, dtfactor, x(ixi^s,1:ndim)
1160 double precision, intent(inout) :: wct(ixi^s,1:nw), wprim(ixi^s,1:nw), w(ixi^s,1:nw)
1161
1162 double precision :: tmp,invr,cs2
1163 integer :: iw,idir,ix^d
1164
1165 integer :: mr_,mphi_ ! Polar var. names
1166 integer :: br_,bphi_
1167
1168 mr_=mom(1); mphi_=mom(1)-1+phi_ ! Polar var. names
1169 br_=mag(1); bphi_=mag(1)-1+phi_
1170
1171 select case (coordinate)
1172 case (cylindrical)
1173 if(phi_>0) then
1174 if(.not.stagger_grid) then
1175 {do ix^db=ixomin^db,ixomax^db\}
1176 w(ix^d,bphi_)=w(ix^d,bphi_)+qdt/x(ix^d,1)*&
1177 (wct(ix^d,bphi_)*wct(ix^d,mr_) &
1178 -wct(ix^d,br_)*wct(ix^d,mphi_))
1179 {end do\}
1180 end if
1181 end if
1182 if(mf_glm) w(ixo^s,br_)=w(ixo^s,br_)+qdt*wct(ixo^s,psi_)/x(ixo^s,1)
1183 case (spherical)
1184 {do ix^db=ixomin^db,ixomax^db\}
1185 invr=qdt/x(ix^d,1)
1186 ! b1
1187 if(mf_glm) then
1188 w(ix^d,mag(1))=w(ix^d,mag(1))+invr*2.0d0*wct(ix^d,psi_)
1189 end if
1190
1191 {^nooned
1192 ! b2
1193 if(.not.stagger_grid) then
1194 tmp=wct(ix^d,mom(1))*wct(ix^d,mag(2))-wct(ix^d,mom(2))*wct(ix^d,mag(1))
1195 cs2=1.d0/tan(x(ix^d,2))
1196 if(mf_glm) then
1197 tmp=tmp+cs2*wct(ix^d,psi_)
1198 end if
1199 w(ix^d,mag(2))=w(ix^d,mag(2))+tmp*invr
1200 end if
1201 }
1202
1203 if(ndir==3) then
1204 {^ifoned
1205 ! b3
1206 if(.not.stagger_grid) then
1207 w(ix^d,mag(3))=w(ix^d,mag(3))+invr*&
1208 (wct(ix^d,mom(1))*wct(ix^d,mag(3)) &
1209 -wct(ix^d,mom(3))*wct(ix^d,mag(1)))
1210 end if
1211 }
1212 {^nooned
1213 ! b3
1214 if(.not.stagger_grid) then
1215 w(ix^d,mag(3))=w(ix^d,mag(3))+invr*&
1216 (wct(ix^d,mom(1))*wct(ix^d,mag(3)) &
1217 -wct(ix^d,mom(3))*wct(ix^d,mag(1)) &
1218 -(wct(ix^d,mom(3))*wct(ix^d,mag(2)) &
1219 -wct(ix^d,mom(2))*wct(ix^d,mag(3)))*cs2)
1220 end if
1221 }
1222 end if
1223 {end do\}
1224 end select
1225
1226 end subroutine mf_add_source_geom
1227
1228 subroutine mf_modify_wlr(ixI^L,ixO^L,qt,wLC,wRC,wLp,wRp,s,idir)
1230 use mod_usr_methods
1231 integer, intent(in) :: ixi^l, ixo^l, idir
1232 double precision, intent(in) :: qt
1233 double precision, intent(inout) :: wlc(ixi^s,1:nw), wrc(ixi^s,1:nw)
1234 double precision, intent(inout) :: wlp(ixi^s,1:nw), wrp(ixi^s,1:nw)
1235 type(state) :: s
1236 double precision :: db(ixi^s), dpsi(ixi^s)
1237
1238 ! Solve the Riemann problem for the linear 2x2 system for normal
1239 ! B-field and GLM_Psi according to Dedner 2002:
1240 ! This implements eq. (42) in Dedner et al. 2002 JcP 175
1241 ! Gives the Riemann solution on the interface
1242 ! for the normal B component and Psi in the GLM-MHD system.
1243 ! 23/04/2013 Oliver Porth
1244 db(ixo^s) = wrp(ixo^s,mag(idir)) - wlp(ixo^s,mag(idir))
1245 dpsi(ixo^s) = wrp(ixo^s,psi_) - wlp(ixo^s,psi_)
1246
1247 wlp(ixo^s,mag(idir)) = 0.5d0 * (wrp(ixo^s,mag(idir)) + wlp(ixo^s,mag(idir))) &
1248 - 0.5d0/cmax_global * dpsi(ixo^s)
1249 wlp(ixo^s,psi_) = 0.5d0 * (wrp(ixo^s,psi_) + wlp(ixo^s,psi_)) &
1250 - 0.5d0*cmax_global * db(ixo^s)
1251
1252 wrp(ixo^s,mag(idir)) = wlp(ixo^s,mag(idir))
1253 wrp(ixo^s,psi_) = wlp(ixo^s,psi_)
1254
1255 end subroutine mf_modify_wlr
1256
1257 subroutine mf_boundary_adjust(igrid,psb)
1259 integer, intent(in) :: igrid
1260 type(state), target :: psb(max_blocks)
1261
1262 integer :: ib, idims, iside, ixo^l, i^d
1263
1264 block=>ps(igrid)
1265 ^d&dxlevel(^d)=rnode(rpdx^d_,igrid);
1266 do idims=1,ndim
1267 ! to avoid using as yet unknown corner info in more than 1D, we
1268 ! fill only interior mesh ranges of the ghost cell ranges at first,
1269 ! and progressively enlarge the ranges to include corners later
1270 do iside=1,2
1271 i^d=kr(^d,idims)*(2*iside-3);
1272 if (neighbor_type(i^d,igrid)/=1) cycle
1273 ib=(idims-1)*2+iside
1274 if(.not.boundary_divbfix(ib)) cycle
1275 if(any(typeboundary(:,ib)==bc_special)) then
1276 ! MF nonlinear force-free B field extrapolation and data driven
1277 ! require normal B of the first ghost cell layer to be untouched by
1278 ! fixdivB=0 process, set boundary_divbfix_skip(iB)=1 in par file
1279 select case (idims)
1280 {case (^d)
1281 if (iside==2) then
1282 ! maximal boundary
1283 ixomin^dd=ixghi^d+1-nghostcells+boundary_divbfix_skip(2*^d)^d%ixOmin^dd=ixglo^dd;
1284 ixomax^dd=ixghi^dd;
1285 else
1286 ! minimal boundary
1287 ixomin^dd=ixglo^dd;
1288 ixomax^dd=ixglo^d-1+nghostcells-boundary_divbfix_skip(2*^d-1)^d%ixOmax^dd=ixghi^dd;
1289 end if \}
1290 end select
1291 call fixdivb_boundary(ixg^ll,ixo^l,psb(igrid)%w,psb(igrid)%x,ib)
1292 end if
1293 end do
1294 end do
1295
1296 end subroutine mf_boundary_adjust
1297
1298 subroutine fixdivb_boundary(ixG^L,ixO^L,w,x,iB)
1300
1301 integer, intent(in) :: ixg^l,ixo^l,ib
1302 double precision, intent(inout) :: w(ixg^s,1:nw)
1303 double precision, intent(in) :: x(ixg^s,1:ndim)
1304
1305 double precision :: dx1x2,dx1x3,dx2x1,dx2x3,dx3x1,dx3x2
1306 integer :: ix^d,ixf^l
1307
1308 select case(ib)
1309 case(1)
1310 ! 2nd order CD for divB=0 to set normal B component better
1311 {^iftwod
1312 ixfmin1=ixomin1+1
1313 ixfmax1=ixomax1+1
1314 ixfmin2=ixomin2+1
1315 ixfmax2=ixomax2-1
1316 if(slab_uniform) then
1317 dx1x2=dxlevel(1)/dxlevel(2)
1318 do ix1=ixfmax1,ixfmin1,-1
1319 w(ix1-1,ixfmin2:ixfmax2,mag(1))=w(ix1+1,ixfmin2:ixfmax2,mag(1)) &
1320 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
1321 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
1322 enddo
1323 else
1324 do ix1=ixfmax1,ixfmin1,-1
1325 w(ix1-1,ixfmin2:ixfmax2,mag(1))=( (w(ix1+1,ixfmin2:ixfmax2,mag(1))+&
1326 w(ix1,ixfmin2:ixfmax2,mag(1)))*block%surfaceC(ix1,ixfmin2:ixfmax2,1)&
1327 +(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
1328 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
1329 -(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
1330 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
1331 /block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
1332 end do
1333 end if
1334 }
1335 {^ifthreed
1336 ixfmin1=ixomin1+1
1337 ixfmax1=ixomax1+1
1338 ixfmin2=ixomin2+1
1339 ixfmax2=ixomax2-1
1340 ixfmin3=ixomin3+1
1341 ixfmax3=ixomax3-1
1342 if(slab_uniform) then
1343 dx1x2=dxlevel(1)/dxlevel(2)
1344 dx1x3=dxlevel(1)/dxlevel(3)
1345 do ix1=ixfmax1,ixfmin1,-1
1346 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
1347 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
1348 +dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
1349 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
1350 +dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
1351 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
1352 end do
1353 else
1354 do ix1=ixfmax1,ixfmin1,-1
1355 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
1356 ( (w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
1357 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
1358 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
1359 +(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
1360 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
1361 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
1362 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
1363 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
1364 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
1365 +(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
1366 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
1367 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
1368 -(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
1369 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
1370 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
1371 /block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
1372 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
1373 end do
1374 end if
1375 }
1376 case(2)
1377 {^iftwod
1378 ixfmin1=ixomin1-1
1379 ixfmax1=ixomax1-1
1380 ixfmin2=ixomin2+1
1381 ixfmax2=ixomax2-1
1382 if(slab_uniform) then
1383 dx1x2=dxlevel(1)/dxlevel(2)
1384 do ix1=ixfmin1,ixfmax1
1385 w(ix1+1,ixfmin2:ixfmax2,mag(1))=w(ix1-1,ixfmin2:ixfmax2,mag(1)) &
1386 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))-&
1387 w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))
1388 enddo
1389 else
1390 do ix1=ixfmin1,ixfmax1
1391 w(ix1+1,ixfmin2:ixfmax2,mag(1))=( (w(ix1-1,ixfmin2:ixfmax2,mag(1))+&
1392 w(ix1,ixfmin2:ixfmax2,mag(1)))*block%surfaceC(ix1-1,ixfmin2:ixfmax2,1)&
1393 -(w(ix1,ixfmin2+1:ixfmax2+1,mag(2))+w(ix1,ixfmin2:ixfmax2,mag(2)))*&
1394 block%surfaceC(ix1,ixfmin2:ixfmax2,2)&
1395 +(w(ix1,ixfmin2:ixfmax2,mag(2))+w(ix1,ixfmin2-1:ixfmax2-1,mag(2)))*&
1396 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,2) )&
1397 /block%surfaceC(ix1,ixfmin2:ixfmax2,1)-w(ix1,ixfmin2:ixfmax2,mag(1))
1398 end do
1399 end if
1400 }
1401 {^ifthreed
1402 ixfmin1=ixomin1-1
1403 ixfmax1=ixomax1-1
1404 ixfmin2=ixomin2+1
1405 ixfmax2=ixomax2-1
1406 ixfmin3=ixomin3+1
1407 ixfmax3=ixomax3-1
1408 if(slab_uniform) then
1409 dx1x2=dxlevel(1)/dxlevel(2)
1410 dx1x3=dxlevel(1)/dxlevel(3)
1411 do ix1=ixfmin1,ixfmax1
1412 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
1413 w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)) &
1414 -dx1x2*(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))-&
1415 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2))) &
1416 -dx1x3*(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))-&
1417 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))
1418 end do
1419 else
1420 do ix1=ixfmin1,ixfmax1
1421 w(ix1+1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))=&
1422 ( (w(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))+&
1423 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1)))*&
1424 block%surfaceC(ix1-1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)&
1425 -(w(ix1,ixfmin2+1:ixfmax2+1,ixfmin3:ixfmax3,mag(2))+&
1426 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2)))*&
1427 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,2)&
1428 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(2))+&
1429 w(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,mag(2)))*&
1430 block%surfaceC(ix1,ixfmin2-1:ixfmax2-1,ixfmin3:ixfmax3,2)&
1431 -(w(ix1,ixfmin2:ixfmax2,ixfmin3+1:ixfmax3+1,mag(3))+&
1432 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3)))*&
1433 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,3)&
1434 +(w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(3))+&
1435 w(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,mag(3)))*&
1436 block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3-1:ixfmax3-1,3) )&
1437 /block%surfaceC(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,1)-&
1438 w(ix1,ixfmin2:ixfmax2,ixfmin3:ixfmax3,mag(1))
1439 end do
1440 end if
1441 }
1442 case(3)
1443 {^iftwod
1444 ixfmin1=ixomin1+1
1445 ixfmax1=ixomax1-1
1446 ixfmin2=ixomin2+1
1447 ixfmax2=ixomax2+1
1448 if(slab_uniform) then
1449 dx2x1=dxlevel(2)/dxlevel(1)
1450 do ix2=ixfmax2,ixfmin2,-1
1451 w(ixfmin1:ixfmax1,ix2-1,mag(2))=w(ixfmin1:ixfmax1,ix2+1,mag(2)) &
1452 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
1453 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
1454 enddo
1455 else
1456 do ix2=ixfmax2,ixfmin2,-1
1457 w(ixfmin1:ixfmax1,ix2-1,mag(2))=( (w(ixfmin1:ixfmax1,ix2+1,mag(2))+&
1458 w(ixfmin1:ixfmax1,ix2,mag(2)))*block%surfaceC(ixfmin1:ixfmax1,ix2,2)&
1459 +(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
1460 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
1461 -(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
1462 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
1463 /block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
1464 end do
1465 end if
1466 }
1467 {^ifthreed
1468 ixfmin1=ixomin1+1
1469 ixfmax1=ixomax1-1
1470 ixfmin3=ixomin3+1
1471 ixfmax3=ixomax3-1
1472 ixfmin2=ixomin2+1
1473 ixfmax2=ixomax2+1
1474 if(slab_uniform) then
1475 dx2x1=dxlevel(2)/dxlevel(1)
1476 dx2x3=dxlevel(2)/dxlevel(3)
1477 do ix2=ixfmax2,ixfmin2,-1
1478 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
1479 ix2+1,ixfmin3:ixfmax3,mag(2)) &
1480 +dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
1481 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
1482 +dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
1483 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
1484 end do
1485 else
1486 do ix2=ixfmax2,ixfmin2,-1
1487 w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))=&
1488 ( (w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))+&
1489 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
1490 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)&
1491 +(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
1492 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
1493 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
1494 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
1495 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
1496 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
1497 +(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
1498 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
1499 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
1500 -(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
1501 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
1502 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
1503 /block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)-&
1504 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
1505 end do
1506 end if
1507 }
1508 case(4)
1509 {^iftwod
1510 ixfmin1=ixomin1+1
1511 ixfmax1=ixomax1-1
1512 ixfmin2=ixomin2-1
1513 ixfmax2=ixomax2-1
1514 if(slab_uniform) then
1515 dx2x1=dxlevel(2)/dxlevel(1)
1516 do ix2=ixfmin2,ixfmax2
1517 w(ixfmin1:ixfmax1,ix2+1,mag(2))=w(ixfmin1:ixfmax1,ix2-1,mag(2)) &
1518 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))-&
1519 w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))
1520 end do
1521 else
1522 do ix2=ixfmin2,ixfmax2
1523 w(ixfmin1:ixfmax1,ix2+1,mag(2))=( (w(ixfmin1:ixfmax1,ix2-1,mag(2))+&
1524 w(ixfmin1:ixfmax1,ix2,mag(2)))*block%surfaceC(ixfmin1:ixfmax1,ix2-1,2)&
1525 -(w(ixfmin1+1:ixfmax1+1,ix2,mag(1))+w(ixfmin1:ixfmax1,ix2,mag(1)))*&
1526 block%surfaceC(ixfmin1:ixfmax1,ix2,1)&
1527 +(w(ixfmin1:ixfmax1,ix2,mag(1))+w(ixfmin1-1:ixfmax1-1,ix2,mag(1)))*&
1528 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,1) )&
1529 /block%surfaceC(ixfmin1:ixfmax1,ix2,2)-w(ixfmin1:ixfmax1,ix2,mag(2))
1530 end do
1531 end if
1532 }
1533 {^ifthreed
1534 ixfmin1=ixomin1+1
1535 ixfmax1=ixomax1-1
1536 ixfmin3=ixomin3+1
1537 ixfmax3=ixomax3-1
1538 ixfmin2=ixomin2-1
1539 ixfmax2=ixomax2-1
1540 if(slab_uniform) then
1541 dx2x1=dxlevel(2)/dxlevel(1)
1542 dx2x3=dxlevel(2)/dxlevel(3)
1543 do ix2=ixfmin2,ixfmax2
1544 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=w(ixfmin1:ixfmax1,&
1545 ix2-1,ixfmin3:ixfmax3,mag(2)) &
1546 -dx2x1*(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))-&
1547 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1))) &
1548 -dx2x3*(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))-&
1549 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))
1550 end do
1551 else
1552 do ix2=ixfmin2,ixfmax2
1553 w(ixfmin1:ixfmax1,ix2+1,ixfmin3:ixfmax3,mag(2))=&
1554 ( (w(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,mag(2))+&
1555 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2)))*&
1556 block%surfaceC(ixfmin1:ixfmax1,ix2-1,ixfmin3:ixfmax3,2)&
1557 -(w(ixfmin1+1:ixfmax1+1,ix2,ixfmin3:ixfmax3,mag(1))+&
1558 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1)))*&
1559 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,1)&
1560 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(1))+&
1561 w(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,mag(1)))*&
1562 block%surfaceC(ixfmin1-1:ixfmax1-1,ix2,ixfmin3:ixfmax3,1)&
1563 -(w(ixfmin1:ixfmax1,ix2,ixfmin3+1:ixfmax3+1,mag(3))+&
1564 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3)))*&
1565 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,3)&
1566 +(w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(3))+&
1567 w(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,mag(3)))*&
1568 block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3-1:ixfmax3-1,3) )&
1569 /block%surfaceC(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,2)-&
1570 w(ixfmin1:ixfmax1,ix2,ixfmin3:ixfmax3,mag(2))
1571 end do
1572 end if
1573 }
1574 {^ifthreed
1575 case(5)
1576 ixfmin1=ixomin1+1
1577 ixfmax1=ixomax1-1
1578 ixfmin2=ixomin2+1
1579 ixfmax2=ixomax2-1
1580 ixfmin3=ixomin3+1
1581 ixfmax3=ixomax3+1
1582 if(slab_uniform) then
1583 dx3x1=dxlevel(3)/dxlevel(1)
1584 dx3x2=dxlevel(3)/dxlevel(2)
1585 do ix3=ixfmax3,ixfmin3,-1
1586 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=w(ixfmin1:ixfmax1,&
1587 ixfmin2:ixfmax2,ix3+1,mag(3)) &
1588 +dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
1589 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
1590 +dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
1591 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
1592 end do
1593 else
1594 do ix3=ixfmax3,ixfmin3,-1
1595 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))=&
1596 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))+&
1597 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
1598 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)&
1599 +(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
1600 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
1601 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
1602 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
1603 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
1604 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
1605 +(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
1606 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
1607 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
1608 -(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
1609 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
1610 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
1611 /block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)-&
1612 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
1613 end do
1614 end if
1615 case(6)
1616 ixfmin1=ixomin1+1
1617 ixfmax1=ixomax1-1
1618 ixfmin2=ixomin2+1
1619 ixfmax2=ixomax2-1
1620 ixfmin3=ixomin3-1
1621 ixfmax3=ixomax3-1
1622 if(slab_uniform) then
1623 dx3x1=dxlevel(3)/dxlevel(1)
1624 dx3x2=dxlevel(3)/dxlevel(2)
1625 do ix3=ixfmin3,ixfmax3
1626 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=w(ixfmin1:ixfmax1,&
1627 ixfmin2:ixfmax2,ix3-1,mag(3)) &
1628 -dx3x1*(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))-&
1629 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1))) &
1630 -dx3x2*(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))-&
1631 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))
1632 end do
1633 else
1634 do ix3=ixfmin3,ixfmax3
1635 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3+1,mag(3))=&
1636 ( (w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,mag(3))+&
1637 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3)))*&
1638 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3-1,3)&
1639 -(w(ixfmin1+1:ixfmax1+1,ixfmin2:ixfmax2,ix3,mag(1))+&
1640 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1)))*&
1641 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,1)&
1642 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(1))+&
1643 w(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,mag(1)))*&
1644 block%surfaceC(ixfmin1-1:ixfmax1-1,ixfmin2:ixfmax2,ix3,1)&
1645 -(w(ixfmin1:ixfmax1,ixfmin2+1:ixfmax2+1,ix3,mag(2))+&
1646 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2)))*&
1647 block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,2)&
1648 +(w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(2))+&
1649 w(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,mag(2)))*&
1650 block%surfaceC(ixfmin1:ixfmax1,ixfmin2-1:ixfmax2-1,ix3,2) )&
1651 /block%surfaceC(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,3)-&
1652 w(ixfmin1:ixfmax1,ixfmin2:ixfmax2,ix3,mag(3))
1653 end do
1654 end if
1655 }
1656 case default
1657 call mpistop("Special boundary is not defined for this region")
1658 end select
1659
1660 end subroutine fixdivb_boundary
1661
1662 {^nooned
1663 subroutine mf_clean_divb_multigrid(qdt, qt, active)
1664 use mod_forest
1667 use mod_geometry
1668
1669 double precision, intent(in) :: qdt !< Current time step
1670 double precision, intent(in) :: qt !< Current time
1671 logical, intent(inout) :: active !< Output if the source is active
1672
1673 double precision :: tmp(ixg^t), grad(ixg^t, ndim)
1674 double precision :: res
1675 double precision, parameter :: max_residual = 1d-3
1676 double precision, parameter :: residual_reduction = 1d-10
1677 integer :: id
1678 integer, parameter :: max_its = 50
1679 double precision :: residual_it(max_its), max_divb
1680 integer :: iigrid, igrid
1681 integer :: n, nc, lvl, ix^l, ixc^l, idim
1682 type(tree_node), pointer :: pnode
1683
1684 mg%operator_type = mg_laplacian
1685
1686 ! Set boundary conditions
1687 do n = 1, 2*ndim
1688 idim = (n+1)/2
1689 select case (typeboundary(mag(idim), n))
1690 case (bc_symm)
1691 ! d/dx B = 0, take phi = 0
1692 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
1693 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
1694 case (bc_asymm)
1695 ! B = 0, so grad(phi) = 0
1696 mg%bc(n, mg_iphi)%bc_type = mg_bc_neumann
1697 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
1698 case (bc_cont)
1699 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
1700 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
1701 case (bc_special)
1702 ! Assume Dirichlet boundary conditions, derivative zero
1703 mg%bc(n, mg_iphi)%bc_type = mg_bc_neumann
1704 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
1705 case (bc_periodic)
1706 ! Nothing to do here
1707 case default
1708 write(*,*) "mf_clean_divb_multigrid warning: unknown boundary type"
1709 mg%bc(n, mg_iphi)%bc_type = mg_bc_dirichlet
1710 mg%bc(n, mg_iphi)%bc_value = 0.0_dp
1711 end select
1712 end do
1713
1714 ix^l=ixm^ll^ladd1;
1715 max_divb = 0.0d0
1716
1717 ! Store divergence of B as right-hand side
1718 do iigrid = 1, igridstail
1719 igrid = igrids(iigrid);
1720 pnode => igrid_to_node(igrid, mype)%node
1721 id = pnode%id
1722 lvl = mg%boxes(id)%lvl
1723 nc = mg%box_size_lvl(lvl)
1724
1725 ! Geometry subroutines expect this to be set
1726 block => ps(igrid)
1727 ^d&dxlevel(^d)=rnode(rpdx^d_,igrid);
1728
1729 call get_divb(ps(igrid)%w(ixg^t, 1:nw), ixg^ll, ixm^ll, tmp, &
1731 mg%boxes(id)%cc({1:nc}, mg_irhs) = tmp(ixm^t)
1732 max_divb = max(max_divb, maxval(abs(tmp(ixm^t))))
1733 end do
1734
1735 ! Solve laplacian(phi) = divB
1736 if(stagger_grid) then
1737 call mpi_allreduce(mpi_in_place, max_divb, 1, mpi_double_precision, &
1738 mpi_max, icomm, ierrmpi)
1739
1740 if (mype == 0) print *, "Performing multigrid divB cleaning"
1741 if (mype == 0) print *, "iteration vs residual"
1742 ! Solve laplacian(phi) = divB
1743 do n = 1, max_its
1744 call mg_fas_fmg(mg, n>1, max_res=residual_it(n))
1745 if (mype == 0) write(*, "(I4,E11.3)") n, residual_it(n)
1746 if (residual_it(n) < residual_reduction * max_divb) exit
1747 end do
1748 if (mype == 0 .and. n > max_its) then
1749 print *, "divb_multigrid warning: not fully converged"
1750 print *, "current amplitude of divb: ", residual_it(max_its)
1751 print *, "multigrid smallest grid: ", &
1752 mg%domain_size_lvl(:, mg%lowest_lvl)
1753 print *, "note: smallest grid ideally has <= 8 cells"
1754 print *, "multigrid dx/dy/dz ratio: ", mg%dr(:, 1)/mg%dr(1, 1)
1755 print *, "note: dx/dy/dz should be similar"
1756 end if
1757 else
1758 do n = 1, max_its
1759 call mg_fas_vcycle(mg, max_res=res)
1760 if (res < max_residual) exit
1761 end do
1762 if (res > max_residual) call mpistop("divb_multigrid: no convergence")
1763 end if
1764
1765
1766 ! Correct the magnetic field
1767 do iigrid = 1, igridstail
1768 igrid = igrids(iigrid);
1769 pnode => igrid_to_node(igrid, mype)%node
1770 id = pnode%id
1771
1772 ! Geometry subroutines expect this to be set
1773 block => ps(igrid)
1774 ^d&dxlevel(^d)=rnode(rpdx^d_,igrid);
1775
1776 ! Compute the gradient of phi
1777 tmp(ix^s) = mg%boxes(id)%cc({:,}, mg_iphi)
1778
1779 if(stagger_grid) then
1780 do idim =1, ndim
1781 ixcmin^d=ixmlo^d-kr(idim,^d);
1782 ixcmax^d=ixmhi^d;
1783 call gradientf(tmp,ps(igrid)%x,ixg^ll,ixc^l,idim,grad(ixg^t,idim))
1784 ps(igrid)%ws(ixc^s,idim)=ps(igrid)%ws(ixc^s,idim)-grad(ixc^s,idim)
1785 end do
1786 call mf_face_to_center(ixm^ll,ps(igrid))
1787 else
1788 do idim = 1, ndim
1789 call gradient(tmp,ixg^ll,ixm^ll,idim,grad(ixg^t, idim))
1790 end do
1791 ! Apply the correction B* = B - gradient(phi)
1792 ps(igrid)%w(ixm^t, mag(1:ndim)) = &
1793 ps(igrid)%w(ixm^t, mag(1:ndim)) - grad(ixm^t, :)
1794 end if
1795
1796 end do
1797
1798 active = .true.
1799
1800 end subroutine mf_clean_divb_multigrid
1801 }
1802
1803 subroutine mf_update_faces(ixI^L,ixO^L,qt,qdt,wprim,fC,fE,sCT,s,vcts)
1805
1806 integer, intent(in) :: ixi^l, ixo^l
1807 double precision, intent(in) :: qt, qdt
1808 ! cell-center primitive variables
1809 double precision, intent(in) :: wprim(ixi^s,1:nw)
1810 type(state) :: sct, s
1811 type(ct_velocity) :: vcts
1812 double precision, intent(in) :: fc(ixi^s,1:nwflux,1:ndim)
1813 double precision, intent(inout) :: fe(ixi^s,sdim:3)
1814
1815 select case(type_ct)
1816 case('average')
1817 call update_faces_average(ixi^l,ixo^l,qt,qdt,fc,fe,sct,s)
1818 case('uct_contact')
1819 call update_faces_contact(ixi^l,ixo^l,qt,qdt,wprim,fc,fe,sct,s,vcts)
1820 case('uct_hll')
1821 call update_faces_hll(ixi^l,ixo^l,qt,qdt,fe,sct,s,vcts)
1822 case default
1823 call mpistop('choose average, uct_contact,or uct_hll for type_ct!')
1824 end select
1825
1826 end subroutine mf_update_faces
1827
1828 !> get electric field though averaging neighors to update faces in CT
1829 subroutine update_faces_average(ixI^L,ixO^L,qt,qdt,fC,fE,sCT,s)
1831 use mod_usr_methods
1832
1833 integer, intent(in) :: ixi^l, ixo^l
1834 double precision, intent(in) :: qt, qdt
1835 type(state) :: sct, s
1836 double precision, intent(in) :: fc(ixi^s,1:nwflux,1:ndim)
1837 double precision, intent(inout) :: fe(ixi^s,sdim:3)
1838
1839 double precision :: circ(ixi^s,1:ndim)
1840 double precision :: e_resi(ixi^s,sdim:3)
1841 integer :: ix^d,ixc^l,ixa^l,i1kr^d,i2kr^d
1842 integer :: idim1,idim2,idir,iwdim1,iwdim2
1843
1844 associate(bfaces=>s%ws,x=>s%x)
1845
1846 ! Calculate contribution to FEM of each edge,
1847 ! that is, estimate value of line integral of
1848 ! electric field in the positive idir direction.
1849
1850 ! if there is resistivity, get eta J
1851 if(mf_eta/=zero) call get_resistive_electric_field(ixi^l,ixo^l,sct,s,e_resi)
1852
1853 do idim1=1,ndim
1854 iwdim1 = mag(idim1)
1855 i1kr^d=kr(idim1,^d);
1856 do idim2=1,ndim
1857 iwdim2 = mag(idim2)
1858 i2kr^d=kr(idim2,^d);
1859 do idir=sdim,3! Direction of line integral
1860 ! Allow only even permutations
1861 if (lvc(idim1,idim2,idir)==1) then
1862 ixcmax^d=ixomax^d;
1863 ixcmin^d=ixomin^d+kr(idir,^d)-1;
1864 ! average cell-face electric field to cell edges
1865 {do ix^db=ixcmin^db,ixcmax^db\}
1866 fe(ix^d,idir)=quarter*&
1867 (fc(ix^d,iwdim1,idim2)+fc({ix^d+i1kr^d},iwdim1,idim2)&
1868 -fc(ix^d,iwdim2,idim1)-fc({ix^d+i2kr^d},iwdim2,idim1))
1869 ! add resistive electric field at cell edges E=-vxB+eta J
1870 if(mf_eta/=zero) fe(ix^d,idir)=fe(ix^d,idir)+e_resi(ix^d,idir)
1871 if(record_electric_field) s%we(ix^d,idir)=fe(ix^d,idir)
1872 ! times time step and edge length
1873 fe(ix^d,idir)=fe(ix^d,idir)*qdt*s%dsC(ix^d,idir)
1874 {end do\}
1875 end if
1876 end do
1877 end do
1878 end do
1879
1880 ! allow user to change inductive electric field, especially for boundary driven applications
1881 if(associated(usr_set_electric_field)) &
1882 call usr_set_electric_field(ixi^l,ixo^l,qt,qdt,fe,sct)
1883
1884 circ(ixi^s,1:ndim)=zero
1885
1886 ! Calculate circulation on each face
1887
1888 do idim1=1,ndim ! Coordinate perpendicular to face
1889 ixcmax^d=ixomax^d;
1890 ixcmin^d=ixomin^d-kr(idim1,^d);
1891 do idim2=1,ndim
1892 ixa^l=ixc^l-kr(idim2,^d);
1893 do idir=sdim,3 ! Direction of line integral
1894 ! Assemble indices
1895 if(lvc(idim1,idim2,idir)==1) then
1896 ! Add line integrals in direction idir
1897 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
1898 +(fe(ixc^s,idir)&
1899 -fe(ixa^s,idir))
1900 else if(lvc(idim1,idim2,idir)==-1) then
1901 ! Add line integrals in direction idir
1902 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
1903 -(fe(ixc^s,idir)&
1904 -fe(ixa^s,idir))
1905 end if
1906 end do
1907 end do
1908 ! Divide by the area of the face to get dB/dt
1909 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
1910 ! Time update
1911 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
1912 end do
1913
1914 end associate
1915
1916 end subroutine update_faces_average
1917
1918 !> update faces using UCT contact mode by Gardiner and Stone 2005 JCP 205, 509
1919 subroutine update_faces_contact(ixI^L,ixO^L,qt,qdt,wp,fC,fE,sCT,s,vcts)
1921 use mod_usr_methods
1922
1923 integer, intent(in) :: ixi^l, ixo^l
1924 double precision, intent(in) :: qt, qdt
1925 ! cell-center primitive variables
1926 double precision, intent(in) :: wp(ixi^s,1:nw)
1927 type(state) :: sct, s
1928 type(ct_velocity) :: vcts
1929 double precision, intent(in) :: fc(ixi^s,1:nwflux,1:ndim)
1930 double precision, intent(inout) :: fe(ixi^s,sdim:3)
1931
1932 double precision :: circ(ixi^s,1:ndim)
1933 ! electric field at cell centers
1934 double precision :: ecc(ixi^s,sdim:3)
1935 ! gradient of E at left and right side of a cell face
1936 double precision :: el(ixi^s),er(ixi^s)
1937 ! gradient of E at left and right side of a cell corner
1938 double precision :: elc(ixi^s),erc(ixi^s)
1939 ! current on cell edges
1940 double precision :: jce(ixi^s,sdim:3)
1941 integer :: hxc^l,ixc^l,jxc^l,ixa^l,ixb^l
1942 integer :: idim1,idim2,idir,iwdim1,iwdim2
1943
1944 associate(bfaces=>s%ws,x=>s%x,w=>s%w,vnorm=>vcts%vnorm)
1945
1946 ecc=0.d0
1947 ! Calculate electric field at cell centers
1948 do idim1=1,ndim; do idim2=1,ndim; do idir=sdim,3
1949 if(lvc(idim1,idim2,idir)==1)then
1950 ecc(ixi^s,idir)=ecc(ixi^s,idir)+wp(ixi^s,mag(idim1))*wp(ixi^s,mom(idim2))
1951 else if(lvc(idim1,idim2,idir)==-1) then
1952 ecc(ixi^s,idir)=ecc(ixi^s,idir)-wp(ixi^s,mag(idim1))*wp(ixi^s,mom(idim2))
1953 endif
1954 enddo; enddo; enddo
1955
1956 ! if there is resistivity, get eta J
1957 if(mf_eta/=zero) call get_resistive_electric_field(ixi^l,ixo^l,sct,s,jce)
1958
1959 ! Calculate contribution to FEM of each edge,
1960 ! that is, estimate value of line integral of
1961 ! electric field in the positive idir direction.
1962 ! evaluate electric field along cell edges according to equation (41)
1963 do idim1=1,ndim
1964 iwdim1 = mag(idim1)
1965 do idim2=1,ndim
1966 iwdim2 = mag(idim2)
1967 do idir=sdim,3 ! Direction of line integral
1968 ! Allow only even permutations
1969 if (lvc(idim1,idim2,idir)==1) then
1970 ixcmax^d=ixomax^d;
1971 ixcmin^d=ixomin^d+kr(idir,^d)-1;
1972 ! Assemble indices
1973 jxc^l=ixc^l+kr(idim1,^d);
1974 hxc^l=ixc^l+kr(idim2,^d);
1975 ! average cell-face electric field to cell edges
1976 fe(ixc^s,idir)=quarter*&
1977 (fc(ixc^s,iwdim1,idim2)+fc(jxc^s,iwdim1,idim2)&
1978 -fc(ixc^s,iwdim2,idim1)-fc(hxc^s,iwdim2,idim1))
1979
1980 ! add slope in idim2 direction from equation (50)
1981 ixamin^d=ixcmin^d;
1982 ixamax^d=ixcmax^d+kr(idim1,^d);
1983 el(ixa^s)=fc(ixa^s,iwdim1,idim2)-ecc(ixa^s,idir)
1984 hxc^l=ixa^l+kr(idim2,^d);
1985 er(ixa^s)=fc(ixa^s,iwdim1,idim2)-ecc(hxc^s,idir)
1986 where(vnorm(ixc^s,idim1)>0.d0)
1987 elc(ixc^s)=el(ixc^s)
1988 else where(vnorm(ixc^s,idim1)<0.d0)
1989 elc(ixc^s)=el(jxc^s)
1990 else where
1991 elc(ixc^s)=0.5d0*(el(ixc^s)+el(jxc^s))
1992 end where
1993 hxc^l=ixc^l+kr(idim2,^d);
1994 where(vnorm(hxc^s,idim1)>0.d0)
1995 erc(ixc^s)=er(ixc^s)
1996 else where(vnorm(hxc^s,idim1)<0.d0)
1997 erc(ixc^s)=er(jxc^s)
1998 else where
1999 erc(ixc^s)=0.5d0*(er(ixc^s)+er(jxc^s))
2000 end where
2001 fe(ixc^s,idir)=fe(ixc^s,idir)+0.25d0*(elc(ixc^s)+erc(ixc^s))
2002
2003 ! add slope in idim1 direction from equation (50)
2004 jxc^l=ixc^l+kr(idim2,^d);
2005 ixamin^d=ixcmin^d;
2006 ixamax^d=ixcmax^d+kr(idim2,^d);
2007 el(ixa^s)=-fc(ixa^s,iwdim2,idim1)-ecc(ixa^s,idir)
2008 hxc^l=ixa^l+kr(idim1,^d);
2009 er(ixa^s)=-fc(ixa^s,iwdim2,idim1)-ecc(hxc^s,idir)
2010 where(vnorm(ixc^s,idim2)>0.d0)
2011 elc(ixc^s)=el(ixc^s)
2012 else where(vnorm(ixc^s,idim2)<0.d0)
2013 elc(ixc^s)=el(jxc^s)
2014 else where
2015 elc(ixc^s)=0.5d0*(el(ixc^s)+el(jxc^s))
2016 end where
2017 hxc^l=ixc^l+kr(idim1,^d);
2018 where(vnorm(hxc^s,idim2)>0.d0)
2019 erc(ixc^s)=er(ixc^s)
2020 else where(vnorm(hxc^s,idim2)<0.d0)
2021 erc(ixc^s)=er(jxc^s)
2022 else where
2023 erc(ixc^s)=0.5d0*(er(ixc^s)+er(jxc^s))
2024 end where
2025 fe(ixc^s,idir)=fe(ixc^s,idir)+0.25d0*(elc(ixc^s)+erc(ixc^s))
2026
2027 ! add current component of electric field at cell edges E=-vxB+eta J
2028 if(mf_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+jce(ixc^s,idir)
2029
2030 if(record_electric_field) s%we(ixc^s,idir)=fe(ixc^s,idir)
2031 ! times time step and edge length
2032 fe(ixc^s,idir)=fe(ixc^s,idir)*qdt*s%dsC(ixc^s,idir)
2033 if (.not.slab) then
2034 where(abs(x(ixc^s,r_)+half*dxlevel(r_))<1.0d-9)
2035 fe(ixc^s,idir)=zero
2036 end where
2037 end if
2038 end if
2039 end do
2040 end do
2041 end do
2042
2043 ! allow user to change inductive electric field, especially for boundary driven applications
2044 if(associated(usr_set_electric_field)) &
2045 call usr_set_electric_field(ixi^l,ixo^l,qt,qdt,fe,sct)
2046
2047 circ(ixi^s,1:ndim)=zero
2048
2049 ! Calculate circulation on each face
2050 do idim1=1,ndim ! Coordinate perpendicular to face
2051 ixcmax^d=ixomax^d;
2052 ixcmin^d=ixomin^d-kr(idim1,^d);
2053 do idim2=1,ndim
2054 do idir=sdim,3 ! Direction of line integral
2055 ! Assemble indices
2056 if(lvc(idim1,idim2,idir)/=0) then
2057 hxc^l=ixc^l-kr(idim2,^d);
2058 ! Add line integrals in direction idir
2059 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
2060 +lvc(idim1,idim2,idir)&
2061 *(fe(ixc^s,idir)&
2062 -fe(hxc^s,idir))
2063 end if
2064 end do
2065 end do
2066 ! Divide by the area of the face to get dB/dt
2067 where(s%surfaceC(ixc^s,idim1) > 1.0d-9*s%dvolume(ixc^s))
2068 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
2069 elsewhere
2070 circ(ixc^s,idim1)=zero
2071 end where
2072 ! Time update cell-face magnetic field component
2073 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
2074 end do
2075
2076 end associate
2077
2078 end subroutine update_faces_contact
2079
2080 !> update faces
2081 subroutine update_faces_hll(ixI^L,ixO^L,qt,qdt,fE,sCT,s,vcts)
2084 use mod_usr_methods
2085
2086 integer, intent(in) :: ixi^l, ixo^l
2087 double precision, intent(in) :: qt, qdt
2088 double precision, intent(inout) :: fe(ixi^s,sdim:3)
2089 type(state) :: sct, s
2090 type(ct_velocity) :: vcts
2091
2092 double precision :: vtill(ixi^s,2)
2093 double precision :: vtilr(ixi^s,2)
2094 double precision :: btill(ixi^s,ndim)
2095 double precision :: btilr(ixi^s,ndim)
2096 double precision :: cp(ixi^s,2)
2097 double precision :: cm(ixi^s,2)
2098 double precision :: circ(ixi^s,1:ndim)
2099 ! current on cell edges
2100 double precision :: jce(ixi^s,sdim:3)
2101 integer :: hxc^l,ixc^l,ixcp^l,jxc^l,ixcm^l
2102 integer :: idim1,idim2,idir
2103
2104 associate(bfaces=>s%ws,bfacesct=>sct%ws,x=>s%x,vbarc=>vcts%vbarC,cbarmin=>vcts%cbarmin,&
2105 cbarmax=>vcts%cbarmax)
2106
2107 ! Calculate contribution to FEM of each edge,
2108 ! that is, estimate value of line integral of
2109 ! electric field in the positive idir direction.
2110
2111 ! Loop over components of electric field
2112
2113 ! idir: electric field component we need to calculate
2114 ! idim1: directions in which we already performed the reconstruction
2115 ! idim2: directions in which we perform the reconstruction
2116
2117 ! if there is resistivity, get eta J
2118 if(mf_eta/=zero) call get_resistive_electric_field(ixi^l,ixo^l,sct,s,jce)
2119
2120 do idir=sdim,3
2121 ! Indices
2122 ! idir: electric field component
2123 ! idim1: one surface
2124 ! idim2: the other surface
2125 ! cyclic permutation: idim1,idim2,idir=1,2,3
2126 ! Velocity components on the surface
2127 ! follow cyclic premutations:
2128 ! Sx(1),Sx(2)=y,z ; Sy(1),Sy(2)=z,x ; Sz(1),Sz(2)=x,y
2129
2130 ixcmax^d=ixomax^d;
2131 ixcmin^d=ixomin^d-1+kr(idir,^d);
2132
2133 ! Set indices and directions
2134 idim1=mod(idir,3)+1
2135 idim2=mod(idir+1,3)+1
2136
2137 jxc^l=ixc^l+kr(idim1,^d);
2138 ixcp^l=ixc^l+kr(idim2,^d);
2139
2140 ! Reconstruct transverse transport velocities
2141 call reconstruct(ixi^l,ixc^l,idim2,vbarc(ixi^s,idim1,1),&
2142 vtill(ixi^s,2),vtilr(ixi^s,2))
2143
2144 call reconstruct(ixi^l,ixc^l,idim1,vbarc(ixi^s,idim2,2),&
2145 vtill(ixi^s,1),vtilr(ixi^s,1))
2146
2147 ! Reconstruct magnetic fields
2148 ! Eventhough the arrays are larger, reconstruct works with
2149 ! the limits ixG.
2150 call reconstruct(ixi^l,ixc^l,idim2,bfacesct(ixi^s,idim1),&
2151 btill(ixi^s,idim1),btilr(ixi^s,idim1))
2152
2153 call reconstruct(ixi^l,ixc^l,idim1,bfacesct(ixi^s,idim2),&
2154 btill(ixi^s,idim2),btilr(ixi^s,idim2))
2155
2156 ! Take the maximum characteristic
2157
2158 cm(ixc^s,1)=max(cbarmin(ixcp^s,idim1),cbarmin(ixc^s,idim1))
2159 cp(ixc^s,1)=max(cbarmax(ixcp^s,idim1),cbarmax(ixc^s,idim1))
2160
2161 cm(ixc^s,2)=max(cbarmin(jxc^s,idim2),cbarmin(ixc^s,idim2))
2162 cp(ixc^s,2)=max(cbarmax(jxc^s,idim2),cbarmax(ixc^s,idim2))
2163
2164
2165 ! Calculate eletric field
2166 fe(ixc^s,idir)=-(cp(ixc^s,1)*vtill(ixc^s,1)*btill(ixc^s,idim2) &
2167 + cm(ixc^s,1)*vtilr(ixc^s,1)*btilr(ixc^s,idim2) &
2168 - cp(ixc^s,1)*cm(ixc^s,1)*(btilr(ixc^s,idim2)-btill(ixc^s,idim2)))&
2169 /(cp(ixc^s,1)+cm(ixc^s,1)) &
2170 +(cp(ixc^s,2)*vtill(ixc^s,2)*btill(ixc^s,idim1) &
2171 + cm(ixc^s,2)*vtilr(ixc^s,2)*btilr(ixc^s,idim1) &
2172 - cp(ixc^s,2)*cm(ixc^s,2)*(btilr(ixc^s,idim1)-btill(ixc^s,idim1)))&
2173 /(cp(ixc^s,2)+cm(ixc^s,2))
2174
2175 ! add current component of electric field at cell edges E=-vxB+eta J
2176 if(mf_eta/=zero) fe(ixc^s,idir)=fe(ixc^s,idir)+jce(ixc^s,idir)
2177
2178 if(record_electric_field) s%we(ixc^s,idir)=fe(ixc^s,idir)
2179 ! times time step and edge length
2180 fe(ixc^s,idir)=qdt*s%dsC(ixc^s,idir)*fe(ixc^s,idir)
2181
2182 if (.not.slab) then
2183 where(abs(x(ixc^s,r_)+half*dxlevel(r_)).lt.1.0d-9)
2184 fe(ixc^s,idir)=zero
2185 end where
2186 end if
2187
2188 end do
2189
2190 ! allow user to change inductive electric field, especially for boundary driven applications
2191 if(associated(usr_set_electric_field)) &
2192 call usr_set_electric_field(ixi^l,ixo^l,qt,qdt,fe,sct)
2193
2194 circ(ixi^s,1:ndim)=zero
2195
2196 ! Calculate circulation on each face: interal(fE dot dl)
2197
2198 do idim1=1,ndim ! Coordinate perpendicular to face
2199 ixcmax^d=ixomax^d;
2200 ixcmin^d=ixomin^d-kr(idim1,^d);
2201 do idim2=1,ndim
2202 do idir=sdim,3 ! Direction of line integral
2203 ! Assemble indices
2204 if(lvc(idim1,idim2,idir)/=0) then
2205 hxc^l=ixc^l-kr(idim2,^d);
2206 ! Add line integrals in direction idir
2207 circ(ixc^s,idim1)=circ(ixc^s,idim1)&
2208 +lvc(idim1,idim2,idir)&
2209 *(fe(ixc^s,idir)&
2210 -fe(hxc^s,idir))
2211 end if
2212 end do
2213 end do
2214 ! Divide by the area of the face to get dB/dt
2215 where(s%surfaceC(ixc^s,idim1) > 1.0d-9*s%dvolume(ixc^s))
2216 circ(ixc^s,idim1)=circ(ixc^s,idim1)/s%surfaceC(ixc^s,idim1)
2217 elsewhere
2218 circ(ixc^s,idim1)=zero
2219 end where
2220 ! Time update
2221 bfaces(ixc^s,idim1)=bfaces(ixc^s,idim1)-circ(ixc^s,idim1)
2222 end do
2223
2224 end associate
2225 end subroutine update_faces_hll
2226
2227 !> calculate eta J at cell edges
2228 subroutine get_resistive_electric_field(ixI^L,ixO^L,sCT,s,jce)
2230 use mod_usr_methods
2231 use mod_geometry
2232
2233 integer, intent(in) :: ixi^l, ixo^l
2234 type(state), intent(in) :: sct, s
2235 ! current on cell edges
2236 double precision :: jce(ixi^s,sdim:3)
2237
2238 ! current on cell centers
2239 double precision :: jcc(ixi^s,7-2*ndir:3)
2240 ! location at cell faces
2241 double precision :: xs(ixgs^t,1:ndim)
2242 ! resistivity
2243 double precision :: eta(ixi^s)
2244 double precision :: gradi(ixgs^t)
2245 integer :: ix^d,ixc^l,ixa^l,ixb^l,idir,idirmin,idim1,idim2
2246
2247 associate(x=>s%x,dx=>s%dx,w=>s%w,wct=>sct%w,wcts=>sct%ws)
2248 ! calculate current density at cell edges
2249 jce=0.d0
2250 do idim1=1,ndim
2251 do idim2=1,ndim
2252 do idir=sdim,3
2253 if (lvc(idim1,idim2,idir)==0) cycle
2254 ixcmax^d=ixomax^d+1;
2255 ixcmin^d=ixomin^d+kr(idir,^d)-2;
2256 ixbmax^d=ixcmax^d-kr(idir,^d)+1;
2257 ixbmin^d=ixcmin^d;
2258 ! current at transverse faces
2259 xs(ixb^s,:)=x(ixb^s,:)
2260 xs(ixb^s,idim2)=x(ixb^s,idim2)+half*dx(ixb^s,idim2)
2261 call gradientf(wcts(ixgs^t,idim2),xs,ixgs^ll,ixc^l,idim1,gradi)
2262 if (lvc(idim1,idim2,idir)==1) then
2263 jce(ixc^s,idir)=jce(ixc^s,idir)+gradi(ixc^s)
2264 else
2265 jce(ixc^s,idir)=jce(ixc^s,idir)-gradi(ixc^s)
2266 end if
2267 end do
2268 end do
2269 end do
2270 ! get resistivity
2271 if(mf_eta>zero)then
2272 jce(ixi^s,:)=jce(ixi^s,:)*mf_eta
2273 else
2274 ixa^l=ixo^l^ladd1;
2275 call get_current(wct,ixi^l,ixa^l,idirmin,jcc)
2276 call usr_special_resistivity(wct,ixi^l,ixa^l,idirmin,x,jcc,eta)
2277 ! calcuate eta on cell edges
2278 do idir=sdim,3
2279 ixcmax^d=ixomax^d;
2280 ixcmin^d=ixomin^d+kr(idir,^d)-1;
2281 jcc(ixc^s,idir)=0.d0
2282 {do ix^db=0,1\}
2283 if({ ix^d==1 .and. ^d==idir | .or.}) cycle
2284 ixamin^d=ixcmin^d+ix^d;
2285 ixamax^d=ixcmax^d+ix^d;
2286 jcc(ixc^s,idir)=jcc(ixc^s,idir)+eta(ixa^s)
2287 {end do\}
2288 jcc(ixc^s,idir)=jcc(ixc^s,idir)*0.25d0
2289 jce(ixc^s,idir)=jce(ixc^s,idir)*jcc(ixc^s,idir)
2290 enddo
2291 end if
2292
2293 end associate
2294 end subroutine get_resistive_electric_field
2295
2296 !> calculate cell-center values from face-center values
2297 subroutine mf_face_to_center(ixO^L,s)
2299 ! Non-staggered interpolation range
2300 integer, intent(in) :: ixo^l
2301 type(state) :: s
2302
2303 integer :: ix^d
2304
2305 ! calculate cell-center values from face-center values in 2nd order
2306 {!dir$ ivdep
2307 do ix^db=ixomin^db,ixomax^db\}
2308 {^ifthreed
2309 s%w(ix^d,mag(1))=half/s%surface(ix^d,1)*(s%ws(ix^d,1)*s%surfaceC(ix^d,1)&
2310 +s%ws(ix1-1,ix2,ix3,1)*s%surfaceC(ix1-1,ix2,ix3,1))
2311 s%w(ix^d,mag(2))=half/s%surface(ix^d,2)*(s%ws(ix^d,2)*s%surfaceC(ix^d,2)&
2312 +s%ws(ix1,ix2-1,ix3,2)*s%surfaceC(ix1,ix2-1,ix3,2))
2313 s%w(ix^d,mag(3))=half/s%surface(ix^d,3)*(s%ws(ix^d,3)*s%surfaceC(ix^d,3)&
2314 +s%ws(ix1,ix2,ix3-1,3)*s%surfaceC(ix1,ix2,ix3-1,3))
2315 }
2316 {^iftwod
2317 s%w(ix^d,mag(1))=half/s%surface(ix^d,1)*(s%ws(ix^d,1)*s%surfaceC(ix^d,1)&
2318 +s%ws(ix1-1,ix2,1)*s%surfaceC(ix1-1,ix2,1))
2319 s%w(ix^d,mag(2))=half/s%surface(ix^d,2)*(s%ws(ix^d,2)*s%surfaceC(ix^d,2)&
2320 +s%ws(ix1,ix2-1,2)*s%surfaceC(ix1,ix2-1,2))
2321 }
2322 {end do\}
2323
2324 ! calculate cell-center values from face-center values in 4th order
2325 !do idim=1,ndim
2326 ! gxO^L=ixO^L-2*kr(idim,^D);
2327 ! hxO^L=ixO^L-kr(idim,^D);
2328 ! jxO^L=ixO^L+kr(idim,^D);
2329
2330 ! ! Interpolate to cell barycentre using fourth order central formula
2331 ! w(ixO^S,mag(idim))=(0.0625d0/s%surface(ixO^S,idim))*&
2332 ! ( -ws(gxO^S,idim)*s%surfaceC(gxO^S,idim) &
2333 ! +9.0d0*ws(hxO^S,idim)*s%surfaceC(hxO^S,idim) &
2334 ! +9.0d0*ws(ixO^S,idim)*s%surfaceC(ixO^S,idim) &
2335 ! -ws(jxO^S,idim)*s%surfaceC(jxO^S,idim) )
2336 !end do
2337
2338 ! calculate cell-center values from face-center values in 6th order
2339 !do idim=1,ndim
2340 ! fxO^L=ixO^L-3*kr(idim,^D);
2341 ! gxO^L=ixO^L-2*kr(idim,^D);
2342 ! hxO^L=ixO^L-kr(idim,^D);
2343 ! jxO^L=ixO^L+kr(idim,^D);
2344 ! kxO^L=ixO^L+2*kr(idim,^D);
2345
2346 ! ! Interpolate to cell barycentre using sixth order central formula
2347 ! w(ixO^S,mag(idim))=(0.00390625d0/s%surface(ixO^S,idim))* &
2348 ! ( +3.0d0*ws(fxO^S,idim)*s%surfaceC(fxO^S,idim) &
2349 ! -25.0d0*ws(gxO^S,idim)*s%surfaceC(gxO^S,idim) &
2350 ! +150.0d0*ws(hxO^S,idim)*s%surfaceC(hxO^S,idim) &
2351 ! +150.0d0*ws(ixO^S,idim)*s%surfaceC(ixO^S,idim) &
2352 ! -25.0d0*ws(jxO^S,idim)*s%surfaceC(jxO^S,idim) &
2353 ! +3.0d0*ws(kxO^S,idim)*s%surfaceC(kxO^S,idim) )
2354 !end do
2355
2356 end subroutine mf_face_to_center
2357
2358 !> calculate magnetic field from vector potential
2359 subroutine b_from_vector_potential(ixIs^L, ixI^L, ixO^L, ws, x)
2362
2363 integer, intent(in) :: ixis^l, ixi^l, ixo^l
2364 double precision, intent(inout) :: ws(ixis^s,1:nws)
2365 double precision, intent(in) :: x(ixi^s,1:ndim)
2366
2367 double precision :: adummy(ixis^s,1:3)
2368
2369 call b_from_vector_potentiala(ixis^l, ixi^l, ixo^l, ws, x, adummy)
2370
2371 end subroutine b_from_vector_potential
2372
2375
2376 double precision :: sum_jbb_ipe, sum_j_ipe, sum_l_ipe, f_i_ipe, volume_pe
2377 double precision :: sum_jbb, sum_j, sum_l, f_i, volume, cw_sin_theta
2378 integer :: iigrid, igrid, ix^d
2379 integer :: amode, istatus(mpi_status_size)
2380 integer, save :: fhmf
2381 logical :: patchwi(ixg^t)
2382 logical, save :: logmfopened=.false.
2383 character(len=800) :: filename,filehead
2384 character(len=800) :: line,datastr
2385
2386 sum_jbb_ipe = 0.d0
2387 sum_j_ipe = 0.d0
2388 sum_l_ipe = 0.d0
2389 f_i_ipe = 0.d0
2390 volume_pe=0.d0
2391 do iigrid=1,igridstail; igrid=igrids(iigrid);
2392 block=>ps(igrid)
2393 ^d&dxlevel(^d)=rnode(rpdx^d_,igrid);
2394 call mask_inner(ixg^ll,ixm^ll,ps(igrid)%w,ps(igrid)%x,patchwi,volume_pe)
2395 sum_jbb_ipe = sum_jbb_ipe+integral_grid_mf(ixg^ll,ixm^ll,ps(igrid)%w,&
2396 ps(igrid)%x,1,patchwi)
2397 sum_j_ipe = sum_j_ipe+integral_grid_mf(ixg^ll,ixm^ll,ps(igrid)%w,&
2398 ps(igrid)%x,2,patchwi)
2399 f_i_ipe=f_i_ipe+integral_grid_mf(ixg^ll,ixm^ll,ps(igrid)%w,&
2400 ps(igrid)%x,3,patchwi)
2401 sum_l_ipe = sum_l_ipe+integral_grid_mf(ixg^ll,ixm^ll,ps(igrid)%w,&
2402 ps(igrid)%x,4,patchwi)
2403 end do
2404 call mpi_reduce(sum_jbb_ipe,sum_jbb,1,mpi_double_precision,&
2405 mpi_sum,0,icomm,ierrmpi)
2406 call mpi_reduce(sum_j_ipe,sum_j,1,mpi_double_precision,mpi_sum,0,&
2407 icomm,ierrmpi)
2408 call mpi_reduce(f_i_ipe,f_i,1,mpi_double_precision,mpi_sum,0,&
2409 icomm,ierrmpi)
2410 call mpi_reduce(sum_l_ipe,sum_l,1,mpi_double_precision,mpi_sum,0,&
2411 icomm,ierrmpi)
2412 call mpi_reduce(volume_pe,volume,1,mpi_double_precision,mpi_sum,0,&
2413 icomm,ierrmpi)
2414
2415 if(mype==0) then
2416 ! current- and volume-weighted average of the sine of the angle
2417 ! between the magnetic field B and the current density J
2418 cw_sin_theta = sum_jbb/sum_j
2419 ! volume-weighted average of the absolute value of the fractional
2420 ! magnetic flux change
2421 f_i = f_i/volume
2422 sum_j=sum_j/volume
2423 sum_l=sum_l/volume
2424 if(.not.logmfopened) then
2425 ! generate filename
2426 write(filename,"(a,a)") trim(base_filename), "_mf_metrics.csv"
2427
2428 ! Delete the log when not doing a restart run
2429 if (restart_from_file == undefined) then
2430 open(unit=20,file=trim(filename),status='replace')
2431 close(20, status='delete')
2432 end if
2433
2434 amode=ior(mpi_mode_create,mpi_mode_wronly)
2435 amode=ior(amode,mpi_mode_append)
2436 call mpi_file_open(mpi_comm_self,filename,amode,mpi_info_null,fhmf,ierrmpi)
2437 logmfopened=.true.
2438 filehead=" it,time,CW_sin_theta,current,Lorenz_force,f_i"
2439 if (it == 0) then
2440 call mpi_file_write(fhmf,filehead,len_trim(filehead), &
2441 mpi_character,istatus,ierrmpi)
2442 call mpi_file_write(fhmf,achar(10),1,mpi_character,istatus,ierrmpi)
2443 end if
2444 end if
2445 line=''
2446 write(datastr,'(i6,a)') it,','
2447 line=trim(line)//trim(datastr)
2448 write(datastr,'(es13.6,a)') global_time,','
2449 line=trim(line)//trim(datastr)
2450 write(datastr,'(es13.6,a)') cw_sin_theta,','
2451 line=trim(line)//trim(datastr)
2452 write(datastr,'(es13.6,a)') sum_j,','
2453 line=trim(line)//trim(datastr)
2454 write(datastr,'(es13.6,a)') sum_l,','
2455 line=trim(line)//trim(datastr)
2456 write(datastr,'(es13.6)') f_i
2457 line=trim(line)//trim(datastr)//new_line('A')
2458 call mpi_file_write(fhmf,line,len_trim(line),mpi_character,istatus,ierrmpi)
2459 if(.not.time_advance) then
2460 call mpi_file_close(fhmf,ierrmpi)
2461 logmfopened=.false.
2462 end if
2463 end if
2464
2465 end subroutine record_force_free_metrics
2466
2467 subroutine mask_inner(ixI^L,ixO^L,w,x,patchwi,volume_pe)
2469
2470 integer, intent(in) :: ixi^l,ixo^l
2471 double precision, intent(in):: w(ixi^s,nw),x(ixi^s,1:ndim)
2472 double precision, intent(inout) :: volume_pe
2473 logical, intent(out) :: patchwi(ixi^s)
2474
2475 double precision :: xo^l
2476 integer :: ix^d
2477
2478 {xomin^d = xprobmin^d + 0.05d0*(xprobmax^d-xprobmin^d)\}
2479 {xomax^d = xprobmax^d - 0.05d0*(xprobmax^d-xprobmin^d)\}
2480 if(slab) then
2481 xomin^nd = xprobmin^nd
2482 else
2483 xomin1 = xprobmin1
2484 end if
2485
2486 {do ix^db=ixomin^db,ixomax^db\}
2487 if({ x(ix^dd,^d) > xomin^d .and. x(ix^dd,^d) < xomax^d | .and. }) then
2488 patchwi(ix^d)=.true.
2489 volume_pe=volume_pe+block%dvolume(ix^d)
2490 else
2491 patchwi(ix^d)=.false.
2492 endif
2493 {end do\}
2494
2495 end subroutine mask_inner
2496
2497 function integral_grid_mf(ixI^L,ixO^L,w,x,iw,patchwi)
2499
2500 integer, intent(in) :: ixi^l,ixo^l,iw
2501 double precision, intent(in) :: x(ixi^s,1:ndim)
2502 double precision :: w(ixi^s,nw+nwauxio)
2503 logical, intent(in) :: patchwi(ixi^s)
2504
2505 double precision, dimension(ixI^S,7-2*ndir:3) :: current
2506 double precision, dimension(ixI^S,1:ndir) :: bvec,qvec
2507 double precision :: integral_grid_mf,tmp(ixi^s),bm2
2508 integer :: ix^d,idirmin0,idirmin,idir,jdir,kdir
2509
2510 integral_grid_mf=0.d0
2511 select case(iw)
2512 case(1)
2513 ! Sum(|JxB|/|B|*dvolume)
2514 bvec(ixo^s,:)=w(ixo^s,mag(:))
2515 call get_current(w,ixi^l,ixo^l,idirmin,current)
2516 ! calculate Lorentz force
2517 qvec(ixo^s,1:ndir)=zero
2518 do idir=1,ndir; do jdir=idirmin,3; do kdir=1,ndir
2519 if(lvc(idir,jdir,kdir)/=0)then
2520 if(lvc(idir,jdir,kdir)==1)then
2521 qvec(ixo^s,idir)=qvec(ixo^s,idir)+current(ixo^s,jdir)*bvec(ixo^s,kdir)
2522 else
2523 qvec(ixo^s,idir)=qvec(ixo^s,idir)-current(ixo^s,jdir)*bvec(ixo^s,kdir)
2524 end if
2525 end if
2526 end do; end do; end do
2527
2528 {do ix^db=ixomin^db,ixomax^db\}
2529 if(patchwi(ix^d)) then
2530 bm2=sum(bvec(ix^d,:)**2)
2531 if(bm2/=0.d0) bm2=1.d0/bm2
2532 integral_grid_mf=integral_grid_mf+sqrt(sum(qvec(ix^d,:)**2)*&
2533 bm2)*block%dvolume(ix^d)
2534 end if
2535 {end do\}
2536 case(2)
2537 ! Sum(|J|*dvolume)
2538 call get_current(w,ixi^l,ixo^l,idirmin,current)
2539 {do ix^db=ixomin^db,ixomax^db\}
2540 if(patchwi(ix^d)) integral_grid_mf=integral_grid_mf+sqrt(sum(current(ix^d,:)**2))*&
2541 block%dvolume(ix^d)
2542 {end do\}
2543 case(3)
2544 ! f_i solenoidal property of B: (dvolume |div B|)/(dsurface |B|)
2545 ! Sum(f_i*dvolume)
2546 call get_normalized_divb(w,ixi^l,ixo^l,tmp)
2547 {do ix^db=ixomin^db,ixomax^db\}
2548 if(patchwi(ix^d)) integral_grid_mf=integral_grid_mf+tmp(ix^d)*block%dvolume(ix^d)
2549 {end do\}
2550 case(4)
2551 ! Sum(|JxB|*dvolume)
2552 bvec(ixo^s,:)=w(ixo^s,mag(:))
2553 call get_current(w,ixi^l,ixo^l,idirmin,current)
2554 ! calculate Lorentz force
2555 qvec(ixo^s,1:ndir)=zero
2556 do idir=1,ndir; do jdir=idirmin,3; do kdir=1,ndir
2557 if(lvc(idir,jdir,kdir)/=0)then
2558 if(lvc(idir,jdir,kdir)==1)then
2559 qvec(ixo^s,idir)=qvec(ixo^s,idir)+current(ixo^s,jdir)*bvec(ixo^s,kdir)
2560 else
2561 qvec(ixo^s,idir)=qvec(ixo^s,idir)-current(ixo^s,jdir)*bvec(ixo^s,kdir)
2562 end if
2563 end if
2564 end do; end do; end do
2565
2566 {do ix^db=ixomin^db,ixomax^db\}
2567 if(patchwi(ix^d)) integral_grid_mf=integral_grid_mf+&
2568 sqrt(sum(qvec(ix^d,:)**2))*block%dvolume(ix^d)
2569 {end do\}
2570 end select
2571 return
2572 end function integral_grid_mf
2573
2574end module mod_mf_phys
subroutine, public mpistop(message)
Exit MPI-AMRVAC with an error message.
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
Module with basic grid data structures.
Definition mod_forest.t:2
type(tree_node_ptr), dimension(:,:), allocatable, save igrid_to_node
Array to go from an [igrid, ipe] index to a node pointer.
Definition mod_forest.t:32
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)
Definition mod_geometry.t:2
integer coordinate
Definition mod_geometry.t:7
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
integer, dimension(0:3^d &), target type_recv_p_p1
integer, dimension( :^d &), pointer type_recv_r
integer, dimension(-1:1^d &), target type_send_srl_p1
subroutine getbc(time, qdt, psb, nwstart, nwbc)
do update ghost cells of all blocks including physical boundaries
integer, dimension(0:3^d &), target type_send_p_f
integer, dimension( :^d &), pointer type_send_p
integer, dimension( :^d &), pointer type_send_srl
integer, dimension(-1:1^d &), target type_send_r_p1
subroutine create_bc_mpi_datatype(nwstart, nwbc)
integer, dimension(0:3^d &), target type_recv_r_f
integer, dimension(-1:1^d &), target type_recv_srl_f
integer, dimension(-1:1^d &), target type_send_r_f
integer, dimension(-1:1^d &), target type_send_srl_f
integer, dimension(0:3^d &), target type_send_p_p1
integer, dimension( :^d &), pointer type_send_r
integer, dimension(0:3^d &), target type_recv_r_p1
integer, dimension( :^d &), pointer type_recv_p
integer, dimension(-1:1^d &), target type_recv_srl_p1
integer, dimension(0:3^d &), target type_recv_p_f
integer, dimension( :^d &), pointer type_recv_srl
This module contains definitions of global parameters and variables and some generic functions/subrou...
type(state), pointer block
Block pointer for using one block and its previous state.
double precision dtdiffpar
For resistive MHD, the time step is also limited by the diffusion time: .
character(len=std_len) typegrad
double precision unit_charge
Physical scaling factor for charge.
integer ixghi
Upper index of grid block arrays.
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
double precision global_time
The global simulation time.
double precision unit_mass
Physical scaling factor for mass.
integer, dimension(3, 3) kr
Kronecker delta tensor.
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.
double precision unit_pressure
Physical scaling factor for pressure.
integer, parameter ndim
Number of spatial dimensions for grid variables.
double precision unit_length
Physical scaling factor for length.
logical stagger_grid
True for using stagger grid.
double precision cmax_global
global fastest wave speed needed in fd scheme and glm method
logical use_particles
Use particles module or not.
character(len=std_len), dimension(:), allocatable par_files
Which par files are used as input.
integer icomm
The MPI communicator.
double precision bdip
amplitude of background dipolar, quadrupolar, octupolar, user's field
integer 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 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.
integer nwauxio
Number of auxiliary variables that are only included in output.
double precision unit_velocity
Physical scaling factor for velocity.
logical time_advance
do time evolving
character(len=std_len) restart_from_file
If not 'unavailable', resume from snapshot with this base file name.
double precision c_norm
Normalised speed of light.
double precision, dimension(:,:), allocatable rnode
Corner coordinates.
double precision unit_temperature
Physical scaling factor for temperature.
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
character(len= *), parameter undefined
logical need_global_cmax
need global maximal wave speed
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)
character(len=std_len) base_filename
Base file name for simulation output, which will be followed by a number.
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:
logical record_electric_field
True for record electric field.
integer, parameter ixglo
Lower index of grid block arrays (always 1)
Magnetofriction module.
Definition mod_mf_phys.t:2
double precision, public mf_nu
viscosity coefficient in s cm^-2 for solar corona (Cheung 2012 ApJ)
Definition mod_mf_phys.t:12
subroutine, public mf_phys_init()
integer, public, protected mf_divb_nth
Whether divB is computed with a fourth order approximation.
Definition mod_mf_phys.t:76
subroutine, public b_from_vector_potential(ixisl, ixil, ixol, ws, x)
calculate magnetic field from vector potential
logical, public, protected mf_record_electric_field
set to true if need to record electric field on cell edges
Definition mod_mf_phys.t:73
logical, public, protected clean_initial_divb
clean divb in the initial condition
Definition mod_mf_phys.t:88
logical, public divbwave
Add divB wave in Roe solver.
Definition mod_mf_phys.t:85
subroutine, public mf_face_to_center(ixol, s)
calculate cell-center values from face-center values
double precision, public mf_vmax
maximal limit of magnetofrictional velocity in cm s^-1 (Pomoell 2019 A&A)
Definition mod_mf_phys.t:15
logical, public, protected mf_glm
Whether GLM-MHD is used.
Definition mod_mf_phys.t:64
double precision, public mf_eta_hyper
The hyper-resistivity.
Definition mod_mf_phys.t:28
double precision, public mf_glm_alpha
GLM-MHD parameter: ratio of the diffusive and advective time scales for div b taking values within [0...
Definition mod_mf_phys.t:22
logical, dimension(2 *^nd), public, protected boundary_divbfix
To control divB=0 fix for boundary.
Definition mod_mf_phys.t:79
character(len=std_len), public, protected type_ct
Method type of constrained transport.
Definition mod_mf_phys.t:94
character(len=std_len), public, protected typedivbfix
Method type to clean divergence of B.
Definition mod_mf_phys.t:91
subroutine, public get_normalized_divb(w, ixil, ixol, divb)
get dimensionless div B = |divB| * volume / area / |B|
integer, dimension(2 *^nd), public, protected boundary_divbfix_skip
To skip * layer of ghost cells during divB=0 fix for boundary.
Definition mod_mf_phys.t:46
double precision, dimension(2 *^nd), public mf_decay_scale
decay scale of frictional velocity near boundaries
Definition mod_mf_phys.t:18
subroutine, public record_force_free_metrics()
subroutine, public mf_to_conserved(ixil, ixol, w, x)
Transform primitive variables into conservative ones.
logical, public, protected mf_4th_order
MHD fourth order.
Definition mod_mf_phys.t:70
subroutine, public get_current(w, ixil, ixol, idirmin, current, fourthorder)
Calculate idirmin and the idirmin:3 components of the common current array make sure that dxlevel(^D)...
integer, public, protected psi_
Indices of the GLM psi.
Definition mod_mf_phys.t:43
integer, dimension(:), allocatable, public, protected mom
Indices of the momentum density.
Definition mod_mf_phys.t:40
subroutine, public mf_clean_divb_multigrid(qdt, qt, active)
logical, public, protected mf_particles
Whether particles module is added.
Definition mod_mf_phys.t:61
subroutine, public mf_to_primitive(ixil, ixol, w, x)
Transform conservative variables into primitive ones.
double precision, public mf_eta
The resistivity.
Definition mod_mf_phys.t:25
logical, public, protected source_split_divb
Whether divB cleaning sources are added splitting from fluid solver.
Definition mod_mf_phys.t:67
double precision, public, protected he_abundance
Helium abundance over Hydrogen.
Definition mod_mf_phys.t:34
Module to couple the octree-mg library to AMRVAC. This file uses the VACPP preprocessor,...
type(mg_t) mg
Data structure containing the multigrid tree.
Module containing all the particle routines.
subroutine particles_init()
Initialize particle data and parameters.
This module defines the procedures of a physics module. It contains function pointers for the various...
Definition mod_physics.t:4
procedure(sub_get_ct_velocity), pointer phys_get_ct_velocity
Definition mod_physics.t:79
procedure(sub_convert), pointer phys_to_primitive
Definition mod_physics.t:55
integer, parameter flux_tvdlf
Indicates the flux should be treated with tvdlf.
Definition mod_physics.t:26
procedure(sub_write_info), pointer phys_write_info
Definition mod_physics.t:77
procedure(sub_get_flux), pointer phys_get_flux
Definition mod_physics.t:64
procedure(sub_get_cbounds), pointer phys_get_cbounds
Definition mod_physics.t:63
procedure(sub_get_dt), pointer phys_get_dt
Definition mod_physics.t:67
procedure(sub_add_source_geom), pointer phys_add_source_geom
Definition mod_physics.t:68
procedure(sub_check_params), pointer phys_check_params
Definition mod_physics.t:52
integer, parameter flux_default
Indicates a normal flux.
Definition mod_physics.t:24
integer, dimension(:, :), allocatable flux_type
Array per direction per variable, which can be used to specify that certain fluxes have to be treated...
Definition mod_physics.t:21
procedure(sub_update_faces), pointer phys_update_faces
Definition mod_physics.t:80
procedure(sub_convert), pointer phys_to_conserved
Definition mod_physics.t:54
character(len=name_len) physics_type
String describing the physics type of the simulation.
Definition mod_physics.t:50
procedure(sub_clean_divb), pointer phys_clean_divb
Definition mod_physics.t:84
procedure(sub_boundary_adjust), pointer phys_boundary_adjust
Definition mod_physics.t:76
procedure(sub_global_source), pointer phys_global_source_after
Definition mod_physics.t:70
procedure(sub_add_source), pointer phys_add_source
Definition mod_physics.t:69
procedure(sub_face_to_center), pointer phys_face_to_center
Definition mod_physics.t:81
procedure(sub_modify_wlr), pointer phys_modify_wlr
Definition mod_physics.t:56
procedure(sub_get_cmax), pointer phys_get_cmax
Definition mod_physics.t:57
logical phys_energy
Solve energy equation or not.
Definition mod_physics.t:35
procedure(sub_special_advance), pointer phys_special_advance
Definition mod_physics.t:71
Module with all the methods that users can customize in AMRVAC.
procedure(special_resistivity), pointer usr_special_resistivity
procedure(set_electric_field), pointer usr_set_electric_field
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.
Definition mod_forest.t:11