IllinoisGRMHD

Samuel Cupp
Leonardo Rosa Werneck
Terrence Pierre Jacques
Zachariah Etienne

\( \)Date\( \)

Abstract

IllinoisGRMHD solves the equations of general relativistic magneto-hydrodynamics (GRMHD) using the General Relativistic Hydrodynamics Library (GRHayL), which is included in the Einstein Toolkit via the GRHayLib thorn. The core library inherits or adapts code from the original IllinoisGRMHD thorn into a modular, infrastructure-agnostic library. This original thorn is itself a rewrite of the Illinois Numerical Relativity (ILNR) group’s GRMHD code (ca. 2009–2014), which was used in their modeling of the following systems:

  1. Magnetized circumbinary disk accretion onto binary black holes

  2. Magnetized black hole–neutron star mergers

  3. Magnetized Bondi flow, Bondi-Hoyle-Littleton accretion

  4. White dwarf–neutron star mergers

The improved GRHayL-based IllinoisGRMHD incorporates more options for controlling the evolution, most notably the addition of new conservative-to-primitive solvers and nuclear equations of state.

1 Introduction

This thorn provides a GRMHD evolution code built on the General Relativistic Hydrodynamics Library (GRHayL), which is included in the Einstein Toolkit via the GRHayLib thorn. The core library inherits or adapts code from the original IllinoisGRMHD thorn into a modular, infrastructure-agnostic library.

The new and improved IllinoisGRMHD provides support for hybrid and tabulated EOS, both with and without entropy. The core functions all come from GRHayLib, ensuring that any improvements or updates to the library can be easily adopted by the thorn. The conservative-to-primitive solver is selected at runtime, allowing for users to take advantage of any Con2Prim methods provided by GRHayL.

2 Parameters

Most of the behavior of this thorn is controlled by GRHayLib, the thorn that provides GRHayL functionality within the Einstein Toolkit. However, there are several parameters in the thorn which control diagnostic or debugging features. Most are self-explanatory, but some parameters deserve a more detailed explanation.

First, many analysis or diagnostic thorns use HydroBase variables. By default, IllinoisGRMHD never copies the data back from IllinoisGRMHD variables to HydroBase variables, which would prevent the usage of these thorns. The Convert_to_HydroBase_every parameter sets how often to copy back this data. Naturally, copying more frequently will slow down the simulation, so this should be set on the same frequency as the analysis or IO thorn that is using the HydroBase variable. We reduced the amount of data copying in IllinoisGRMHD by using the HydroBase variables directly, which removes the need to copy them back and removes extra grid functions from memory. We still use distinct velocity variables because we use a different velocity than is defined in HydroBase, so this conversion is still necessary.

Next, there are several parameters for debugging or other testing. The perturbing parameters give users the ability to affect either the initial data or evolution data at runtime without slowing down standard simulations. The perturb_initial_data parameter controls whether the initial data from HydroBase is perturbed, and the perturb_every_con2prim parameter controls whether the conservative variables are perturbed before every con2prim call. The magnitude of these perturbations is set by random_pert.

3 Updating Old Parfiles

With the many changes to improve the code and transition to using GRHayLib, parfile setups have changed significantly. To this end, we provide a guide to updating parfiles from old IllinoisGRMHD to the GRHayL-based IllinoisGRMHD. Old parfiles are temporarily supported via backward compatibility patch, but this support ends in the ET_2024_11 release.

First, the two thorns ID_converter_ILGRMHD and Convert_to_HydroBase are entirely deprecated and will be removed. As such, these thorns and all their parameters should be removed from the parfile. Their equivalent parameters are as follows:

Old
New


ID_converter_ILGRMHD::Gamma_Initial GRHayLib::Gamma_ppoly_in[0]
ID_converter_ILGRMHD::random_seed IllinoisGRMHD::random_seed
ID_converter_ILGRMHD::random_pert IllinoisGRMHD::random_pert
ID_converter_ILGRMHD::K_Initial GRHayLib::k_ppoly0
Convert_to_HydroBase::Convert_to_HydroBase_everyIllinoisGRMHD::Convert_to_HydroBase_every


The parameter ID_converter_ILGRMHD::pure_hydro_run is entirely deprecated, as the GRHayLHD thorn provides this functionaility. Additionally, to properly trigger the random perturbation the new parameter IllinoisGRMHD::perturb_initial_data should be set.

The parameters in IllinoisGRMHD have also changed significantly, with many moving to the GRHayLib thorn. These changes are as follows:

Old
New


IllinoisGRMHD::GAMMA_SPEED_LIMITGRHayLib::max_Lorentz_factor
IllinoisGRMHD::K_poly GRHayLib::k_ppoly0
IllinoisGRMHD::rho_b_atm GRHayLib::rho_b_atm
IllinoisGRMHD::rho_b_max GRHayLib::rho_b_max
IllinoisGRMHD::Psi6threshold GRHayLib::Psi6threshold
IllinoisGRMHD::neos GRHayLib::neos
IllinoisGRMHD::gamma_th GRHayLib::Gamma_th
IllinoisGRMHD::damp_lorenz GRHayLib::Lorenz_damping_factor


As seen here, the ID converter and IllinoisGRMHD thorns both had a \(K\) parameter. These are condensed into a single parameter in GRHayLib.

Two parameters are deprecated and marked for removal. These are IllinoisGRMHD::tau_atm and IllinoisGRMHD::conserv_to_prims_debug. The former is now automatically computed by GRHayLib, and the latter’s feature is no longer available.

Other IllinoisGRMHD parameter names are unchanged. However, some of their options are deprecated and also marked for removal. These are the ”essential” and ”essential+iteration output” options for IllinoisGRMHD::verbose.

Finally, note that the magnetic field quantities have been rescaled by \(\left (4\pi \right )^{-1/2}\), as this simplifies many equations in GRHayL. This definition is consistent with the magnetic field defined by HydroBase and GRHydro (which the old IllinoisGRMHD did not respect). To maintain support for old initial data thorns, we by default assume that the HydroBase \(B^i\), \(A_i\) use the old definition and rescale them when copying into the IllinoisGRMHD variables. The parameter rescale_magnetics controls this behavior. If the thorns using the old definition (i.e. thorns in wvuthorns and wvuthorns_diagnostics) are updated to use the new definition, this parameter will be switch such that the default behaves as expected for these thorns. Such a change will be detailed in the Einstein Toolkit release notes prior to the release introducing the change.

In addition to these changes, GRHayLib offers new parameter options for controlling the simulation, such as a wider range of conservative-to-primitive routines, new equation of state options, and control over the PPM reconstruction parameters. Please see that thorn’s documentation for more information about these features, as well as GRHayL’s documentation on the library’s implementation details.

4 Acknowledgements

Note that many codes have fed into the GRHayL library. The most prominent is the IllinoisGRMHD thorn developed primarily by Zachariah Etienne, Yuk Tung Liu, and Vasileios Paschalidis [1]. This thorn is based on the GRMHD code of the Illinois Numerical Relativity group (ca. 2014), written by Matt Duez, Yuk Tung Liu, and Branson Stephens .

For the full list of contributions and related citations, please use GRHayL’s citation guide.

References

[1]   Z. B. Etienne, V. Paschalidis, R. Haas, P. Mösta and S. L. Shapiro, “IllinoisGRMHD: An Open-Source, User-Friendly GRMHD Code for Dynamical Spacetimes,” Class. Quant. Grav. 32, 175009 (2015) doi:10.1088/0264-9381/32/17/175009 [arXiv:1501.07276 [astro-ph.HE]].

5 Parameters




conserv_to_prims_debug
Scope: private  INT



Description: Deprecated.



Range   Default: (none)
0:1
zero (no) or one (yes)






convert_to_hydrobase_every
Scope: private  INT



Description: How often to convert IllinoisGRMHD primitive variables to HydroBase (Valencia formulation) primitive variables? Needed for some ET-based diagnostics. NOT needed for pure IllinoisGRMHD runs.



Range   Default: (none)
0:*
zero (disable) or positive (every N iterations)






damp_lorenz
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 0.0
*:*
any real






em_bc
Scope: private  KEYWORD



Description: EM field boundary condition



Range   Default: copy
copy
Copy data from nearest boundary point
frozen
Frozen boundaries






gamma_speed_limit
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 10.0
1:*
Positive > 1, though you’ll likely have troubles far above 10.






gamma_th
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: -1
0:*
Physical values
-1
forbidden value to make sure it is explicitly set in the parfile






k_poly
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 1.0
0:*
Positive






matter_bc
Scope: private  KEYWORD



Description: Chosen Matter boundary condition



Range   Default: outflow
copy
Copy BCs
outflow
Copy BCs with additional outflow BC for velocities
frozen
Frozen boundaries






neos
Scope: private  INT



Description: Deprecated. Please use GRHayLib.



Range   Default: 1
1:10
Any integer between 1 and 10






perturb_every_con2prim
Scope: private  BOOLEAN



Description: Random perturbation applied every time con2prim runs



  Default: no






perturb_initial_data
Scope: private  BOOLEAN



Description: Random perturbation to initial data



  Default: no






psi6threshold
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 1e100
*:*
Can set to anything






random_pert
Scope: private  REAL



Description: Magnitude of random perturbations



Range   Default: (none)
*:*
Anything goes.






random_seed
Scope: private  INT



Description: Random seed for random, generally roundoff-level perturbation on initial data. Seeds srand(), and rand() is used for the RNG.



Range   Default: (none)
0:99999999
Anything unsigned goes.






rescale_magnetics
Scope: private  BOOLEAN



Description: Rescale magnetic data to match original IllinoisGRMHD definitions



  Default: yes






rho_b_atm
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 1e200
*:*
Allow for negative values. This enables us to debug the code and verify if rho_b_atm is properly set.






rho_b_max
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 1e300
0:*
Note that you will have problems unless rho_b_atm<rho_b_max






sym_bz
Scope: private  REAL



Description: In-progress equatorial symmetry support: Symmetry parameter across z axis for magnetic fields = +/- 1



Range   Default: 1.0
-1.0:1.0
Set to +1 or -1.






symmetry
Scope: private  KEYWORD



Description: Currently only no symmetry supported, though work has begun in adding equatorial-symmetry support.



Range   Default: none
none
no symmetry, full 3d domain






tau_atm
Scope: private  REAL



Description: Deprecated. Please use GRHayLib.



Range   Default: 1e100
0:*
Positive






update_tmunu
Scope: private  BOOLEAN



Description: Update Tmunu, for RHS of Einstein’s equations?



  Default: yes






verbose
Scope: private  KEYWORD



Description: Determines how much evolution information is output



Range   Default: yes
no
Complete silence
yes
”Outputs information about conservative-to-prim itive fixes, failures, etc.”
essential
Deprecated option.
see [1] below
Deprecated option.



[1]

essential+iteration output




eos_type
Scope: shared from GRHAYLIB KEYWORD






evolve_entropy
Scope: shared from GRHAYLIB BOOLEAN



6 Interfaces

General

Implements:

illinoisgrmhd

Inherits:

admbase

tmunubase

hydrobase

grhaylib

Grid Variables

6.0.1 PRIVATE GROUPS




  Group Names    Variable Names    Details   




grmhd_velocities   compact0
vx   descriptionComponents of primitive three velocity vî. Note that vî is defined in terms of 4-velocity as: vî = uî/u                                          ˆ0  . Note that this definition differs from the Valencia formalism.
vy   dimensions3
vz   distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none”
  timelevels1
 variable typeREAL




u0 u0   compact0
  description4-velocity component uˆ0
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none” checkpoint=”no”
  timelevels1
 variable typeREAL




grmhd_conservatives   compact0
rho_star   descriptionEvolved hydrodynamic variables
tau   dimensions3
Stildex   distributionDEFAULT
Stildey   group typeGF
Stildez   tagsprolongation=”ENO”
  timelevels3
 variable typeREAL




ent_star ent_star   compact0
  descriptionEvolved entropy variable
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”ENO”
  timelevels3
 variable typeREAL




ye_star Ye_star   compact0
  descriptionEvolved electron fraction variable
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”ENO”
  timelevels3
 variable typeREAL




ax Ax   compact0
  descriptionx-component of the vector potential
    descriptionevolved when constrained_transport_scheme==3
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsProlongation=”STAGGER011”
  timelevels3
 variable typeREAL








  Group Names     Variable Names    Details   




ay Ay   compact0
  descriptiony-component of the vector potential
    descriptionevolved when constrained_transport_scheme==3
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsProlongation=”STAGGER101”
  timelevels3
 variable typeREAL




az Az   compact0
  descriptionz-component of the vector potential
    descriptionevolved when constrained_transport_scheme==3
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsProlongation=”STAGGER110”
  timelevels3
 variable typeREAL




phitilde phitilde   compact0
  descriptionsqrt{gamma} Phi
    descriptionwhere Phi is the em scalar potential
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsProlongation=”STAGGER111”
  timelevels3
 variable typeREAL




grmhd_b_stagger   compact0
Bx_stagger   descriptionDensitized B-field components defined at staggered points [Bx_stagger at (i+1/2
    descriptionj
Bx_stagger   descriptionk)
Bx_stagger   descriptionBy_stagger at (i
Bx_stagger   descriptionj+1/2
Bx_stagger   descriptionk)
Bx_stagger   descriptionBz_stagger at (i
Bx_stagger   descriptionj
Bx_stagger   descriptionk+1/2)].
By_stagger   dimensions3
Bz_stagger   distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none”
  timelevels1
 variable typeREAL




grmhd_b_center   compact0
Bx_center   descriptionB-field components defined at vertices.
By_center   dimensions3
Bz_center   distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none”
  timelevels1
 variable typeREAL




grmhd_conservatives_rhs   compact0
rho_star_rhs   descriptionRight-hand side for evolved conservative variables
tau_rhs   dimensions3
Stildex_rhs   distributionDEFAULT
Stildey_rhs   group typeGF
Stildez_rhs   tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL








  Group Names     Variable Names    Details   




ent_star_rhs ent_star_rhs   compact0
  descriptionRight-hand side for ent_star
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL




ye_star_rhs Ye_star_rhs   compact0
  descriptionRight-hand side for Ye_star
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL




em_rhs   compact0
Ax_rhs   descriptionStorage for the right-hand side of the partial_t A equations and partial_t (psi                         ˆ6  Phi) equation.
Ay_rhs   dimensions3
Az_rhs   distributionDEFAULT
phitilde_rhs   group typeGF
  tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL




grmhd_cmin_cmax_temps   compact0
cmin_x   descriptionStore min and max characteristic speeds in all three directions.
cmax_x   dimensions3
cmin_y   distributionDEFAULT
cmax_y   group typeGF
cmin_z   tagsprolongation=”none” Checkpoint=”no”
cmax_z   timelevels1
 variable typeREAL




grmhd_flux_temps   compact0
rho_star_flux   descriptionFlux variables for computing RHSs
tau_flux   dimensions3
Stildex_flux   distributionDEFAULT
Stildey_flux   group typeGF
Stildez_flux   tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL




ent_star_flux ent_star_flux   compact0
  descriptionFlux variable for ent_star
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL








  Group Names     Variable Names    Details   




ye_star_flux Ye_star_flux   compact0
  descriptionFlux variable for Ye_star
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”none” Checkpoint=”no”
  timelevels1
 variable typeREAL




grmhd_primitives_reconstructed_temps   compact0
vxr   descriptionTemporary variables used for primitives reconstruction
vyr   dimensions3
vzr   distributionDEFAULT
vxl   group typeGF
vyl   tagsprolongation=”none” Checkpoint=”no”
vzl   timelevels1
Bx_staggerr  variable typeREAL




failure_checker failure_checker   compact0
  descriptionGridfunction to track conservative-to-primitives solver fixes. Beware that this gridfunction is overwritten at each RK substep.
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsprolongation=”none” Checkpoint=”no” InterpNumTimelevels=1
  timelevels1
 variable typeREAL




em_psi6phi   compact0
psi6phi   descriptionDeprecated variable
  dimensions3
  distributionDEFAULT
  group typeGF
  tagsProlongation=”STAGGER111”
  timelevels3
 variable typeREAL




grmhd_primitives_allbutbi   compact0
rho_b   descriptionDeprecated variables
P   dimensions3
  distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none”
  timelevels1
 variable typeREAL




grmhd_primitives_bi   compact0
Bx   descriptionDeprecated variables
By   dimensions3
Bz   distributionDEFAULT
  group typeGF
  tagsInterpNumTimelevels=1 prolongation=”none”
  timelevels1
 variable typeREAL




Uses header:

Symmetry.h

GRHayLib.h

7 Schedule

This section lists all the variables which are assigned storage by thorn GRHayLET/IllinoisGRMHD. Storage can either last for the duration of the run (Always means that if this thorn is activated storage will be assigned, Conditional means that if this thorn is activated storage will be assigned for the duration of the run if some condition is met), or can be turned on for the duration of a schedule function.

Storage

 

Always: Conditional:
HydroBase::Bvec[1] HydroBase::Avec[1] HydroBase::Aphi[1] Ye_star[3] Ye_star_rhs Ye_star_flux
grmhd_conservatives[3] Ax[3] Ay[3] Az[3] phitilde[3] ent_star[3] ent_star_rhs ent_star_flux
grmhd_velocities u0 grmhd_B_center grmhd_B_stagger em_psi6phi[3] grmhd_primitives_allbutBi grmhd_primitives_Bi
grmhd_conservatives_rhs EM_rhs  
grmhd_primitives_reconstructed_temps grmhd_cmin_cmax_temps failure_checker 
grmhd_flux_temps Ye_star_flux ent_star_flux  
   

Scheduled Functions

MoL_Register (conditional)

  illinoisgrmhd_registervars

  register evolved, rhs variables in illinoisgrmhd for mol

 

 Language:c
 Options: meta
 Type: function

Driver_BoundarySelect (conditional)

  illinoisgrmhd_specify_driver_bcs

  register boundary conditions with presync

 

 Language:c
 Options: meta
 Type: function

CCTK_POSTPOSTINITIAL (conditional)

  illinoisgrmhd_set_gz_symmetries

  compute post-initialdata quantities

 

 After: con2prim
 Language:c
 Reads: grid::coordinates
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
    ay
   az
 Type: function
 Writes: grmhd_b_center(boundary)
   grmhd_b_stagger(boundary)
   phitilde(boundary)
   ax(boundary)
   ay(boundary)
   az(boundary)

HydroBase_Con2Prim (conditional)

  illinoisgrmhd_con2prim

  compute primitive variables from conservatives

 

 Type:group

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_sync

  sync conservative variable ghost zones for c2p routine

 

 Language:c
 Sync: grmhd_conservatives
   ye_star
   ent_star
    ax
   ay
   az
   phitilde
 Type: function

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_a_i_outer_boundaries

  apply linear extrapolation bcs on a_{mu}, so that bcs are flat on bî

 

 After: illinoisgrmhd_sync
 Language:c
 Reads: phitilde
   ax
    ay
   az
 Type: function
 Writes: phitilde(boundary)
   ax(boundary)
   ay(boundary)
   az(boundary)

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_compute_b_and_bstagger_from_a

  compute b and b_stagger from a sync: grmhd_primitives_bi,grmhd_primitives_bi_stagger

 

 After: illinoisgrmhd_a_i_outer_boundaries
 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    phitilde
   ax
    ay
   az
  Sync: grmhd_b_center
   grmhd_b_stagger
 Type: function
 Writes: phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)
   grmhd_b_center(everywhere)
   grmhd_b_stagger(everywhere)

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_perturb_conservatives

  perturb conservatives before con2prim

 

 After: illinoisgrmhd_compute_b_and_bstagger_from_a
 Before:illinoisgrmhd_conservs_to_prims
 Type: group

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_conservs_to_prims

  compute primitive variables from conservatives

 

 After:illinoisgrmhd_compute_b_and_bstagger_from_a
 Type:group

IllinoisGRMHD_Con2Prim (conditional)

  illinoisgrmhd_hydro_outer_boundaries

  apply selected boundary conditions to the primitive variables

 

 After:illinoisgrmhd_conservs_to_prims
 Type:group

AddToTmunu (conditional)

  illinoisgrmhd_compute_tmunu

  compute stress-energy tensor

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   grmhd_velocities
   u0
   grmhd_b_center
 Type: function
 Writes: tmunubase::stress_energy_scalar(everywhere)
   tmunubase::stress_energy_vector(everywhere)
   tmunubase::stress_energy_tensor(everywhere)

MoL_CalcRHS (conditional)

  illinoisgrmhd_rhs

  evaluate rhss grhd equations

 

 Type:group

CCTK_BASEGRID (conditional)

  illinoisgrmhd_initsymbound

  schedule symmetries

 

 Language:c
 Type: function

IllinoisGRMHD_RHS (conditional)

  illinoisgrmhd_evaluate_sources_rhs

  evaluate source terms in grmhd rhss

 

 Type:group

IllinoisGRMHD_RHS (conditional)

  illinoisgrmhd_evaluate_fluxes_rhs

  evaluate flux terms in grmhd rhss

 

 After:illinoisgrmhd_evaluate_sources_rhs
 Type:group

IllinoisGRMHD_RHS (conditional)

  convert_illinoisgrmhd_to_hydrobase

  convert needed hydrobase variables for nrpyleakage

 

 After: illinoisgrmhd_evaluate_fluxes_rhs
 Language:c
 Reads: admbase::lapse
   admbase::shift
   grmhd_velocities
 Type: function
 Writes: hydrobase::vel(everywhere)

IllinoisGRMHD_RHS

  illinoisgrmhd_evaluate_phitilde_and_a_gauge_rhs

  evaluate phitilde rhs and gauge contributions to a_i rhs

 

 After: evaluate_fluxes_rhs
  Language:c
 Reads: admbase::lapse
   admbase::shift
    admbase::metric
   phitilde
   ax
   ay
   az
 Type: function
 Writes: grmhd_primitives_reconstructed_temps
   em_rhs

CCTK_ANALYSIS (conditional)

  convert_illinoisgrmhd_to_hydrobase

  convert illinoisgrmhd-native variables to hydrobase

 

 After: ml_bssn_evolcalcgroup
 Before: compute_bi_b2_poyn_fluxet
   convert_to_mhd_3velocity
   particle_traceret
   volumeintegralgroup
 Language:c
 Options: global-early
   loop-local
 Reads: admbase::metric
   admbase::lapse
   admbase::shift
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: hydrobase::vel(everywhere)
   hydrobase::w_lorentz(everywhere)
   hydrobase::bvec(everywhere)

IllinoisGRMHD_prims_to_conservs (conditional)

  illinoisgrmhd_hybrid_entropy_prims_to_conservs

  entropy+hybrid version of illinoisgrmhd_prims_to_conservs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_conservatives
   ent_star
 Type: function
 Writes: u0(everywhere)
   grmhd_velocities(everywhere)
   grmhd_conservatives(everywhere)
   ent_star(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)

IllinoisGRMHD_conservs_to_prims (conditional)

  illinoisgrmhd_hybrid_entropy_conservs_to_prims

  entropy+hybrid version of illinoisgrmhd_conservs_to_prims

 

 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_conservatives
   ent_star
    grmhd_b_center
 Type: function
 Writes: grmhd_conservatives(everywhere)
   ent_star(everywhere)
   u0(everywhere)
   grmhd_velocities(everywhere)
   failure_checker(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)

IllinoisGRMHD_hydro_outer_boundaries (conditional)

  illinoisgrmhd_hybrid_entropy_hydro_outer_boundaries

  entropy+hybrid version of illinoisgrmhd_hydro_outer_boundaries

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_velocities
   hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
 Type: function
 Writes: u0(everywhere)
   grmhd_conservatives(everywhere)
   ent_star(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)

IllinoisGRMHD_evaluate_sources_rhs (conditional)

  illinoisgrmhd_hybrid_entropy_evaluate_sources_rhs

  entropy+hybrid version of illinoisgrmhd_evaluate_sources_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    admbase::curv
   hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives_rhs
   ent_star_rhs
   em_rhs

IllinoisGRMHD_evaluate_fluxes_rhs (conditional)

  illinoisgrmhd_hybrid_entropy_evaluate_fluxes_rhs

  entropy+hybrid version of illinoisgrmhd_evaluate_fluxes_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   grmhd_velocities
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
    ay
   az
   grmhd_conservatives_rhs(interior)
   ent_star_rhs(interior)
   em_rhs(interior)
 Type: function
 Writes: grmhd_flux_temps
   grmhd_conservatives_rhs
   ent_star_flux
   ent_star_rhs
   grmhd_primitives_reconstructed_temps
   grmhd_cmin_cmax_temps
   em_rhs

HydroBase_Prim2ConInitial (conditional)

  illinoisgrmhd_prim2con2prim

  convert hydrobase initial data to illinoisgrmhd variables

 

 Type:group

IllinoisGRMHD_perturb_primitives (conditional)

  illinoisgrmhd_hybrid_entropy_perturb_primitives

  entropy+hybrid version of illinoisgrmhd_perturb_primitives

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
   grmhd_velocities
   phitilde
   ax
    ay
   az
  Type: function
 Writes: hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy
   grmhd_velocities(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_perturb_conservatives (conditional)

  illinoisgrmhd_hybrid_entropy_perturb_conservatives

  entropy+hybrid version of illinoisgrmhd_perturb_conservatives

 

 Language:c
 Reads: grmhd_conservatives
   ent_star
  Type: function
 Writes: grmhd_conservatives(everywhere)
   ent_star(everywhere)

IllinoisGRMHD_prims_to_conservs (conditional)

  illinoisgrmhd_hybrid_prims_to_conservs

  hybrid version of illinoisgrmhd_prims_to_conservs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_conservatives
 Type: function
 Writes: u0(everywhere)
   grmhd_velocities(everywhere)
   grmhd_conservatives(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_conservs_to_prims (conditional)

  illinoisgrmhd_hybrid_conservs_to_prims

  hybrid version of illinoisgrmhd_conservs_to_prims

 

 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_conservatives
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives(everywhere)
   failure_checker(everywhere)
   u0(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_hydro_outer_boundaries (conditional)

  illinoisgrmhd_hybrid_hydro_outer_boundaries

  hybrid version of illinoisgrmhd_outer_boundaries

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_velocities
   hydrobase::rho
   hydrobase::press
   hydrobase::eps
 Type: function
 Writes: u0(everywhere)
   grmhd_conservatives(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_evaluate_sources_rhs (conditional)

  illinoisgrmhd_hybrid_evaluate_sources_rhs

  hybrid version of illinoisgrmhd_evaluate_sources_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    admbase::curv
   hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives_rhs
   em_rhs

IllinoisGRMHD_evaluate_fluxes_rhs (conditional)

  illinoisgrmhd_hybrid_evaluate_fluxes_rhs

  hybrid version of illinoisgrmhd_evaluate_fluxes_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
   ay
   az
   grmhd_conservatives_rhs(interior)
   em_rhs(interior)
 Type: function
 Writes: grmhd_flux_temps
   grmhd_conservatives_rhs
   grmhd_cmin_cmax_temps
   grmhd_primitives_reconstructed_temps
   em_rhs

IllinoisGRMHD_perturb_primitives (conditional)

  illinoisgrmhd_hybrid_perturb_primitives

  hybrid version of illinoisgrmhd_perturb_primitives

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   hydrobase::eps
   grmhd_velocities
   phitilde
   ax
    ay
   az
  Type: function
 Writes: hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   grmhd_velocities(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_perturb_conservatives (conditional)

  illinoisgrmhd_hybrid_perturb_conservatives

  hybrid version of illinoisgrmhd_perturb_conservatives

 

 Language:c
 Reads: grmhd_conservatives
 Type: function
 Writes: grmhd_conservatives(everywhere)

IllinoisGRMHD_prims_to_conservs (conditional)

  illinoisgrmhd_tabulated_entropy_prims_to_conservs

  entropy+tabulated version of illinoisgrmhd_prims_to_conservs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_conservatives
   ye_star
   ent_star
 Type: function
 Writes: u0(everywhere)
   grmhd_velocities(everywhere)
   grmhd_conservatives(everywhere)
   ent_star(everywhere)
   ye_star(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_Prim2Con2Prim (conditional)

  convert_hydrobase_to_illinoisgrmhd

  convert hydrobase initial data (id) to illinoisgrmhd variables

 

 Language:c
 Reads: admbase::lapse
   admbase::shift
    hydrobase::vel
   hydrobase::avec
   hydrobase::aphi
 Sync: grmhd_velocities
   ax
    ay
   az
   phitilde
 Type: function
 Writes: grmhd_velocities(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_conservs_to_prims (conditional)

  illinoisgrmhd_tabulated_entropy_conservs_to_prims

  entropy+tabulated version of illinoisgrmhd_conservs_to_prims

 

 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_conservatives
   ent_star
    ye_star
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives(everywhere)
   ent_star(everywhere)
   ye_star(everywhere)
   u0(everywhere)
   grmhd_velocities(everywhere)
   failure_checker(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_hydro_outer_boundaries (conditional)

  illinoisgrmhd_tabulated_entropy_hydro_outer_boundaries

  entropy+tabulated version of illinoisgrmhd_outer_boundaries

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_velocities
   hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
 Type: function
 Writes: u0(everywhere)
   grmhd_conservatives(everywhere)
   ent_star(everywhere)
   ye_star(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_evaluate_sources_rhs (conditional)

  illinoisgrmhd_tabulated_entropy_evaluate_sources_rhs

  entropy+tabulated version of illinoisgrmhd_evaluate_sources_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    admbase::curv
   hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives_rhs
   ent_star_rhs
   ye_star_rhs
   em_rhs

IllinoisGRMHD_evaluate_fluxes_rhs (conditional)

  illinoisgrmhd_tabulated_entropy_evaluate_fluxes_rhs

  entropy+tabulated version of illinoisgrmhd_evaluate_fluxes_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
    ay
   az
   grmhd_conservatives_rhs(interior)
   em_rhs(interior)
   ent_star_rhs(interior)
   ye_star_rhs(interior)
 Type: function
 Writes: grmhd_flux_temps
   ent_star_flux
   ye_star_flux
   grmhd_conservatives_rhs
   ent_star_rhs
   ye_star_rhs
   grmhd_cmin_cmax_temps
   grmhd_primitives_reconstructed_temps
   em_rhs

IllinoisGRMHD_perturb_primitives (conditional)

  illinoisgrmhd_tabulated_entropy_perturb_primitives

  entropy+tabulated version of illinoisgrmhd_perturb_primitives

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::entropy
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   phitilde
   ax
    ay
   az
  Type: function
 Writes: hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::entropy
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)
   grmhd_velocities(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_perturb_conservatives (conditional)

  illinoisgrmhd_tabulated_entropy_perturb_conservatives

  entropy+tabulated version of illinoisgrmhd_perturb_conservatives

 

 Language:c
 Reads: grmhd_conservatives
   ent_star
    ye_star
 Type: function
 Writes: grmhd_conservatives(everywhere)
   ent_star(everywhere)
   ye_star(everywhere)

IllinoisGRMHD_prims_to_conservs (conditional)

  illinoisgrmhd_tabulated_prims_to_conservs

  tabulated version of illinoisgrmhd_prims_to_conservs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_conservatives
   ye_star
 Type: function
 Writes: u0(everywhere)
   grmhd_velocities(everywhere)
   grmhd_conservatives(everywhere)
   ye_star(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_conservs_to_prims (conditional)

  illinoisgrmhd_tabulated_conservs_to_prims

  tabulated version of illinoisgrmhd_conservs_to_prims

 

 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_conservatives
   ye_star
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives(everywhere)
   ye_star(everywhere)
   u0(everywhere)
   grmhd_velocities(everywhere)
   failure_checker(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_hydro_outer_boundaries (conditional)

  illinoisgrmhd_tabulated_hydro_outer_boundaries

  tabulated version of illinoisgrmhd_outer_boundaries

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_velocities
   hydrobase::rho
   hydrobase::eps
   hydrobase::press
   hydrobase::y_e
   hydrobase::temperature
 Type: function
 Writes: u0(everywhere)
   grmhd_conservatives(everywhere)
   ye_star(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)

IllinoisGRMHD_evaluate_sources_rhs (conditional)

  illinoisgrmhd_tabulated_evaluate_sources_rhs

  tabulated version of illinoisgrmhd_evaluate_sources_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    admbase::curv
   hydrobase::rho
   hydrobase::press
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives_rhs
   ye_star_rhs
   em_rhs

IllinoisGRMHD_Prim2Con2Prim (conditional)

  illinoisgrmhd_perturb_primitives

  perturb initial primitive data

 

 After: convert_hydrobase_to_illinoisgrmhd
 Before:illinoisgrmhd_prims_to_conservs
 Type: group

IllinoisGRMHD_evaluate_fluxes_rhs (conditional)

  illinoisgrmhd_tabulated_evaluate_fluxes_rhs

  tabulated version of illinoisgrmhd_evaluate_fluxes_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
    ay
   az
   grmhd_conservatives_rhs(interior)
   ye_star_rhs(interior)
   em_rhs(interior)
 Type: function
 Writes: grmhd_flux_temps
   grmhd_conservatives_rhs
   ye_star_flux
   ye_star_rhs
   grmhd_primitives_reconstructed_temps
   grmhd_cmin_cmax_temps
   em_rhs

IllinoisGRMHD_perturb_primitives (conditional)

  illinoisgrmhd_tabulated_perturb_primitives

  tabulated version of illinoisgrmhd_perturb_primitives

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   hydrobase::eps
   hydrobase::y_e
   hydrobase::temperature
   grmhd_velocities
   phitilde
   ax
    ay
   az
  Type: function
 Writes: grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   hydrobase::y_e(everywhere)
   hydrobase::temperature(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_perturb_conservatives (conditional)

  illinoisgrmhd_tabulated_perturb_conservatives

  tabulated version of illinoisgrmhd_perturb_conservatives

 

 Language:c
 Reads: grmhd_conservatives
   ye_star
 Type: function
 Writes: grmhd_conservatives(everywhere)
   ye_star(everywhere)

CCTK_WRAGH (conditional)

  illinoisgrmhd_backward_compatible_initialize

  set up the grhayl structs and read the table for tabulated eos.

 

 Language:c
 Options: global
 Type: function

CCTK_POSTINITIAL (conditional)

  illinoisgrmhd_backward_compatible_data

  copy data to deprecated variables

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   phitilde
   grmhd_b_center
 Type: function
 Writes: grmhd_primitives_allbutbi
   psi6phi
   grmhd_primitives_bi

MoL_PostRHS (conditional)

  illinoisgrmhd_backward_compatible_data

  copy data to deprecated variables

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   phitilde
   grmhd_b_center
 Type: function
 Writes: grmhd_primitives_allbutbi
   psi6phi
   grmhd_primitives_bi

IllinoisGRMHD_Prim2Con2Prim (conditional)

  convert_illinoisgrmhd_to_hydrobase

  convert illinoisgrmhd-native variables to hydrobase

 

 After: illinoisgrmhd_conservs_to_prims
 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: hydrobase::vel(everywhere)
   hydrobase::w_lorentz(everywhere)
   hydrobase::bvec(everywhere)

CCTK_ANALYSIS (conditional)

  convert_illinoisgrmhd_to_hydrobase

  convert illinoisgrmhd-native variables to hydrobase

 

 After: ml_bssn_evolcalcgroup
 Before: compute_bi_b2_poyn_fluxet
   convert_to_mhd_3velocity
   particle_traceret
   volumeintegralgroup
 Language:c
 Options: global-early
   loop-local
 Reads: admbase::metric
   admbase::lapse
   admbase::shift
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: hydrobase::vel(everywhere)
   hydrobase::w_lorentz(everywhere)
   hydrobase::bvec(everywhere)

IllinoisGRMHD_prims_to_conservs (conditional)

  illinoisgrmhd_hybrid_prims_to_conservs

  hybrid version of illinoisgrmhd_prims_to_conservs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   hydrobase::eps
   grmhd_b_center
 Sync: grmhd_conservatives
 Type: function
 Writes: u0(everywhere)
   grmhd_velocities(everywhere)
   grmhd_conservatives(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_conservs_to_prims (conditional)

  illinoisgrmhd_hybrid_conservs_to_prims

  hybrid version of illinoisgrmhd_conservs_to_prims

 

 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_conservatives
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives(everywhere)
   failure_checker(everywhere)
   u0(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_Prim2Con2Prim (conditional)

  illinoisgrmhd_compute_b_and_bstagger_from_a

  compute b and b_stagger from a

 

 After: convert_hydrobase_to_illinoisgrmhd
 Language:c
 Reads: grid::coordinates
   admbase::metric
    admbase::lapse
   admbase::shift
    phitilde
   ax
    ay
   az
  Sync: grmhd_b_center
   grmhd_b_stagger
 Type: function
 Writes: phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)
   grmhd_b_center(everywhere)
   grmhd_b_stagger(everywhere)

IllinoisGRMHD_hydro_outer_boundaries (conditional)

  illinoisgrmhd_hybrid_hydro_outer_boundaries

  hybrid version of illinoisgrmhd_outer_boundaries

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
 Sync: grmhd_velocities
   hydrobase::rho
   hydrobase::press
   hydrobase::eps
 Type: function
 Writes: u0(everywhere)
   grmhd_conservatives(everywhere)
   grmhd_velocities(everywhere)
   hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)

IllinoisGRMHD_evaluate_sources_rhs (conditional)

  illinoisgrmhd_hybrid_evaluate_sources_rhs

  hybrid version of illinoisgrmhd_evaluate_sources_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    admbase::curv
   hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: grmhd_conservatives_rhs
   em_rhs

IllinoisGRMHD_evaluate_fluxes_rhs (conditional)

  illinoisgrmhd_hybrid_evaluate_fluxes_rhs

  hybrid version of illinoisgrmhd_evaluate_fluxes_rhs

 

 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    hydrobase::rho
   hydrobase::press
   grmhd_velocities
   grmhd_b_center
   grmhd_b_stagger
   phitilde
   ax
   ay
   az
   grmhd_conservatives_rhs(interior)
   em_rhs(interior)
 Type: function
 Writes: grmhd_flux_temps
   grmhd_conservatives_rhs
   grmhd_cmin_cmax_temps
   grmhd_primitives_reconstructed_temps
   em_rhs

IllinoisGRMHD_perturb_primitives (conditional)

  illinoisgrmhd_hybrid_perturb_primitives

  hybrid version of illinoisgrmhd_perturb_primitives

 

 Language:c
 Reads: hydrobase::rho
   hydrobase::press
   hydrobase::eps
   grmhd_velocities
   phitilde
   ax
    ay
   az
  Type: function
 Writes: hydrobase::rho(everywhere)
   hydrobase::press(everywhere)
   hydrobase::eps(everywhere)
   grmhd_velocities(everywhere)
   phitilde(everywhere)
   ax(everywhere)
   ay(everywhere)
   az(everywhere)

IllinoisGRMHD_perturb_conservatives (conditional)

  illinoisgrmhd_hybrid_perturb_conservatives

  hybrid version of illinoisgrmhd_perturb_conservatives

 

 Language:c
 Reads: grmhd_conservatives
 Type: function
 Writes: grmhd_conservatives(everywhere)

IllinoisGRMHD_Prim2Con2Prim (conditional)

  illinoisgrmhd_prims_to_conservs

  compute conservative variables from primitives

 

 After:illinoisgrmhd_compute_b_and_bstagger_from_a
 Type:group

IllinoisGRMHD_Prim2Con2Prim (conditional)

  illinoisgrmhd_conservs_to_prims

  compute primitive variables from conservatives

 

 After:illinoisgrmhd_prims_to_conservs
 Type:group

IllinoisGRMHD_Prim2Con2Prim (conditional)

  convert_illinoisgrmhd_to_hydrobase

  convert illinoisgrmhd-native variables to hydrobase

 

 After: illinoisgrmhd_conservs_to_prims
 Language:c
 Reads: admbase::metric
    admbase::lapse
   admbase::shift
    grmhd_velocities
   grmhd_b_center
 Type: function
 Writes: hydrobase::vel(everywhere)
   hydrobase::w_lorentz(everywhere)
   hydrobase::bvec(everywhere)

Aliased Functions

 

Alias Name:        Function Name:
IllinoisGRMHD_sync IllinoisGRMHD_sync_conservatives