Field List

This is a list of many of the fields available in yt. We have attempted to include most of the fields that are accessible through the plugin system, as well as the fields that are known by the frontends, however it is possible to generate many more permutations, particularly through vector operations. For more information about the fields framework, see Fields in yt.

Some fields are recognized by specific frontends only. These are typically fields like density and temperature that have their own names and units in the different frontend datasets. Often, these fields are aliased to their yt-named counterpart fields (typically ‘gas’ fieldtypes). For example, in the FLASH frontend, the dens field (i.e. (flash, dens)) is aliased to the gas field density (i.e. (gas, density)), similarly (flash, velx) is aliased to (gas, velocity_x), and so on. In what follows, if a field is aliased it will be noted.

Try using the ds.field_list and ds.derived_field_list to view the native and derived fields available for your dataset respectively. For example to display the native fields in alphabetical order:

To figure out out what all of the field types here mean, see Field types known to yt.

Universal Fields

(‘all’, ‘mesh_id’)

  • Sampling Method: particle

Field Source

def particle_mesh_ids(field, data):
    pos = data[ptype, coord_name]
    ids = np.zeros(pos.shape[0], dtype="float64") - 1
    # This is float64 in name only.  It will be properly cast inside the
    # deposit operation.
    # _ids = ids.view("float64")
    data.deposit(pos, [ids], method="mesh_id")
    return data.apply_units(ids, "")

(‘all’, ‘particle_angular_momentum’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum(field, data):
    am = (
        data[ptype, "particle_mass"]
        * data[ptype, "particle_specific_angular_momentum"].T
    )
    return am.T

(‘all’, ‘particle_angular_momentum_magnitude’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘all’, ‘particle_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘all’, ‘particle_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘all’, ‘particle_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘all’, ‘particle_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_ones’)

  • Sampling Method: particle

Field Source

def particle_ones(field, data):
    v = np.ones(data[ptype, coord_name].shape[0], dtype="float64")
    return data.apply_units(v, field.units)

(‘all’, ‘particle_position’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘all’, ‘particle_position_cylindrical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_r(pos, normal), "code_length")

(‘all’, ‘particle_position_cylindrical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_cyl_theta(pos, normal), "")

(‘all’, ‘particle_position_cylindrical_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_z(field, data):
    """The cylindrical z component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_z(pos, normal), "code_length")

(‘all’, ‘particle_position_relative_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘particle_position_relative_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘particle_position_relative_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘particle_position_spherical_phi’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_phi(field, data):
    """The spherical phi component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_phi(pos, normal), "")

(‘all’, ‘particle_position_spherical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘all’, ‘particle_position_spherical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_theta(field, data):
    """The spherical theta coordinate of the particle positions.

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_theta(pos, normal), "")

(‘all’, ‘particle_position_x’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_position_y’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_position_z’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_radial_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘all’, ‘particle_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘all’, ‘particle_specific_angular_momentum’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum(field, data):
    """Calculate the angular of a particle velocity.

    Returns a vector for each particle.
    """
    center = data.get_field_parameter("center")
    pos, vel, normal = get_angular_momentum_components(ptype, data, spos, svel)
    L, r_vec, v_vec = modify_reference_frame(center, normal, P=pos, V=vel)
    # adding in the unit registry allows us to have a reference to the
    # dataset and thus we will always get the correct units after applying
    # the cross product.
    return ucross(r_vec, v_vec, registry=data.ds.unit_registry)

(‘all’, ‘particle_specific_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘all’, ‘particle_specific_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘all’, ‘particle_specific_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘all’, ‘particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘all’, ‘particle_velocity_cylindrical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylr = get_cyl_r_component(vel, theta, normal)
    return cylr

(‘all’, ‘particle_velocity_cylindrical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylt = get_cyl_theta_component(vel, theta, normal)
    return cylt

(‘all’, ‘particle_velocity_cylindrical_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_z(field, data):
    """The cylindrical z component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vel = data[(ptype, "relative_particle_velocity")].T
    cylz = get_cyl_z_component(vel, normal)
    return cylz

(‘all’, ‘particle_velocity_magnitude’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_magnitude(field, data):
    """M{|v|}"""
    return np.sqrt(
        data[ptype, f"relative_{svel % 'x'}"] ** 2
        + data[ptype, f"relative_{svel % 'y'}"] ** 2
        + data[ptype, f"relative_{svel % 'z'}"] ** 2
    )

(‘all’, ‘particle_velocity_relative_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘all’, ‘particle_velocity_relative_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘all’, ‘particle_velocity_relative_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘all’, ‘particle_velocity_spherical_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_phi(field, data):
    """The spherical phi component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    phi = get_sph_phi(pos, normal)
    sphp = get_sph_phi_component(vel, phi, normal)
    return sphp

(‘all’, ‘particle_velocity_spherical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_radius(field, data):
    """The spherical radius component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    sphr = get_sph_r_component(vel, theta, phi, normal)
    return sphr

(‘all’, ‘particle_velocity_spherical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_theta(field, data):
    """The spherical theta component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    spht = get_sph_theta_component(vel, theta, phi, normal)
    return spht

(‘all’, ‘particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘all’, ‘relative_particle_position’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _relative_particle_position(field, data):
    """The cartesian particle positions in a rotated reference frame

    Relative to the coordinate system defined by *center* field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_position_{ax}") for ax in "xyz"]
    return obtain_position_vector(data, field_names=field_names).T

(‘all’, ‘relative_particle_position_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘relative_particle_position_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘relative_particle_position_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘all’, ‘relative_particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _relative_particle_velocity(field, data):
    """The vector particle velocities in an arbitrary coordinate system

    Relative to the coordinate system defined by the *bulk_velocity*
    vector field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_velocity_{ax}") for ax in "xyz"]
    return obtain_relative_velocity_vector(data, field_names=field_names).T

(‘all’, ‘relative_particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘all’, ‘relative_particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘all’, ‘relative_particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘deposit’, ‘all_cic’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_cic(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, [data[ptype, mass_name]], method="cic")
    d = data.apply_units(d, data[ptype, mass_name].units)
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘all_cic_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘all_cic_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘all_cic_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘all_count’)

  • Sampling Method: cell

Field Source

def particle_count(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, method="count")
    return data.apply_units(d, field.units)

(‘deposit’, ‘all_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_density(field, data):
    pos = data[ptype, coord_name]
    pos.convert_to_units("code_length")
    mass = data[ptype, mass_name]
    mass.convert_to_units("code_mass")
    d = data.deposit(pos, [mass], method="sum")
    d = data.ds.arr(d, "code_mass")
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘all_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: cell

Field Source

def particle_mass(field, data):
    pos = data[ptype, coord_name]
    pmass = data[ptype, mass_name]
    pmass.convert_to_units(field.units)
    d = data.deposit(pos, [pmass], method="sum")
    return data.apply_units(d, field.units)

(‘deposit’, ‘all_nn_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘all_nn_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘all_nn_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_cic’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_cic(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, [data[ptype, mass_name]], method="cic")
    d = data.apply_units(d, data[ptype, mass_name].units)
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘io_cic_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_cic_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_cic_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_count’)

  • Sampling Method: cell

Field Source

def particle_count(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, method="count")
    return data.apply_units(d, field.units)

(‘deposit’, ‘io_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_density(field, data):
    pos = data[ptype, coord_name]
    pos.convert_to_units("code_length")
    mass = data[ptype, mass_name]
    mass.convert_to_units("code_mass")
    d = data.deposit(pos, [mass], method="sum")
    d = data.ds.arr(d, "code_mass")
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘io_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: cell

Field Source

def particle_mass(field, data):
    pos = data[ptype, coord_name]
    pmass = data[ptype, mass_name]
    pmass.convert_to_units(field.units)
    d = data.deposit(pos, [pmass], method="sum")
    return data.apply_units(d, field.units)

(‘deposit’, ‘io_nn_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_nn_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘io_nn_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_cic’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_cic(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, [data[ptype, mass_name]], method="cic")
    d = data.apply_units(d, data[ptype, mass_name].units)
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘nbody_cic_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_cic_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_cic_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_count’)

  • Sampling Method: cell

Field Source

def particle_count(field, data):
    pos = data[ptype, coord_name]
    d = data.deposit(pos, method="count")
    return data.apply_units(d, field.units)

(‘deposit’, ‘nbody_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def particle_density(field, data):
    pos = data[ptype, coord_name]
    pos.convert_to_units("code_length")
    mass = data[ptype, mass_name]
    mass.convert_to_units("code_mass")
    d = data.deposit(pos, [mass], method="sum")
    d = data.ds.arr(d, "code_mass")
    d /= data["index", "cell_volume"]
    return d

(‘deposit’, ‘nbody_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: cell

Field Source

def particle_mass(field, data):
    pos = data[ptype, coord_name]
    pmass = data[ptype, mass_name]
    pmass.convert_to_units(field.units)
    d = data.deposit(pos, [pmass], method="sum")
    return data.apply_units(d, field.units)

(‘deposit’, ‘nbody_nn_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_nn_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘deposit’, ‘nbody_nn_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _deposit_field(field, data):
    """
    Create a grid field for particle quantities weighted by particle
    mass, using cloud-in-cell deposit.
    """
    pos = data[ptype, "particle_position"]
    # Get back into density
    pden = data[ptype, "particle_mass"]
    top = data.deposit(pos, [pden * data[(ptype, fname)]], method=method)
    bottom = data.deposit(pos, [pden], method=method)
    top[bottom == 0] = 0.0
    bnz = bottom.nonzero()
    top[bnz] /= bottom[bnz]
    d = data.ds.arr(top, units=units)
    return d

(‘gas’, ‘alfven_speed’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _alfven_speed(field, data):
    B = data[ftype, "magnetic_field_strength"]
    return B / np.sqrt(mag_factors(B.units.dimensions) * data[ftype, "density"])

(‘gas’, ‘angular_momentum_magnitude’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘angular_momentum_x’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _angular_momentum_x(field, data):
    return data[ftype, "mass"] * data[ftype, "specific_angular_momentum_x"]

(‘gas’, ‘angular_momentum_y’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _angular_momentum_y(field, data):
    return data[ftype, "mass"] * data[ftype, "specific_angular_momentum_y"]

(‘gas’, ‘angular_momentum_z’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _angular_momentum_z(field, data):
    return data[ftype, "mass"] * data[ftype, "specific_angular_momentum_z"]

(‘gas’, ‘averaged_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _averaged_field(field, data):
    def atleast_4d(array):
        if array.ndim == 3:
            return array[..., None]
        else:
            return array

    nx, ny, nz, ngrids = atleast_4d(data[(ftype, basename)]).shape
    new_field = data.ds.arr(
        np.zeros((nx - 2, ny - 2, nz - 2, ngrids), dtype=np.float64),
        (just_one(data[(ftype, basename)]) * just_one(data[(ftype, weight)])).units,
    )
    weight_field = data.ds.arr(
        np.zeros((nx - 2, ny - 2, nz - 2, ngrids), dtype=np.float64),
        data[(ftype, weight)].units,
    )
    i_i, j_i, k_i = np.mgrid[0:3, 0:3, 0:3]

    for i, j, k in zip(i_i.ravel(), j_i.ravel(), k_i.ravel()):
        sl = (
            slice(i, nx - (2 - i)),
            slice(j, ny - (2 - j)),
            slice(k, nz - (2 - k)),
        )
        new_field += (
            atleast_4d(data[(ftype, basename)])[sl]
            * atleast_4d(data[(ftype, weight)])[sl]
        )
        weight_field += atleast_4d(data[(ftype, weight)])[sl]

    # Now some fancy footwork
    new_field2 = data.ds.arr(
        np.zeros((nx, ny, nz, ngrids)), data[(ftype, basename)].units
    )
    new_field2[1:-1, 1:-1, 1:-1] = new_field / weight_field

    if data[(ftype, basename)].ndim == 3:
        return new_field2[..., 0]
    else:
        return new_field2

(‘gas’, ‘baroclinic_vorticity_magnitude’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘baroclinic_vorticity_x’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _baroclinic_vorticity_x(field, data):
    rho2 = data[ftype, "density"].astype("float64", copy=False) ** 2
    return (
        data[ftype, "pressure_gradient_y"] * data[ftype, "density_gradient_z"]
        - data[ftype, "pressure_gradient_z"] * data[ftype, "density_gradient_z"]
    ) / rho2

(‘gas’, ‘baroclinic_vorticity_y’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _baroclinic_vorticity_y(field, data):
    rho2 = data[ftype, "density"].astype("float64", copy=False) ** 2
    return (
        data[ftype, "pressure_gradient_z"] * data[ftype, "density_gradient_x"]
        - data[ftype, "pressure_gradient_x"] * data[ftype, "density_gradient_z"]
    ) / rho2

(‘gas’, ‘baroclinic_vorticity_z’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _baroclinic_vorticity_z(field, data):
    rho2 = data[ftype, "density"].astype("float64", copy=False) ** 2
    return (
        data[ftype, "pressure_gradient_x"] * data[ftype, "density_gradient_y"]
        - data[ftype, "pressure_gradient_y"] * data[ftype, "density_gradient_x"]
    ) / rho2

(‘gas’, ‘baryon_overdensity’)

  • Sampling Method: local

Field Source

def _baryon_overdensity(field, data):
    if (
        not hasattr(data.ds, "cosmological_simulation")
        or not data.ds.cosmological_simulation
    ):
        raise NeedsConfiguration("cosmological_simulation", 1)
    omega_baryon = data.get_field_parameter("omega_baryon")
    if omega_baryon is None:
        raise NeedsParameter("omega_baryon")
    co = data.ds.cosmology
    # critical_density(z) ~ omega_lambda + omega_matter * (1 + z)^3
    # mean matter density(z) ~ omega_matter * (1 + z)^3
    return (
        data[ftype, "density"]
        / omega_baryon
        / co.critical_density(0.0)
        / (1.0 + data.ds.current_redshift) ** 3
    )

(‘gas’, ‘cell_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: cell

Field Source

def _cell_mass(field, data):
    return data[ftype, "density"] * data[ftype, "cell_volume"]

(‘gas’, ‘cell_volume’)

  • Units: \(\rm{cm}^{3}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘courant_time_step’)

  • Units: \(\rm{s}\)

  • Sampling Method: cell

Field Source

def _courant_time_step(field, data):
    t1 = data[ftype, "dx"] / (
        data[ftype, "sound_speed"] + np.abs(data[ftype, "velocity_x"])
    )
    t2 = data[ftype, "dy"] / (
        data[ftype, "sound_speed"] + np.abs(data[ftype, "velocity_y"])
    )
    t3 = data[ftype, "dz"] / (
        data[ftype, "sound_speed"] + np.abs(data[ftype, "velocity_z"])
    )
    tr = np.minimum(np.minimum(t1, t2), t3)
    return tr

(‘gas’, ‘cutting_plane_magnetic_field_x’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘cutting_plane_magnetic_field_y’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘cutting_plane_magnetic_field_z’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘cutting_plane_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘cutting_plane_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘cutting_plane_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cp_val(field, data):
    vec = data.get_field_parameter(f"cp_{ax}_vec")
    tr = data[xn[0], f"relative_{xn[1]}"] * vec.d[0]
    tr += data[yn[0], f"relative_{yn[1]}"] * vec.d[1]
    tr += data[zn[0], f"relative_{zn[1]}"] * vec.d[2]
    return tr

(‘gas’, ‘dark_matter_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘density_gradient_magnitude’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{4}}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘density_gradient_x’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{4}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘density_gradient_y’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{4}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘density_gradient_z’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{4}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘di_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘dii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘dx’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘dy’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘dynamical_time’)

  • Units: \(\rm{s}\)

  • Sampling Method: local

Field Source

def _dynamical_time(field, data):
    """
    sqrt(3 pi / (16 G rho))
    """
    return np.sqrt(3.0 * np.pi / (16.0 * pc.G * data[ftype, "density"]))

(‘gas’, ‘dz’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘four_velocity_magnitude’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘four_velocity_t’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _four_velocity_t(field, data):
    return data["gas", "lorentz_factor"] * pc.clight

(‘gas’, ‘four_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _four_velocity(field, data):
    return data["gas", f"velocity_{u}"] * data["gas", "lorentz_factor"]

(‘gas’, ‘four_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _four_velocity(field, data):
    return data["gas", f"velocity_{u}"] * data["gas", "lorentz_factor"]

(‘gas’, ‘four_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _four_velocity(field, data):
    return data["gas", f"velocity_{u}"] * data["gas", "lorentz_factor"]

(‘gas’, ‘h2i_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘h2ii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘h2m_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘hdi_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘hei_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘heii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘heiii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘hi_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘hii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘jeans_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: local

Field Source

def _jeans_mass(field, data):
    MJ_constant = (((5.0 * pc.kboltz) / (pc.G * pc.mh)) ** 1.5) * (
        3.0 / (4.0 * np.pi)
    ) ** 0.5
    u = (
        MJ_constant
        * (
            (data[ftype, "temperature"] / data[ftype, "mean_molecular_weight"])
            ** 1.5
        )
        * (data[ftype, "density"] ** (-0.5))
    )
    return u

(‘gas’, ‘kT’)

  • Units: \(\rm{keV}\)

  • Sampling Method: local

Field Source

def _kT(field, data):
    return (pc.kboltz * data[ftype, "temperature"]).in_units("keV")

(‘gas’, ‘kinetic_energy_density’)

  • Units: \(\frac{\rm{dyn}}{\rm{cm}^{2}}\)

  • Sampling Method: local

Field Source

def _kinetic_energy_density(field, data):
    v = obtain_relative_velocity_vector(data)
    return 0.5 * data[ftype, "density"] * (v**2).sum(axis=0)

(‘gas’, ‘lorentz_factor’)

  • Sampling Method: local

Field Source

def _lorentz_factor(field, data):
    b2 = data[ftype, "velocity_magnitude"].to_value("c")
    b2 *= b2
    return 1.0 / np.sqrt(1.0 - b2)

(‘gas’, ‘mach_alfven’)

  • Units: :math:``

  • Sampling Method: local

Field Source

def _mach_alfven(field, data):
    return data[ftype, "velocity_magnitude"] / data[ftype, "alfven_speed"]

(‘gas’, ‘mach_number’)

  • Sampling Method: local

Field Source

def _mach_number(field, data):
    """M{|v|/c_sound}"""
    return data[ftype, "velocity_magnitude"] / data[ftype, "sound_speed"]

(‘gas’, ‘magnetic_energy_density’)

  • Units: \(\frac{\rm{dyn}}{\rm{cm}^{2}}\)

  • Sampling Method: local

Field Source

def _magnetic_energy_density(field, data):
    B = data[ftype, "magnetic_field_strength"]
    return 0.5 * B * B / mag_factors(B.units.dimensions)

(‘gas’, ‘magnetic_field_cylindrical_radius’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cylindrical_radius_component(field, data):
    """The cylindrical radius component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "cylindrical_theta"]
    return get_cyl_r_component(vectors, theta, normal)

(‘gas’, ‘magnetic_field_cylindrical_theta’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cylindrical_theta_component(field, data):
    """The cylindrical theta component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "cylindrical_theta"].copy()
    theta = np.tile(theta, (3,) + (1,) * len(theta.shape))
    return get_cyl_theta_component(vectors, theta, normal)

(‘gas’, ‘magnetic_field_cylindrical_z’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _cylindrical_z_component(field, data):
    """The cylindrical z component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    return get_cyl_z_component(vectors, normal)

(‘gas’, ‘magnetic_field_divergence’)

  • Units: \(\frac{\sqrt{\rm{g}}}{\rm{cm}^{3/2} \cdot \rm{s}}\)

  • Sampling Method: local

Field Source

def _divergence(field, data):
    ds = div_fac * just_one(data["index", "dx"])
    f = data[xn[0], f"relative_{xn[1]}"][sl_right, 1:-1, 1:-1] / ds
    f -= data[xn[0], f"relative_{xn[1]}"][sl_left, 1:-1, 1:-1] / ds
    ds = div_fac * just_one(data["index", "dy"])
    f += data[yn[0], f"relative_{yn[1]}"][1:-1, sl_right, 1:-1] / ds
    f -= data[yn[0], f"relative_{yn[1]}"][1:-1, sl_left, 1:-1] / ds
    ds = div_fac * just_one(data["index", "dz"])
    f += data[zn[0], f"relative_{zn[1]}"][1:-1, 1:-1, sl_right] / ds
    f -= data[zn[0], f"relative_{zn[1]}"][1:-1, 1:-1, sl_left] / ds
    new_field = data.ds.arr(np.zeros(data[xn].shape, dtype=np.float64), f.units)
    new_field[1:-1, 1:-1, 1:-1] = f
    return new_field

(‘gas’, ‘magnetic_field_divergence_absolute’)

  • Units: \(\frac{\sqrt{\rm{g}}}{\rm{cm}^{3/2} \cdot \rm{s}}\)

  • Sampling Method: local

Field Source

def _divergence_abs(field, data):
    return np.abs(data[ftype, f"{basename}_divergence"])

(‘gas’, ‘magnetic_field_los’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _los_field(field, data):
    if data.has_field_parameter(f"bulk_{basename}"):
        fns = [(fc[0], f"relative_{fc[1]}") for fc in field_comps]
    else:
        fns = field_comps
    ax = data.get_field_parameter("axis")
    if is_sequence(ax):
        # Make sure this is a unit vector
        ax /= np.sqrt(np.dot(ax, ax))
        ret = data[fns[0]] * ax[0] + data[fns[1]] * ax[1] + data[fns[2]] * ax[2]
    elif ax in [0, 1, 2]:
        ret = data[fns[ax]]
    else:
        raise NeedsParameter(["axis"])
    return ret

(‘gas’, ‘magnetic_field_magnitude’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘magnetic_field_poloidal’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _DeprecatedFieldFunc(field, data):
    # Only log a warning if we've already done
    # field detection
    if data.ds.fields_detected:
        args = [field.name, since]
        msg = "The Derived Field %s is deprecated as of yt v%s "
        if removal is not None:
            msg += "and will be removed in yt v%s "
            args.append(removal)
        if ret_field != field.name:
            msg += ", use %s instead"
            args.append(ret_field)
        mylog.warning(msg, *args)
    return func(field, data)

(‘gas’, ‘magnetic_field_poloidal_magnitude’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _magnetic_field_poloidal_magnitude(field, data):
    B2 = (
        data[ftype, "relative_magnetic_field_x"]
        * data[ftype, "relative_magnetic_field_x"]
        + data[ftype, "relative_magnetic_field_y"]
        * data[ftype, "relative_magnetic_field_y"]
        + data[ftype, "relative_magnetic_field_z"]
        * data[ftype, "relative_magnetic_field_z"]
    )
    Bt2 = (
        data[ftype, "magnetic_field_spherical_phi"]
        * data[ftype, "magnetic_field_spherical_phi"]
    )
    return np.sqrt(B2 - Bt2)

(‘gas’, ‘magnetic_field_spherical_phi’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _spherical_phi_component(field, data):
    """The spherical phi component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    phi = data["index", "spherical_phi"]
    return get_sph_phi_component(vectors, phi, normal)

(‘gas’, ‘magnetic_field_spherical_radius’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _spherical_radius_component(field, data):
    """The spherical radius component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "spherical_theta"]
    phi = data["index", "spherical_phi"]
    rv = get_sph_r_component(vectors, theta, phi, normal)
    # Now, anywhere that radius is in fact zero, we want to zero out our
    # return values.
    rv[np.isnan(theta)] = 0.0
    return rv

(‘gas’, ‘magnetic_field_spherical_theta’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _spherical_theta_component(field, data):
    """The spherical theta component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "spherical_theta"]
    phi = data["index", "spherical_phi"]
    return get_sph_theta_component(vectors, theta, phi, normal)

(‘gas’, ‘magnetic_field_strength’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _magnetic_field_strength(field, data):
    xm = f"relative_magnetic_field_{axis_names[0]}"
    ym = f"relative_magnetic_field_{axis_names[1]}"
    zm = f"relative_magnetic_field_{axis_names[2]}"

    B2 = (data[ftype, xm]) ** 2 + (data[ftype, ym]) ** 2 + (data[ftype, zm]) ** 2

    return np.sqrt(B2)

(‘gas’, ‘magnetic_field_toroidal’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _DeprecatedFieldFunc(field, data):
    # Only log a warning if we've already done
    # field detection
    if data.ds.fields_detected:
        args = [field.name, since]
        msg = "The Derived Field %s is deprecated as of yt v%s "
        if removal is not None:
            msg += "and will be removed in yt v%s "
            args.append(removal)
        if ret_field != field.name:
            msg += ", use %s instead"
            args.append(ret_field)
        mylog.warning(msg, *args)
    return func(field, data)

(‘gas’, ‘magnetic_field_toroidal_magnitude’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘magnetic_field_x’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _mag_field(field, data):
    return data[fd].to(field.units)

(‘gas’, ‘magnetic_field_y’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _mag_field(field, data):
    return data[fd].to(field.units)

(‘gas’, ‘magnetic_field_z’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _mag_field(field, data):
    return data[fd].to(field.units)

(‘gas’, ‘magnetic_pressure’)

  • Units: \(\frac{\rm{dyn}}{\rm{cm}^{2}}\)

  • Sampling Method: local

Field Source

def _magnetic_pressure(field, data):
    return data[ftype, "magnetic_energy_density"]

(‘gas’, ‘mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘matter_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: local

Field Source

def _matter_density(field, data):
    return data[ftype, "density"] + data[ftype, "dark_matter_density"]

(‘gas’, ‘matter_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: local

Field Source

def _matter_mass(field, data):
    return data[ftype, "matter_density"] * data["index", "cell_volume"]

(‘gas’, ‘matter_overdensity’)

  • Sampling Method: local

Field Source

def _matter_overdensity(field, data):
    if (
        not hasattr(data.ds, "cosmological_simulation")
        or not data.ds.cosmological_simulation
    ):
        raise NeedsConfiguration("cosmological_simulation", 1)
    co = data.ds.cosmology
    # critical_density(z) ~ omega_lambda + omega_matter * (1 + z)^3
    # mean density(z) ~ omega_matter * (1 + z)^3
    return (
        data[ftype, "matter_density"]
        / data.ds.omega_matter
        / co.critical_density(0.0)
        / (1.0 + data.ds.current_redshift) ** 3
    )

(‘gas’, ‘mean_molecular_weight’)

  • Sampling Method: local

Field Source

def _mean_molecular_weight(field, data):
    return data[ftype, "density"] / (pc.mh * data[ftype, "number_density"])

(‘gas’, ‘metal_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘metal_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: local

Field Source

def _metal_mass(field, data):
    Z = data[ftype, "metallicity"].to("dimensionless")
    return Z * data[ftype, "mass"]

(‘gas’, ‘metallicity’)

  • Units: \(\rm{Z}_\odot\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘momentum_density_x’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}\)

  • Sampling Method: local

Field Source

def _momd(field, data):
    return data["gas", "density"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘momentum_density_y’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}\)

  • Sampling Method: local

Field Source

def _momd(field, data):
    return data["gas", "density"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘momentum_density_z’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}\)

  • Sampling Method: local

Field Source

def _momd(field, data):
    return data["gas", "density"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘momentum_x’)

  • Units: \(\rm{cm} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _momm(field, data):
    return data["gas", "mass"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘momentum_y’)

  • Units: \(\rm{cm} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _momm(field, data):
    return data["gas", "mass"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘momentum_z’)

  • Units: \(\rm{cm} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: local

Field Source

def _momm(field, data):
    return data["gas", "mass"] * data["gas", f"velocity_{v}"]

(‘gas’, ‘number_density’)

  • Units: \(\frac{1}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘overdensity’)

  • Sampling Method: local

Field Source

def _overdensity(field, data):
    if (
        not hasattr(data.ds, "cosmological_simulation")
        or not data.ds.cosmological_simulation
    ):
        raise NeedsConfiguration("cosmological_simulation", 1)
    co = data.ds.cosmology
    return data[ftype, "matter_density"] / co.critical_density(
        data.ds.current_redshift
    )

(‘gas’, ‘path_element_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘path_element_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘path_element_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘plasma_beta’)

  • Sampling Method: local

Field Source

def _plasma_beta(field, data):
    return data[ftype, "pressure"] / data[ftype, "magnetic_energy_density"]

(‘gas’, ‘pressure’)

  • Units: \(\frac{\rm{dyn}}{\rm{cm}^{2}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘pressure_gradient_magnitude’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘pressure_gradient_x’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘pressure_gradient_y’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘pressure_gradient_z’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def func(field, data):
    block_order = getattr(data, "_block_order", "C")
    if block_order == "F":
        # Fortran-ordering: we need to swap axes here and
        # reswap below
        field_data = data[grad_field].swapaxes(0, 2)
    else:
        field_data = data[grad_field]
    dx = div_fac * data[ftype, f"d{ax}"]
    if ax == "theta":
        dx *= data[ftype, "r"]
    if ax == "phi":
        dx *= data[ftype, "r"] * np.sin(data[ftype, "theta"])
    f = field_data[slice_3dr] / dx[slice_3d]
    f -= field_data[slice_3dl] / dx[slice_3d]
    new_field = np.zeros_like(data[grad_field], dtype=np.float64)
    new_field = data.ds.arr(new_field, field_data.units / dx.units)
    new_field[slice_3d] = f

    if block_order == "F":
        new_field = new_field.swapaxes(0, 2)

    return new_field

(‘gas’, ‘radial_mach_number’)

  • Sampling Method: local

Field Source

def _radial_mach_number(field, data):
    """Radial component of M{|v|/c_sound}"""
    tr = data[ftype, "radial_velocity"] / data[ftype, "sound_speed"]
    return np.abs(tr)

(‘gas’, ‘radial_magnetic_field’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _radial(field, data):
    return data[ftype, f"{basename}_spherical_radius"]

(‘gas’, ‘radial_magnetic_field_absolute’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _radial_absolute(field, data):
    return np.abs(data[ftype, f"{basename}_spherical_radius"])

(‘gas’, ‘radial_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _radial(field, data):
    return data[ftype, f"{basename}_spherical_radius"]

(‘gas’, ‘radial_velocity_absolute’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _radial_absolute(field, data):
    return np.abs(data[ftype, f"{basename}_spherical_radius"])

(‘gas’, ‘radiation_acceleration_x’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘radiation_acceleration_y’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘radiation_acceleration_z’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘relative_magnetic_field_x’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘relative_magnetic_field_y’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘relative_magnetic_field_z’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘relative_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘relative_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘relative_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _relative_vector(field, data):
    iax = axis_order.index(ax)
    d = data[field_components[iax]]
    bulk = get_bulk(data, basename, d.unit_quantity)
    return d - bulk[iax]

(‘gas’, ‘shear’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: cell

Field Source

def _shear(field, data):
    """
    Shear is defined as [(dvx/dy + dvy/dx)^2 + (dvz/dy + dvy/dz)^2 +
                         (dvx/dz + dvz/dx)^2 ]^(0.5)
    where dvx/dy = [vx(j-1) - vx(j+1)]/[2dy]
    and is in units of s^(-1)
    (it's just like vorticity except add the derivative pairs instead
     of subtracting them)
    """

    if data.ds.geometry != "cartesian":
        raise NotImplementedError("shear is only supported in cartesian geometries")

    try:
        vx = data[ftype, "relative_velocity_x"]
        vy = data[ftype, "relative_velocity_y"]
    except YTFieldNotFound as e:
        raise YTDimensionalityError(
            "shear computation requires 2 velocity components"
        ) from e

    dvydx = (
        vy[sl_right, sl_center, sl_center] - vy[sl_left, sl_center, sl_center]
    ) / (div_fac * just_one(data["index", "dx"]))
    dvxdy = (
        vx[sl_center, sl_right, sl_center] - vx[sl_center, sl_left, sl_center]
    ) / (div_fac * just_one(data["index", "dy"]))
    f = (dvydx + dvxdy) ** 2.0
    del dvydx, dvxdy

    try:
        vz = data[ftype, "relative_velocity_z"]
        dvzdy = (
            vz[sl_center, sl_right, sl_center] - vz[sl_center, sl_left, sl_center]
        ) / (div_fac * just_one(data["index", "dy"]))
        dvydz = (
            vy[sl_center, sl_center, sl_right] - vy[sl_center, sl_center, sl_left]
        ) / (div_fac * just_one(data["index", "dz"]))
        f += (dvzdy + dvydz) ** 2.0
        del dvzdy, dvydz
        dvxdz = (
            vx[sl_center, sl_center, sl_right] - vx[sl_center, sl_center, sl_left]
        ) / (div_fac * just_one(data["index", "dz"]))
        dvzdx = (
            vz[sl_right, sl_center, sl_center] - vz[sl_left, sl_center, sl_center]
        ) / (div_fac * just_one(data["index", "dx"]))
        f += (dvxdz + dvzdx) ** 2.0
        del dvxdz, dvzdx
    except YTFieldNotFound:
        # the absence of a z velocity component is not blocking
        pass

    np.sqrt(f, out=f)
    new_field = data.ds.arr(np.zeros_like(data[ftype, "velocity_x"]), f.units)
    new_field[sl_center, sl_center, sl_center] = f
    return new_field

(‘gas’, ‘shear_criterion’)

  • Units: \(1 / \rm{cm}\)

  • Sampling Method: cell

Field Source

def _shear_criterion(field, data):
    """
    Divide by c_s to leave shear in units of length**-1, which
    can be compared against the inverse of the local cell size (1/dx)
    to determine if refinement should occur.
    """
    return data[ftype, "shear"] / data[ftype, "sound_speed"]

(‘gas’, ‘shear_mach’)

  • Sampling Method: cell

Field Source

def _shear_mach(field, data):
    """
    Dimensionless shear (shear_mach) is defined nearly the same as shear,
    except that it is scaled by the local dx/dy/dz and the local sound speed.
    So it results in a unitless quantity that is effectively measuring
    shear in mach number.

    In order to avoid discontinuities created by multiplying by dx/dy/dz at
    grid refinement boundaries, we also multiply by 2**GridLevel.

    Shear (Mach) = [(dvx + dvy)^2 + (dvz + dvy)^2 +
                    (dvx + dvz)^2  ]^(0.5) / c_sound
    """

    if data.ds.geometry != "cartesian":
        raise NotImplementedError(
            "shear_mach is only supported in cartesian geometries"
        )

    try:
        vx = data[ftype, "relative_velocity_x"]
        vy = data[ftype, "relative_velocity_y"]
    except YTFieldNotFound as e:
        raise YTDimensionalityError(
            "shear_mach computation requires 2 velocity components"
        ) from e
    dvydx = (
        vy[sl_right, sl_center, sl_center] - vy[sl_left, sl_center, sl_center]
    ) / div_fac
    dvxdy = (
        vx[sl_center, sl_right, sl_center] - vx[sl_center, sl_left, sl_center]
    ) / div_fac
    f = (dvydx + dvxdy) ** 2.0
    del dvydx, dvxdy
    try:
        vz = data[ftype, "relative_velocity_z"]
        dvzdy = (
            vz[sl_center, sl_right, sl_center] - vz[sl_center, sl_left, sl_center]
        ) / div_fac
        dvydz = (
            vy[sl_center, sl_center, sl_right] - vy[sl_center, sl_center, sl_left]
        ) / div_fac
        f += (dvzdy + dvydz) ** 2.0
        del dvzdy, dvydz
        dvxdz = (
            vx[sl_center, sl_center, sl_right] - vx[sl_center, sl_center, sl_left]
        ) / div_fac
        dvzdx = (
            vz[sl_right, sl_center, sl_center] - vz[sl_left, sl_center, sl_center]
        ) / div_fac
        f += (dvxdz + dvzdx) ** 2.0
        del dvxdz, dvzdx
    except YTFieldNotFound:
        # the absence of a z velocity component is not blocking
        pass
    f *= (
        2.0 ** data["index", "grid_level"][sl_center, sl_center, sl_center]
        / data[ftype, "sound_speed"][sl_center, sl_center, sl_center]
    ) ** 2.0
    np.sqrt(f, out=f)
    new_field = data.ds.arr(np.zeros_like(vx), f.units)
    new_field[sl_center, sl_center, sl_center] = f
    return new_field

(‘gas’, ‘sound_speed’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _sound_speed(field, data):
    tr = data.ds.gamma * data[ftype, "pressure"] / data[ftype, "density"]
    return np.sqrt(tr)

(‘gas’, ‘specific_angular_momentum_magnitude’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘specific_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: local

Field Source

def _specific_angular_momentum_x(field, data):
    xv, yv, zv = obtain_relative_velocity_vector(data)
    rv = obtain_position_vector(data)
    units = rv.units
    rv = np.rollaxis(rv, 0, len(rv.shape))
    rv = data.ds.arr(rv, units=units)
    return rv[..., 1] * zv - rv[..., 2] * yv

(‘gas’, ‘specific_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: local

Field Source

def _specific_angular_momentum_y(field, data):
    xv, yv, zv = obtain_relative_velocity_vector(data)
    rv = obtain_position_vector(data)
    units = rv.units
    rv = np.rollaxis(rv, 0, len(rv.shape))
    rv = data.ds.arr(rv, units=units)
    return rv[..., 2] * xv - rv[..., 0] * zv

(‘gas’, ‘specific_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: local

Field Source

def _specific_angular_momentum_z(field, data):
    xv, yv, zv = obtain_relative_velocity_vector(data)
    rv = obtain_position_vector(data)
    units = rv.units
    rv = np.rollaxis(rv, 0, len(rv.shape))
    rv = data.ds.arr(rv, units=units)
    return rv[..., 0] * yv - rv[..., 1] * xv

(‘gas’, ‘specific_thermal_energy’)

  • Units: \(\rm{erg} / \rm{g}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘tangential_magnetic_field’)

  • Units: \(\rm{G}\)

  • Sampling Method: local

Field Source

def _tangential(field, data):
    return np.sqrt(
        data[ftype, f"{basename}_spherical_theta"] ** 2.0
        + data[ftype, f"{basename}_spherical_phi"] ** 2.0
    )

(‘gas’, ‘tangential_over_magnetic_field_magnitude’)

  • Sampling Method: local

Field Source

def _tangential_over_magnitude(field, data):
    tr = (
        data[ftype, f"tangential_{basename}"]
        / data[ftype, f"{basename}_magnitude"]
    )
    return np.abs(tr)

(‘gas’, ‘tangential_over_velocity_magnitude’)

  • Sampling Method: local

Field Source

def _tangential_over_magnitude(field, data):
    tr = (
        data[ftype, f"tangential_{basename}"]
        / data[ftype, f"{basename}_magnitude"]
    )
    return np.abs(tr)

(‘gas’, ‘tangential_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _tangential(field, data):
    return np.sqrt(
        data[ftype, f"{basename}_spherical_theta"] ** 2.0
        + data[ftype, f"{basename}_spherical_phi"] ** 2.0
    )

(‘gas’, ‘temperature’)

  • Units: \(\rm{K}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_cylindrical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cylindrical_radius_component(field, data):
    """The cylindrical radius component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "cylindrical_theta"]
    return get_cyl_r_component(vectors, theta, normal)

(‘gas’, ‘velocity_cylindrical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cylindrical_theta_component(field, data):
    """The cylindrical theta component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "cylindrical_theta"].copy()
    theta = np.tile(theta, (3,) + (1,) * len(theta.shape))
    return get_cyl_theta_component(vectors, theta, normal)

(‘gas’, ‘velocity_cylindrical_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _cylindrical_z_component(field, data):
    """The cylindrical z component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    return get_cyl_z_component(vectors, normal)

(‘gas’, ‘velocity_divergence’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: local

Field Source

def _divergence(field, data):
    ds = div_fac * just_one(data["index", "dx"])
    f = data[xn[0], f"relative_{xn[1]}"][sl_right, 1:-1, 1:-1] / ds
    f -= data[xn[0], f"relative_{xn[1]}"][sl_left, 1:-1, 1:-1] / ds
    ds = div_fac * just_one(data["index", "dy"])
    f += data[yn[0], f"relative_{yn[1]}"][1:-1, sl_right, 1:-1] / ds
    f -= data[yn[0], f"relative_{yn[1]}"][1:-1, sl_left, 1:-1] / ds
    ds = div_fac * just_one(data["index", "dz"])
    f += data[zn[0], f"relative_{zn[1]}"][1:-1, 1:-1, sl_right] / ds
    f -= data[zn[0], f"relative_{zn[1]}"][1:-1, 1:-1, sl_left] / ds
    new_field = data.ds.arr(np.zeros(data[xn].shape, dtype=np.float64), f.units)
    new_field[1:-1, 1:-1, 1:-1] = f
    return new_field

(‘gas’, ‘velocity_divergence_absolute’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: local

Field Source

def _divergence_abs(field, data):
    return np.abs(data[ftype, f"{basename}_divergence"])

(‘gas’, ‘velocity_los’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _los_field(field, data):
    if data.has_field_parameter(f"bulk_{basename}"):
        fns = [(fc[0], f"relative_{fc[1]}") for fc in field_comps]
    else:
        fns = field_comps
    ax = data.get_field_parameter("axis")
    if is_sequence(ax):
        # Make sure this is a unit vector
        ax /= np.sqrt(np.dot(ax, ax))
        ret = data[fns[0]] * ax[0] + data[fns[1]] * ax[1] + data[fns[2]] * ax[2]
    elif ax in [0, 1, 2]:
        ret = data[fns[ax]]
    else:
        raise NeedsParameter(["axis"])
    return ret

(‘gas’, ‘velocity_magnitude’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘velocity_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_r’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_spherical_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _spherical_phi_component(field, data):
    """The spherical phi component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    phi = data["index", "spherical_phi"]
    return get_sph_phi_component(vectors, phi, normal)

(‘gas’, ‘velocity_spherical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _spherical_radius_component(field, data):
    """The spherical radius component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "spherical_theta"]
    phi = data["index", "spherical_phi"]
    rv = get_sph_r_component(vectors, theta, phi, normal)
    # Now, anywhere that radius is in fact zero, we want to zero out our
    # return values.
    rv[np.isnan(theta)] = 0.0
    return rv

(‘gas’, ‘velocity_spherical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: local

Field Source

def _spherical_theta_component(field, data):
    """The spherical theta component of the vector field

    Relative to the coordinate system defined by the *normal* vector,
    *center*, and *bulk_* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vectors = obtain_relative_velocity_vector(
        data, (xn, yn, zn), f"bulk_{basename}"
    )
    theta = data["index", "spherical_theta"]
    phi = data["index", "spherical_phi"]
    return get_sph_theta_component(vectors, theta, phi, normal)

(‘gas’, ‘velocity_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘vertex_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘vertex_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘vertex_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘volume’)

  • Units: \(\rm{cm}^{3}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘vorticity_growth_magnitude’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_magnitude(field, data):
    result = np.sqrt(
        data[ftype, "vorticity_growth_x"] ** 2
        + data[ftype, "vorticity_growth_y"] ** 2
        + data[ftype, "vorticity_growth_z"] ** 2
    )
    dot = data.ds.arr(np.zeros(result.shape), "")
    for ax in "xyz":
        dot += (
            data[ftype, f"vorticity_{ax}"] * data[ftype, f"vorticity_growth_{ax}"]
        ).to_ndarray()
    result = np.sign(dot) * result
    return result

(‘gas’, ‘vorticity_growth_magnitude_absolute’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_magnitude_absolute(field, data):
    return np.sqrt(
        data[ftype, "vorticity_growth_x"] ** 2
        + data[ftype, "vorticity_growth_y"] ** 2
        + data[ftype, "vorticity_growth_z"] ** 2
    )

(‘gas’, ‘vorticity_growth_timescale’)

  • Units: \(\rm{s}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_timescale(field, data):
    domegax_dt = data[ftype, "vorticity_x"] / data[ftype, "vorticity_growth_x"]
    domegay_dt = data[ftype, "vorticity_y"] / data[ftype, "vorticity_growth_y"]
    domegaz_dt = data[ftype, "vorticity_z"] / data[ftype, "vorticity_growth_z"]
    return np.sqrt(domegax_dt**2 + domegay_dt**2 + domegaz_dt**2)

(‘gas’, ‘vorticity_growth_x’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_x(field, data):
    return (
        -data[ftype, "vorticity_stretching_x"]
        - data[ftype, "baroclinic_vorticity_x"]
    )

(‘gas’, ‘vorticity_growth_y’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_y(field, data):
    return (
        -data[ftype, "vorticity_stretching_y"]
        - data[ftype, "baroclinic_vorticity_y"]
    )

(‘gas’, ‘vorticity_growth_z’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_growth_z(field, data):
    return (
        -data[ftype, "vorticity_stretching_z"]
        - data[ftype, "baroclinic_vorticity_z"]
    )

(‘gas’, ‘vorticity_magnitude’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘vorticity_radiation_pressure_growth_magnitude’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_magnitude(field, data):
    result = np.sqrt(
        data[ftype, "vorticity_radiation_pressure_growth_x"] ** 2
        + data[ftype, "vorticity_radiation_pressure_growth_y"] ** 2
        + data[ftype, "vorticity_radiation_pressure_growth_z"] ** 2
    )
    dot = data.ds.arr(np.zeros(result.shape), "")
    for ax in "xyz":
        dot += (
            data[ftype, f"vorticity_{ax}"] * data[ftype, f"vorticity_growth_{ax}"]
        ).to_ndarray()
    result = np.sign(dot) * result
    return result

(‘gas’, ‘vorticity_radiation_pressure_growth_magnitude_absolute’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_magnitude_absolute(field, data):
    return np.sqrt(
        data[ftype, "vorticity_radiation_pressure_growth_x"] ** 2
        + data[ftype, "vorticity_radiation_pressure_growth_y"] ** 2
        + data[ftype, "vorticity_radiation_pressure_growth_z"] ** 2
    )

(‘gas’, ‘vorticity_radiation_pressure_growth_timescale’)

  • Units: \(\rm{s}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_timescale(field, data):
    domegax_dt = (
        data[ftype, "vorticity_x"]
        / data[ftype, "vorticity_radiation_pressure_growth_x"]
    )
    domegay_dt = (
        data[ftype, "vorticity_y"]
        / data[ftype, "vorticity_radiation_pressure_growth_y"]
    )
    domegaz_dt = (
        data[ftype, "vorticity_z"]
        / data[ftype, "vorticity_radiation_pressure_growth_z"]
    )
    return np.sqrt(domegax_dt**2 + domegay_dt**2 + domegaz_dt**2)

(‘gas’, ‘vorticity_radiation_pressure_growth_x’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_x(field, data):
    return (
        -data[ftype, "vorticity_stretching_x"]
        - data[ftype, "baroclinic_vorticity_x"]
        - data[ftype, "vorticity_radiation_pressure_x"]
    )

(‘gas’, ‘vorticity_radiation_pressure_growth_y’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_y(field, data):
    return (
        -data[ftype, "vorticity_stretching_y"]
        - data[ftype, "baroclinic_vorticity_y"]
        - data[ftype, "vorticity_radiation_pressure_y"]
    )

(‘gas’, ‘vorticity_radiation_pressure_growth_z’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_growth_z(field, data):
    return (
        -data[ftype, "vorticity_stretching_z"]
        - data[ftype, "baroclinic_vorticity_z"]
        - data[ftype, "vorticity_radiation_pressure_z"]
    )

(‘gas’, ‘vorticity_radiation_pressure_magnitude’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘vorticity_radiation_pressure_x’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_x(field, data):
    rho = data[ftype, "density"].astype("float64", copy=False)
    return (
        data[ftype, "radiation_acceleration_y"] * data[ftype, "density_gradient_z"]
        - data[ftype, "radiation_acceleration_z"]
        * data[ftype, "density_gradient_y"]
    ) / rho

(‘gas’, ‘vorticity_radiation_pressure_y’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_y(field, data):
    rho = data[ftype, "density"].astype("float64", copy=False)
    return (
        data[ftype, "radiation_acceleration_z"] * data[ftype, "density_gradient_x"]
        - data[ftype, "radiation_acceleration_x"]
        * data[ftype, "density_gradient_z"]
    ) / rho

(‘gas’, ‘vorticity_radiation_pressure_z’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_radiation_pressure_z(field, data):
    rho = data[ftype, "density"].astype("float64", copy=False)
    return (
        data[ftype, "radiation_acceleration_x"] * data[ftype, "density_gradient_y"]
        - data[ftype, "radiation_acceleration_y"]
        * data[ftype, "density_gradient_x"]
    ) / rho

(‘gas’, ‘vorticity_squared’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def _squared(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    squared = data[fn] * data[fn]
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        squared += data[fn] * data[fn]
    return squared

(‘gas’, ‘vorticity_stretching_magnitude’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: local

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘gas’, ‘vorticity_stretching_x’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_stretching_x(field, data):
    return data[ftype, "velocity_divergence"] * data[ftype, "vorticity_x"]

(‘gas’, ‘vorticity_stretching_y’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_stretching_y(field, data):
    return data[ftype, "velocity_divergence"] * data[ftype, "vorticity_y"]

(‘gas’, ‘vorticity_stretching_z’)

  • Units: \(\frac{1}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

def _vorticity_stretching_z(field, data):
    return data[ftype, "velocity_divergence"] * data[ftype, "vorticity_z"]

(‘gas’, ‘vorticity_x’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: cell

Field Source

def _vorticity_x(field, data):
    vz = data[ftype, "relative_velocity_z"]
    vy = data[ftype, "relative_velocity_y"]
    f = (vz[sl_center, sl_right, sl_center] - vz[sl_center, sl_left, sl_center]) / (
        div_fac * just_one(data["index", "dy"])
    )
    f -= (
        vy[sl_center, sl_center, sl_right] - vy[sl_center, sl_center, sl_left]
    ) / (div_fac * just_one(data["index", "dz"]))
    new_field = data.ds.arr(np.zeros_like(vz, dtype=np.float64), f.units)
    new_field[sl_center, sl_center, sl_center] = f
    return new_field

(‘gas’, ‘vorticity_y’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: cell

Field Source

def _vorticity_y(field, data):
    vx = data[ftype, "relative_velocity_x"]
    vz = data[ftype, "relative_velocity_z"]
    f = (vx[sl_center, sl_center, sl_right] - vx[sl_center, sl_center, sl_left]) / (
        div_fac * just_one(data["index", "dz"])
    )
    f -= (
        vz[sl_right, sl_center, sl_center] - vz[sl_left, sl_center, sl_center]
    ) / (div_fac * just_one(data["index", "dx"]))
    new_field = data.ds.arr(np.zeros_like(vz, dtype=np.float64), f.units)
    new_field[sl_center, sl_center, sl_center] = f
    return new_field

(‘gas’, ‘vorticity_z’)

  • Units: \(1 / \rm{s}\)

  • Sampling Method: cell

Field Source

def _vorticity_z(field, data):
    vx = data[ftype, "relative_velocity_x"]
    vy = data[ftype, "relative_velocity_y"]
    f = (vy[sl_right, sl_center, sl_center] - vy[sl_left, sl_center, sl_center]) / (
        div_fac * just_one(data["index", "dx"])
    )
    f -= (
        vx[sl_center, sl_right, sl_center] - vx[sl_center, sl_left, sl_center]
    ) / (div_fac * just_one(data["index", "dy"]))
    new_field = data.ds.arr(np.zeros_like(vy, dtype=np.float64), f.units)
    new_field[sl_center, sl_center, sl_center] = f
    return new_field

(‘gas’, ‘weak_lensing_convergence’)

  • Units: \(1 / \rm{cm}\)

  • Sampling Method: local

Field Source

def _weak_lensing_convergence(field, data):
    if (
        not hasattr(data.ds, "cosmological_simulation")
        or not data.ds.cosmological_simulation
    ):
        raise NeedsConfiguration("cosmological_simulation", 1)
    co = data.ds.cosmology
    pc = data.ds.units.physical_constants
    observer_redshift = data.get_field_parameter("observer_redshift")
    source_redshift = data.get_field_parameter("source_redshift")

    # observer to lens
    dl = co.angular_diameter_distance(observer_redshift, data.ds.current_redshift)
    # observer to source
    ds = co.angular_diameter_distance(observer_redshift, source_redshift)
    # lens to source
    dls = co.angular_diameter_distance(data.ds.current_redshift, source_redshift)

    # removed the factor of 1 / a to account for the fact that we are projecting
    # with a proper distance.
    return (
        1.5
        * (co.hubble_constant / pc.clight) ** 2
        * (dl * dls / ds)
        * data[ftype, "matter_overdensity"]
    ).in_units("1/cm")

(‘gas’, ‘x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘gas’, ‘z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘index’, ‘cell_volume’)

  • Units: \(\rm{code~length}^{3}\)

  • Sampling Method: cell

Field Source

def _cell_volume(field, data):
    rv = data["index", "dx"].copy(order="K")
    rv *= data["index", "dy"]
    rv *= data["index", "dz"]
    return rv

(‘index’, ‘cylindrical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _cylindrical_radius(field, data):
    """The cylindrical radius component of the positions of the mesh cells.

    Relative to the coordinate system defined by the *normal* vector and
    *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    coords = get_periodic_rvec(data)
    return data.ds.arr(get_cyl_r(coords, normal), "code_length").in_base(
        unit_system.name
    )

(‘index’, ‘cylindrical_theta’)

  • Sampling Method: cell

Field Source

def _cylindrical_theta(field, data):
    """The cylindrical z component of the positions of the mesh cells.

    theta is the azimuthal position angle in the plane perpendicular to the
    *normal* vector.

    Relative to the coordinate system defined by the *normal* vector and
    *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    coords = get_periodic_rvec(data)
    return get_cyl_theta(coords, normal)

(‘index’, ‘cylindrical_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _cylindrical_z(field, data):
    """The cylindrical z component of the positions of the mesh cells.

    Relative to the coordinate system defined by the *normal* vector and
    *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    coords = get_periodic_rvec(data)
    return data.ds.arr(get_cyl_z(coords, normal), "code_length").in_base(
        unit_system.name
    )

(‘index’, ‘dx’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘dy’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘dz’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘grid_indices’)

  • Sampling Method: cell

Field Source

def _grid_indices(field, data):
    """The index of the leaf grid the mesh cells exist on"""
    if hasattr(data, "domain_id"):
        this_id = data.domain_id
    else:
        this_id = data.id - data._id_offset
    arr = np.ones(data["index", "ones"].shape)
    arr *= this_id
    if data._spatial:
        return data._reshape_vals(arr)
    return arr

(‘index’, ‘grid_level’)

  • Sampling Method: cell

Field Source

def _grid_level(field, data):
    """The AMR refinement level"""
    arr = np.ones(data.ires.shape, dtype="float64")
    arr *= data.ires
    if data._spatial:
        return data._reshape_vals(arr)
    return arr

(‘index’, ‘morton_index’)

  • Sampling Method: cell

Field Source

def _morton_index(field, data):
    """This is the morton index, which is properly a uint64 field.  Because
    we make some assumptions that the fields returned by derived fields are
    float64, this returns a "view" on the data that is float64.  To get
    back the original uint64, you need to call .view("uint64") on it;
    however, it should be true that if you sort the uint64, you will get
    the same order as if you sort the float64 view.
    """
    eps = np.finfo("f8").eps
    uq = data.ds.domain_left_edge.uq
    LE = data.ds.domain_left_edge - eps * uq
    RE = data.ds.domain_right_edge + eps * uq
    # .ravel() only copies if it needs to
    morton = compute_morton(
        data["index", "x"].ravel(),
        data["index", "y"].ravel(),
        data["index", "z"].ravel(),
        LE,
        RE,
    )
    morton.shape = data["index", "x"].shape
    return morton.view("f8")

(‘index’, ‘ones’)

  • Sampling Method: cell

Field Source

def _ones(field, data):
    """Returns one for all cells"""
    tmp = np.ones(data.ires.shape, dtype="float64")
    arr = data.apply_units(tmp, field.units)
    if data._spatial:
        return data._reshape_vals(arr)
    return arr

(‘index’, ‘ones_over_dx’)

  • Units: \(1 / \rm{cm}\)

  • Sampling Method: cell

Field Source

def _ones_over_dx(field, data):
    """The inverse of the local cell spacing"""
    return (
        np.ones(data["index", "ones"].shape, dtype="float64") / data["index", "dx"]
    )

(‘index’, ‘path_element_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘path_element_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘path_element_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _dds(field, data):
    rv = data.ds.arr(data.fwidth[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _radius(field, data):
    """The spherical radius component of the mesh cells.

    Relative to the coordinate system defined by the *center* field
    parameter.
    """
    return get_radius(data, "", field.name[0])

(‘index’, ‘spherical_phi’)

  • Sampling Method: cell

Field Source

def _spherical_phi(field, data):
    """The spherical phi component of the positions of the mesh cells.

    phi is the azimuthal position angle in the plane perpendicular to the
    *normal* vector

    Relative to the coordinate system defined by the *center* and *normal*
    field parameters.
    """
    normal = data.get_field_parameter("normal")
    coords = get_periodic_rvec(data)
    return get_sph_phi(coords, normal)

(‘index’, ‘spherical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _spherical_radius(field, data):
    """The spherical radius component of the positions of the mesh cells.

    Relative to the coordinate system defined by the *center* field
    parameter.
    """
    coords = get_periodic_rvec(data)
    return data.ds.arr(get_sph_r(coords), "code_length").in_base(unit_system.name)

(‘index’, ‘spherical_theta’)

  • Sampling Method: cell

Field Source

def _spherical_theta(field, data):
    """The spherical theta component of the positions of the mesh cells.

    theta is the poloidal position angle in the plane parallel to the
    *normal* vector

    Relative to the coordinate system defined by the *center* and *normal*
    field parameters.
    """
    normal = data.get_field_parameter("normal")
    coords = get_periodic_rvec(data)
    return get_sph_theta(coords, normal)

(‘index’, ‘vertex_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _vert(field, data):
    rv = data.ds.arr(data.fcoords_vertex[..., axi].copy(), units)
    return rv

(‘index’, ‘vertex_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _vert(field, data):
    rv = data.ds.arr(data.fcoords_vertex[..., axi].copy(), units)
    return rv

(‘index’, ‘vertex_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _vert(field, data):
    rv = data.ds.arr(data.fcoords_vertex[..., axi].copy(), units)
    return rv

(‘index’, ‘virial_radius_fraction’)

  • Sampling Method: local

Field Source

def _virial_radius_fraction(field, data):
    virial_radius = data.get_field_parameter("virial_radius")
    if virial_radius == 0.0:
        ret = 0.0
    else:
        ret = data[("index", "radius")] / virial_radius
    return ret

(‘index’, ‘volume’)

  • Units: \(\rm{cm}^{3}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘index’, ‘x’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _coords(field, data):
    rv = data.ds.arr(data.fcoords[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘y’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _coords(field, data):
    rv = data.ds.arr(data.fcoords[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘z’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: cell

Field Source

def _coords(field, data):
    rv = data.ds.arr(data.fcoords[..., axi].copy(), units)
    return data._reshape_vals(rv)

(‘index’, ‘zeros’)

  • Sampling Method: cell

Field Source

def _zeros(field, data):
    """Returns zero for all cells"""
    arr = np.zeros(data["index", "ones"].shape, dtype="float64")
    return data.apply_units(arr, field.units)

(‘io’, ‘mesh_id’)

  • Sampling Method: particle

Field Source

def particle_mesh_ids(field, data):
    pos = data[ptype, coord_name]
    ids = np.zeros(pos.shape[0], dtype="float64") - 1
    # This is float64 in name only.  It will be properly cast inside the
    # deposit operation.
    # _ids = ids.view("float64")
    data.deposit(pos, [ids], method="mesh_id")
    return data.apply_units(ids, "")

(‘io’, ‘particle_angular_momentum’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum(field, data):
    am = (
        data[ptype, "particle_mass"]
        * data[ptype, "particle_specific_angular_momentum"].T
    )
    return am.T

(‘io’, ‘particle_angular_momentum_magnitude’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘io’, ‘particle_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘io’, ‘particle_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘io’, ‘particle_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘io’, ‘particle_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_ones’)

  • Sampling Method: particle

Field Source

def particle_ones(field, data):
    v = np.ones(data[ptype, coord_name].shape[0], dtype="float64")
    return data.apply_units(v, field.units)

(‘io’, ‘particle_position’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘io’, ‘particle_position_cylindrical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_r(pos, normal), "code_length")

(‘io’, ‘particle_position_cylindrical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_cyl_theta(pos, normal), "")

(‘io’, ‘particle_position_cylindrical_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_z(field, data):
    """The cylindrical z component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_z(pos, normal), "code_length")

(‘io’, ‘particle_position_relative_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘particle_position_relative_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘particle_position_relative_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘particle_position_spherical_phi’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_phi(field, data):
    """The spherical phi component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_phi(pos, normal), "")

(‘io’, ‘particle_position_spherical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘io’, ‘particle_position_spherical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_theta(field, data):
    """The spherical theta coordinate of the particle positions.

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_theta(pos, normal), "")

(‘io’, ‘particle_position_x’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_position_y’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_position_z’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_radial_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘io’, ‘particle_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘io’, ‘particle_specific_angular_momentum’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum(field, data):
    """Calculate the angular of a particle velocity.

    Returns a vector for each particle.
    """
    center = data.get_field_parameter("center")
    pos, vel, normal = get_angular_momentum_components(ptype, data, spos, svel)
    L, r_vec, v_vec = modify_reference_frame(center, normal, P=pos, V=vel)
    # adding in the unit registry allows us to have a reference to the
    # dataset and thus we will always get the correct units after applying
    # the cross product.
    return ucross(r_vec, v_vec, registry=data.ds.unit_registry)

(‘io’, ‘particle_specific_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘io’, ‘particle_specific_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘io’, ‘particle_specific_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘io’, ‘particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘io’, ‘particle_velocity_cylindrical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylr = get_cyl_r_component(vel, theta, normal)
    return cylr

(‘io’, ‘particle_velocity_cylindrical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylt = get_cyl_theta_component(vel, theta, normal)
    return cylt

(‘io’, ‘particle_velocity_cylindrical_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_z(field, data):
    """The cylindrical z component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vel = data[(ptype, "relative_particle_velocity")].T
    cylz = get_cyl_z_component(vel, normal)
    return cylz

(‘io’, ‘particle_velocity_magnitude’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_magnitude(field, data):
    """M{|v|}"""
    return np.sqrt(
        data[ptype, f"relative_{svel % 'x'}"] ** 2
        + data[ptype, f"relative_{svel % 'y'}"] ** 2
        + data[ptype, f"relative_{svel % 'z'}"] ** 2
    )

(‘io’, ‘particle_velocity_relative_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘io’, ‘particle_velocity_relative_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘io’, ‘particle_velocity_relative_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘io’, ‘particle_velocity_spherical_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_phi(field, data):
    """The spherical phi component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    phi = get_sph_phi(pos, normal)
    sphp = get_sph_phi_component(vel, phi, normal)
    return sphp

(‘io’, ‘particle_velocity_spherical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_radius(field, data):
    """The spherical radius component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    sphr = get_sph_r_component(vel, theta, phi, normal)
    return sphr

(‘io’, ‘particle_velocity_spherical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_theta(field, data):
    """The spherical theta component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    spht = get_sph_theta_component(vel, theta, phi, normal)
    return spht

(‘io’, ‘particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘io’, ‘relative_particle_position’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _relative_particle_position(field, data):
    """The cartesian particle positions in a rotated reference frame

    Relative to the coordinate system defined by *center* field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_position_{ax}") for ax in "xyz"]
    return obtain_position_vector(data, field_names=field_names).T

(‘io’, ‘relative_particle_position_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘relative_particle_position_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘relative_particle_position_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘io’, ‘relative_particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _relative_particle_velocity(field, data):
    """The vector particle velocities in an arbitrary coordinate system

    Relative to the coordinate system defined by the *bulk_velocity*
    vector field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_velocity_{ax}") for ax in "xyz"]
    return obtain_relative_velocity_vector(data, field_names=field_names).T

(‘io’, ‘relative_particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘io’, ‘relative_particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘io’, ‘relative_particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘mesh_id’)

  • Sampling Method: particle

Field Source

def particle_mesh_ids(field, data):
    pos = data[ptype, coord_name]
    ids = np.zeros(pos.shape[0], dtype="float64") - 1
    # This is float64 in name only.  It will be properly cast inside the
    # deposit operation.
    # _ids = ids.view("float64")
    data.deposit(pos, [ids], method="mesh_id")
    return data.apply_units(ids, "")

(‘nbody’, ‘particle_angular_momentum’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum(field, data):
    am = (
        data[ptype, "particle_mass"]
        * data[ptype, "particle_specific_angular_momentum"].T
    )
    return am.T

(‘nbody’, ‘particle_angular_momentum_magnitude’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _magnitude(field, data):
    fn = field_components[0]
    if data.has_field_parameter(f"bulk_{basename}"):
        fn = (fn[0], f"relative_{fn[1]}")
    d = data[fn]
    mag = (d) ** 2
    for idim in range(1, registry.ds.dimensionality):
        fn = field_components[idim]
        if data.has_field_parameter(f"bulk_{basename}"):
            fn = (fn[0], f"relative_{fn[1]}")
        mag += (data[fn]) ** 2
    return np.sqrt(mag)

(‘nbody’, ‘particle_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘nbody’, ‘particle_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘nbody’, ‘particle_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} \cdot \rm{g} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_angular_momentum_component(field, data):
    return (
        data[_ptype, "particle_mass"]
        * data[ptype, f"particle_specific_angular_momentum_{ax}"]
    )

(‘nbody’, ‘particle_mass’)

  • Units: \(\rm{g}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_ones’)

  • Sampling Method: particle

Field Source

def particle_ones(field, data):
    v = np.ones(data[ptype, coord_name].shape[0], dtype="float64")
    return data.apply_units(v, field.units)

(‘nbody’, ‘particle_position’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘nbody’, ‘particle_position_cylindrical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_r(pos, normal), "code_length")

(‘nbody’, ‘particle_position_cylindrical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_cyl_theta(pos, normal), "")

(‘nbody’, ‘particle_position_cylindrical_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_position_cylindrical_z(field, data):
    """The cylindrical z component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    pos.convert_to_units("code_length")
    return data.ds.arr(get_cyl_z(pos, normal), "code_length")

(‘nbody’, ‘particle_position_relative_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘particle_position_relative_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘particle_position_relative_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘particle_position_spherical_phi’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_phi(field, data):
    """The spherical phi component of the particle positions

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_phi(pos, normal), "")

(‘nbody’, ‘particle_position_spherical_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘nbody’, ‘particle_position_spherical_theta’)

  • Sampling Method: particle

Field Source

def _particle_position_spherical_theta(field, data):
    """The spherical theta coordinate of the particle positions.

    Relative to the coordinate system defined by the *normal* vector
    and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    return data.ds.arr(get_sph_theta(pos, normal), "")

(‘nbody’, ‘particle_position_x’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_position_y’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_position_z’)

  • Units: \(\rm{code~length}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_radial_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘nbody’, ‘particle_radius’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_radius(field, data):
    """The spherical radius component of the particle positions

    Relative to the coordinate system defined by the *normal* vector,
    and *center* field parameters.
    """
    return get_radius(data, "particle_position_", field.name[0])

(‘nbody’, ‘particle_specific_angular_momentum’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum(field, data):
    """Calculate the angular of a particle velocity.

    Returns a vector for each particle.
    """
    center = data.get_field_parameter("center")
    pos, vel, normal = get_angular_momentum_components(ptype, data, spos, svel)
    L, r_vec, v_vec = modify_reference_frame(center, normal, P=pos, V=vel)
    # adding in the unit registry allows us to have a reference to the
    # dataset and thus we will always get the correct units after applying
    # the cross product.
    return ucross(r_vec, v_vec, registry=data.ds.unit_registry)

(‘nbody’, ‘particle_specific_angular_momentum_x’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘nbody’, ‘particle_specific_angular_momentum_y’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘nbody’, ‘particle_specific_angular_momentum_z’)

  • Units: \(\rm{cm}^{2} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_specific_angular_momentum_component(field, data):
    return data[_ptype, "particle_specific_angular_momentum"][:, axi]

(‘nbody’, ‘particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def particle_vectors(field, data):
    v = [data[_ptype, name].in_units(field.units) for name in names]
    return data.ds.arr(np.column_stack(v), v[0].units)

(‘nbody’, ‘particle_velocity_cylindrical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_radius(field, data):
    """The cylindrical radius component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylr = get_cyl_r_component(vel, theta, normal)
    return cylr

(‘nbody’, ‘particle_velocity_cylindrical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_theta(field, data):
    """The cylindrical theta component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_cyl_theta(pos, normal)
    cylt = get_cyl_theta_component(vel, theta, normal)
    return cylt

(‘nbody’, ‘particle_velocity_cylindrical_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_cylindrical_z(field, data):
    """The cylindrical z component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    vel = data[(ptype, "relative_particle_velocity")].T
    cylz = get_cyl_z_component(vel, normal)
    return cylz

(‘nbody’, ‘particle_velocity_magnitude’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_magnitude(field, data):
    """M{|v|}"""
    return np.sqrt(
        data[ptype, f"relative_{svel % 'x'}"] ** 2
        + data[ptype, f"relative_{svel % 'y'}"] ** 2
        + data[ptype, f"relative_{svel % 'z'}"] ** 2
    )

(‘nbody’, ‘particle_velocity_relative_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘particle_velocity_relative_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘particle_velocity_relative_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘particle_velocity_spherical_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_phi(field, data):
    """The spherical phi component of the particle velocities

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    phi = get_sph_phi(pos, normal)
    sphp = get_sph_phi_component(vel, phi, normal)
    return sphp

(‘nbody’, ‘particle_velocity_spherical_radius’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_radius(field, data):
    """The spherical radius component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    sphr = get_sph_r_component(vel, theta, phi, normal)
    return sphr

(‘nbody’, ‘particle_velocity_spherical_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_velocity_spherical_theta(field, data):
    """The spherical theta component of the particle velocities in an
     arbitrary coordinate system

    Relative to the coordinate system defined by the *normal* vector,
    *bulk_velocity* vector and *center* field parameters.
    """
    normal = data.get_field_parameter("normal")
    pos = data[(ptype, "relative_particle_position")].T
    vel = data[(ptype, "relative_particle_velocity")].T
    theta = get_sph_theta(pos, normal)
    phi = get_sph_phi(pos, normal)
    spht = get_sph_theta_component(vel, theta, phi, normal)
    return spht

(‘nbody’, ‘particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

No source available.

(‘nbody’, ‘relative_particle_position’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _relative_particle_position(field, data):
    """The cartesian particle positions in a rotated reference frame

    Relative to the coordinate system defined by *center* field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_position_{ax}") for ax in "xyz"]
    return obtain_position_vector(data, field_names=field_names).T

(‘nbody’, ‘relative_particle_position_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘relative_particle_position_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘relative_particle_position_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: particle

Field Source

def _particle_pos_rel(field, data):
    return data[_ptype, "relative_particle_position"][:, axi]

(‘nbody’, ‘relative_particle_velocity’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _relative_particle_velocity(field, data):
    """The vector particle velocities in an arbitrary coordinate system

    Relative to the coordinate system defined by the *bulk_velocity*
    vector field parameter.

    Note that the orientation of the x and y axes are arbitrary.
    """
    field_names = [(ptype, f"particle_velocity_{ax}") for ax in "xyz"]
    return obtain_relative_velocity_vector(data, field_names=field_names).T

(‘nbody’, ‘relative_particle_velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘relative_particle_velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘nbody’, ‘relative_particle_velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: particle

Field Source

def _particle_vel_rel(field, data):
    return data[_ptype, "relative_particle_velocity"][:, axi]

(‘stream’, ‘cell_volume’)

  • Units: \(\rm{cm}^{3}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘dark_matter_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘di_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘dii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘dx’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘dy’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘dz’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘h2i_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘h2ii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘h2m_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘hdi_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘hei_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘heii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘heiii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘hi_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘hii_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_phi’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_r’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_theta’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_x’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_y’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘magnetic_field_z’)

  • Units: \(\rm{G}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘metal_density’)

  • Units: \(\frac{\rm{g}}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘metallicity’)

  • Units: \(\rm{Z}_\odot\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘number_density’)

  • Units: \(\frac{1}{\rm{cm}^{3}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘path_element_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘path_element_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘path_element_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘pressure’)

  • Units: \(\frac{\rm{dyn}}{\rm{cm}^{2}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘radiation_acceleration_x’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘radiation_acceleration_y’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘radiation_acceleration_z’)

  • Units: \(\frac{\rm{cm}}{\rm{s}^{2}}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘specific_thermal_energy’)

  • Units: \(\rm{erg} / \rm{g}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘temperature’)

  • Units: \(\rm{K}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_phi’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_r’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_theta’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_x’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_y’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘velocity_z’)

  • Units: \(\rm{cm} / \rm{s}\)

  • Sampling Method: cell

Field Source

No source available.

(‘stream’, ‘vertex_x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘vertex_y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘vertex_z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘volume’)

  • Units: \(\rm{cm}^{3}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘x’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘y’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

(‘stream’, ‘z’)

  • Units: \(\rm{cm}\)

  • Sampling Method: cell

Field Source

def _TranslationFunc(field, data):
    # We do a bunch of in-place modifications, so we will copy this.
    return data[field_name].copy()

AdaptaHOP-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘particle_identifier’)

1

\(Halo Identity\)

(‘io’, ‘raw_position_x’)

\(\mathrm{\rm{Mpc}}\)

1

(‘io’, ‘raw_position_y’)

\(\mathrm{\rm{Mpc}}\)

1

(‘io’, ‘raw_position_z’)

\(\mathrm{\rm{Mpc}}\)

1

(‘io’, ‘r’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo radius\)

(‘io’, ‘a’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo semi-major axis\)

(‘io’, ‘b’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo semi-medium axis\)

(‘io’, ‘c’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo semi-minor axis\)

(‘io’, ‘particle_velocity_x’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(Halo velocity x\)

(‘io’, ‘particle_velocity_y’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(Halo velocity y\)

(‘io’, ‘particle_velocity_z’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(Halo velocity z\)

(‘io’, ‘particle_angular_momentum_x’)

\(\mathrm{1.0 \times 10^{11}~\rm{Mpc} \cdot \rm{M}_\odot \cdot \rm{km} / \rm{s}}\)

1

\(Halo Angular Momentum x\)

(‘io’, ‘particle_angular_momentum_y’)

\(\mathrm{1.0 \times 10^{11}~\rm{Mpc} \cdot \rm{M}_\odot \cdot \rm{km} / \rm{s}}\)

1

\(Halo Angular Momentum y\)

(‘io’, ‘particle_angular_momentum_z’)

\(\mathrm{1.0 \times 10^{11}~\rm{Mpc} \cdot \rm{M}_\odot \cdot \rm{km} / \rm{s}}\)

1

\(Halo Angular Momentum z\)

(‘io’, ‘particle_mass’)

\(\mathrm{1.0 \times 10^{11}~\rm{M}_\odot}\)

1

\(Halo mass\)

(‘io’, ‘ek’)

\(\mathrm{1.0 \times 10^{11}~\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{\rm{s}^{2}}}\)

1

\(Halo Kinetic Energy\)

(‘io’, ‘ep’)

\(\mathrm{1.0 \times 10^{11}~\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{\rm{s}^{2}}}\)

1

\(Halo Gravitational Energy\)

(‘io’, ‘ek’)

\(\mathrm{1.0 \times 10^{11}~\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{\rm{s}^{2}}}\)

1

\(Halo Total Energy\)

(‘io’, ‘spin’)

1

\(Halo Spin Parameter\)

(‘io’, ‘virial_radius’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo Virial Radius\)

(‘io’, ‘virial_mass’)

\(\mathrm{1.0 \times 10^{11}~\rm{M}_\odot}\)

1

\(Halo Virial Mass\)

(‘io’, ‘virial_temperature’)

\(\mathrm{\rm{K}}\)

1

\(Halo Virial Temperature\)

(‘io’, ‘virial_velocity’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(Halo Virial Velocity\)

(‘io’, ‘rho0’)

\(\mathrm{1.0 \times 10^{11}~\frac{\rm{M}_\odot}{\rm{Mpc}^{3}}}\)

1

\(Halo NFW Density\)

(‘io’, ‘R_c’)

\(\mathrm{\rm{Mpc}}\)

1

\(Halo NFW Scale Radius\)

(‘io’, ‘velocity_dispersion’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(Velocity Dispersion\)

(‘io’, ‘radius_200’)

\(\mathrm{\rm{Mpc}}\)

1

\($R_\mathrm{200}$\)

(‘io’, ‘radius_50’)

\(\mathrm{\rm{Mpc}}\)

1

\($R_\mathrm{50}$\)

(‘io’, ‘mass_200’)

\(\mathrm{1.0 \times 10^{11}~\rm{M}_\odot}\)

1

\($M_\mathrm{200}$\)

(‘io’, ‘mass_50’)

\(\mathrm{1.0 \times 10^{11}~\rm{M}_\odot}\)

1

\($M_\mathrm{50}$\)

(‘io’, ‘contaminated’)

1

\(Contaminated\)

(‘io’, ‘m_contam’)

\(\mathrm{1.0 \times 10^{11}~\rm{M}_\odot}\)

1

\(Contaminated Mass\)

AHFHalos-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘ID’)

particle_identifier

1

(‘io’, ‘hostHalo’)

1

(‘io’, ‘numSubStruct’)

1

(‘io’, ‘Mvir’)

\(\mathrm{\rm{M}_\odot / h}\)

particle_mass

1

\(Virial Mass\)

(‘io’, ‘npart’)

1

(‘io’, ‘Xc’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

particle_position_x

1

(‘io’, ‘Yc’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

particle_position_y

1

(‘io’, ‘Zc’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

particle_position_z

1

(‘io’, ‘VXc’)

\(\mathrm{\rm{km} / \rm{s}}\)

particle_velocity_x

1

(‘io’, ‘VYc’)

\(\mathrm{\rm{km} / \rm{s}}\)

particle_velocity_y

1

(‘io’, ‘VZc’)

\(\mathrm{\rm{km} / \rm{s}}\)

particle_velocity_z

1

(‘io’, ‘Rvir’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

virial_radius

1

\(Virial Radius\)

(‘io’, ‘Rmax’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

(‘io’, ‘r2’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

(‘io’, ‘mbp_offset’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

(‘io’, ‘com_offset’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

(‘io’, ‘Vmax’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘v_sec’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘sigV’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘lambda’)

1

(‘io’, ‘lambdaE’)

1

(‘io’, ‘Lx’)

1

(‘io’, ‘Ly’)

1

(‘io’, ‘Lz’)

1

(‘io’, ‘b’)

1

(‘io’, ‘c’)

1

(‘io’, ‘Eax’)

1

(‘io’, ‘Eay’)

1

(‘io’, ‘Eaz’)

1

(‘io’, ‘Ebx’)

1

(‘io’, ‘Eby’)

1

(‘io’, ‘Ebz’)

1

(‘io’, ‘Ecx’)

1

(‘io’, ‘Ecy’)

1

(‘io’, ‘Ecz’)

1

(‘io’, ‘ovdens’)

1

(‘io’, ‘nbins’)

1

(‘io’, ‘fMhires’)

1

(‘io’, ‘Ekin’)

\(\mathrm{\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{h \cdot \rm{s}^{2}}}\)

1

(‘io’, ‘Epot’)

\(\mathrm{\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{h \cdot \rm{s}^{2}}}\)

1

(‘io’, ‘SurfP’)

\(\mathrm{\frac{\rm{M}_\odot \cdot \rm{km}^{2}}{h \cdot \rm{s}^{2}}}\)

1

(‘io’, ‘Phi0’)

\(\mathrm{\frac{\rm{km}^{2}}{\rm{s}^{2}}}\)

1

(‘io’, ‘cNFW’)

1

AMRVAC-Specific Fields

field name

units

aliases

particle?

display name

(‘amrvac’, ‘rho’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘amrvac’, ‘m1’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

moment_1

0

(‘amrvac’, ‘m2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

moment_2

0

(‘amrvac’, ‘m3’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

moment_3

0

(‘amrvac’, ‘e’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

energy_density

0

(‘amrvac’, ‘b1’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_1

0

(‘amrvac’, ‘b2’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_2

0

(‘amrvac’, ‘b3’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_3

0

(‘amrvac’, ‘Te’)

\(\mathrm{\rm{code~temperature}}\)

temperature

0

(‘amrvac’, ‘rhod1’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust1_density

0

(‘amrvac’, ‘rhod2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust2_density

0

(‘amrvac’, ‘rhod3’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust3_density

0

(‘amrvac’, ‘rhod4’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust4_density

0

(‘amrvac’, ‘rhod5’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust5_density

0

(‘amrvac’, ‘rhod6’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust6_density

0

(‘amrvac’, ‘rhod7’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust7_density

0

(‘amrvac’, ‘rhod8’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust8_density

0

(‘amrvac’, ‘rhod9’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust9_density

0

(‘amrvac’, ‘rhod10’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust10_density

0

(‘amrvac’, ‘rhod11’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust11_density

0

(‘amrvac’, ‘rhod12’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust12_density

0

(‘amrvac’, ‘rhod13’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust13_density

0

(‘amrvac’, ‘rhod14’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust14_density

0

(‘amrvac’, ‘rhod15’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust15_density

0

(‘amrvac’, ‘rhod16’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust16_density

0

(‘amrvac’, ‘rhod17’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust17_density

0

(‘amrvac’, ‘rhod18’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust18_density

0

(‘amrvac’, ‘rhod19’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust19_density

0

(‘amrvac’, ‘rhod20’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust20_density

0

(‘amrvac’, ‘rhod21’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust21_density

0

(‘amrvac’, ‘rhod22’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust22_density

0

(‘amrvac’, ‘rhod23’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust23_density

0

(‘amrvac’, ‘rhod24’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust24_density

0

(‘amrvac’, ‘rhod25’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust25_density

0

(‘amrvac’, ‘rhod26’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust26_density

0

(‘amrvac’, ‘rhod27’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust27_density

0

(‘amrvac’, ‘rhod28’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust28_density

0

(‘amrvac’, ‘rhod29’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust29_density

0

(‘amrvac’, ‘rhod30’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust30_density

0

(‘amrvac’, ‘rhod31’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust31_density

0

(‘amrvac’, ‘rhod32’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust32_density

0

(‘amrvac’, ‘rhod33’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust33_density

0

(‘amrvac’, ‘rhod34’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust34_density

0

(‘amrvac’, ‘rhod35’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust35_density

0

(‘amrvac’, ‘rhod36’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust36_density

0

(‘amrvac’, ‘rhod37’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust37_density

0

(‘amrvac’, ‘rhod38’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust38_density

0

(‘amrvac’, ‘rhod39’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust39_density

0

(‘amrvac’, ‘rhod40’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust40_density

0

(‘amrvac’, ‘rhod41’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust41_density

0

(‘amrvac’, ‘rhod42’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust42_density

0

(‘amrvac’, ‘rhod43’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust43_density

0

(‘amrvac’, ‘rhod44’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust44_density

0

(‘amrvac’, ‘rhod45’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust45_density

0

(‘amrvac’, ‘rhod46’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust46_density

0

(‘amrvac’, ‘rhod47’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust47_density

0

(‘amrvac’, ‘rhod48’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust48_density

0

(‘amrvac’, ‘rhod49’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust49_density

0

(‘amrvac’, ‘rhod50’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust50_density

0

(‘amrvac’, ‘rhod51’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust51_density

0

(‘amrvac’, ‘rhod52’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust52_density

0

(‘amrvac’, ‘rhod53’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust53_density

0

(‘amrvac’, ‘rhod54’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust54_density

0

(‘amrvac’, ‘rhod55’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust55_density

0

(‘amrvac’, ‘rhod56’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust56_density

0

(‘amrvac’, ‘rhod57’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust57_density

0

(‘amrvac’, ‘rhod58’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust58_density

0

(‘amrvac’, ‘rhod59’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust59_density

0

(‘amrvac’, ‘rhod60’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust60_density

0

(‘amrvac’, ‘rhod61’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust61_density

0

(‘amrvac’, ‘rhod62’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust62_density

0

(‘amrvac’, ‘rhod63’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust63_density

0

(‘amrvac’, ‘rhod64’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust64_density

0

(‘amrvac’, ‘rhod65’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust65_density

0

(‘amrvac’, ‘rhod66’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust66_density

0

(‘amrvac’, ‘rhod67’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust67_density

0

(‘amrvac’, ‘rhod68’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust68_density

0

(‘amrvac’, ‘rhod69’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust69_density

0

(‘amrvac’, ‘rhod70’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust70_density

0

(‘amrvac’, ‘rhod71’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust71_density

0

(‘amrvac’, ‘rhod72’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust72_density

0

(‘amrvac’, ‘rhod73’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust73_density

0

(‘amrvac’, ‘rhod74’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust74_density

0

(‘amrvac’, ‘rhod75’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust75_density

0

(‘amrvac’, ‘rhod76’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust76_density

0

(‘amrvac’, ‘rhod77’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust77_density

0

(‘amrvac’, ‘rhod78’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust78_density

0

(‘amrvac’, ‘rhod79’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust79_density

0

(‘amrvac’, ‘rhod80’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust80_density

0

(‘amrvac’, ‘rhod81’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust81_density

0

(‘amrvac’, ‘rhod82’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust82_density

0

(‘amrvac’, ‘rhod83’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust83_density

0

(‘amrvac’, ‘rhod84’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust84_density

0

(‘amrvac’, ‘rhod85’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust85_density

0

(‘amrvac’, ‘rhod86’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust86_density

0

(‘amrvac’, ‘rhod87’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust87_density

0

(‘amrvac’, ‘rhod88’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust88_density

0

(‘amrvac’, ‘rhod89’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust89_density

0

(‘amrvac’, ‘rhod90’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust90_density

0

(‘amrvac’, ‘rhod91’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust91_density

0

(‘amrvac’, ‘rhod92’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust92_density

0

(‘amrvac’, ‘rhod93’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust93_density

0

(‘amrvac’, ‘rhod94’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust94_density

0

(‘amrvac’, ‘rhod95’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust95_density

0

(‘amrvac’, ‘rhod96’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust96_density

0

(‘amrvac’, ‘rhod97’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust97_density

0

(‘amrvac’, ‘rhod98’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust98_density

0

(‘amrvac’, ‘rhod99’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust99_density

0

(‘amrvac’, ‘rhod100’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

dust100_density

0

(‘amrvac’, ‘m1d1’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust1_moment_1

0

(‘amrvac’, ‘m2d1’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust1_moment_2

0

(‘amrvac’, ‘m3d1’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust1_moment_3

0

(‘amrvac’, ‘m1d2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust2_moment_1

0

(‘amrvac’, ‘m2d2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust2_moment_2

0

(‘amrvac’, ‘m3d2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust2_moment_3

0

(‘amrvac’, ‘m1d3’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust3_moment_1

0

(‘amrvac’, ‘m2d3’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust3_moment_2

0

(‘amrvac’, ‘m3d3’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust3_moment_3

0

(‘amrvac’, ‘m1d4’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust4_moment_1

0

(‘amrvac’, ‘m2d4’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust4_moment_2

0

(‘amrvac’, ‘m3d4’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust4_moment_3

0

(‘amrvac’, ‘m1d5’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust5_moment_1

0

(‘amrvac’, ‘m2d5’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust5_moment_2

0

(‘amrvac’, ‘m3d5’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust5_moment_3

0

(‘amrvac’, ‘m1d6’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust6_moment_1

0

(‘amrvac’, ‘m2d6’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust6_moment_2

0

(‘amrvac’, ‘m3d6’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust6_moment_3

0

(‘amrvac’, ‘m1d7’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust7_moment_1

0

(‘amrvac’, ‘m2d7’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust7_moment_2

0

(‘amrvac’, ‘m3d7’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust7_moment_3

0

(‘amrvac’, ‘m1d8’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust8_moment_1

0

(‘amrvac’, ‘m2d8’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust8_moment_2

0

(‘amrvac’, ‘m3d8’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust8_moment_3

0

(‘amrvac’, ‘m1d9’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust9_moment_1

0

(‘amrvac’, ‘m2d9’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust9_moment_2

0

(‘amrvac’, ‘m3d9’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust9_moment_3

0

(‘amrvac’, ‘m1d10’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust10_moment_1

0

(‘amrvac’, ‘m2d10’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust10_moment_2

0

(‘amrvac’, ‘m3d10’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust10_moment_3

0

(‘amrvac’, ‘m1d11’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust11_moment_1

0

(‘amrvac’, ‘m2d11’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust11_moment_2

0

(‘amrvac’, ‘m3d11’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust11_moment_3

0

(‘amrvac’, ‘m1d12’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust12_moment_1

0

(‘amrvac’, ‘m2d12’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust12_moment_2

0

(‘amrvac’, ‘m3d12’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust12_moment_3

0

(‘amrvac’, ‘m1d13’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust13_moment_1

0

(‘amrvac’, ‘m2d13’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust13_moment_2

0

(‘amrvac’, ‘m3d13’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust13_moment_3

0

(‘amrvac’, ‘m1d14’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust14_moment_1

0

(‘amrvac’, ‘m2d14’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust14_moment_2

0

(‘amrvac’, ‘m3d14’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust14_moment_3

0

(‘amrvac’, ‘m1d15’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust15_moment_1

0

(‘amrvac’, ‘m2d15’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust15_moment_2

0

(‘amrvac’, ‘m3d15’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust15_moment_3

0

(‘amrvac’, ‘m1d16’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust16_moment_1

0

(‘amrvac’, ‘m2d16’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust16_moment_2

0

(‘amrvac’, ‘m3d16’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust16_moment_3

0

(‘amrvac’, ‘m1d17’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust17_moment_1

0

(‘amrvac’, ‘m2d17’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust17_moment_2

0

(‘amrvac’, ‘m3d17’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust17_moment_3

0

(‘amrvac’, ‘m1d18’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust18_moment_1

0

(‘amrvac’, ‘m2d18’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust18_moment_2

0

(‘amrvac’, ‘m3d18’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust18_moment_3

0

(‘amrvac’, ‘m1d19’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust19_moment_1

0

(‘amrvac’, ‘m2d19’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust19_moment_2

0

(‘amrvac’, ‘m3d19’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust19_moment_3

0

(‘amrvac’, ‘m1d20’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust20_moment_1

0

(‘amrvac’, ‘m2d20’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust20_moment_2

0

(‘amrvac’, ‘m3d20’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust20_moment_3

0

(‘amrvac’, ‘m1d21’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust21_moment_1

0

(‘amrvac’, ‘m2d21’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust21_moment_2

0

(‘amrvac’, ‘m3d21’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust21_moment_3

0

(‘amrvac’, ‘m1d22’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust22_moment_1

0

(‘amrvac’, ‘m2d22’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust22_moment_2

0

(‘amrvac’, ‘m3d22’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust22_moment_3

0

(‘amrvac’, ‘m1d23’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust23_moment_1

0

(‘amrvac’, ‘m2d23’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust23_moment_2

0

(‘amrvac’, ‘m3d23’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust23_moment_3

0

(‘amrvac’, ‘m1d24’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust24_moment_1

0

(‘amrvac’, ‘m2d24’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust24_moment_2

0

(‘amrvac’, ‘m3d24’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust24_moment_3

0

(‘amrvac’, ‘m1d25’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust25_moment_1

0

(‘amrvac’, ‘m2d25’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust25_moment_2

0

(‘amrvac’, ‘m3d25’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust25_moment_3

0

(‘amrvac’, ‘m1d26’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust26_moment_1

0

(‘amrvac’, ‘m2d26’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust26_moment_2

0

(‘amrvac’, ‘m3d26’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust26_moment_3

0

(‘amrvac’, ‘m1d27’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust27_moment_1

0

(‘amrvac’, ‘m2d27’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust27_moment_2

0

(‘amrvac’, ‘m3d27’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust27_moment_3

0

(‘amrvac’, ‘m1d28’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust28_moment_1

0

(‘amrvac’, ‘m2d28’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust28_moment_2

0

(‘amrvac’, ‘m3d28’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust28_moment_3

0

(‘amrvac’, ‘m1d29’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust29_moment_1

0

(‘amrvac’, ‘m2d29’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust29_moment_2

0

(‘amrvac’, ‘m3d29’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust29_moment_3

0

(‘amrvac’, ‘m1d30’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust30_moment_1

0

(‘amrvac’, ‘m2d30’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust30_moment_2

0

(‘amrvac’, ‘m3d30’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust30_moment_3

0

(‘amrvac’, ‘m1d31’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust31_moment_1

0

(‘amrvac’, ‘m2d31’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust31_moment_2

0

(‘amrvac’, ‘m3d31’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust31_moment_3

0

(‘amrvac’, ‘m1d32’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust32_moment_1

0

(‘amrvac’, ‘m2d32’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust32_moment_2

0

(‘amrvac’, ‘m3d32’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust32_moment_3

0

(‘amrvac’, ‘m1d33’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust33_moment_1

0

(‘amrvac’, ‘m2d33’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust33_moment_2

0

(‘amrvac’, ‘m3d33’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust33_moment_3

0

(‘amrvac’, ‘m1d34’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust34_moment_1

0

(‘amrvac’, ‘m2d34’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust34_moment_2

0

(‘amrvac’, ‘m3d34’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust34_moment_3

0

(‘amrvac’, ‘m1d35’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust35_moment_1

0

(‘amrvac’, ‘m2d35’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust35_moment_2

0

(‘amrvac’, ‘m3d35’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust35_moment_3

0

(‘amrvac’, ‘m1d36’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust36_moment_1

0

(‘amrvac’, ‘m2d36’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust36_moment_2

0

(‘amrvac’, ‘m3d36’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust36_moment_3

0

(‘amrvac’, ‘m1d37’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust37_moment_1

0

(‘amrvac’, ‘m2d37’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust37_moment_2

0

(‘amrvac’, ‘m3d37’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust37_moment_3

0

(‘amrvac’, ‘m1d38’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust38_moment_1

0

(‘amrvac’, ‘m2d38’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust38_moment_2

0

(‘amrvac’, ‘m3d38’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust38_moment_3

0

(‘amrvac’, ‘m1d39’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust39_moment_1

0

(‘amrvac’, ‘m2d39’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust39_moment_2

0

(‘amrvac’, ‘m3d39’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust39_moment_3

0

(‘amrvac’, ‘m1d40’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust40_moment_1

0

(‘amrvac’, ‘m2d40’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust40_moment_2

0

(‘amrvac’, ‘m3d40’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust40_moment_3

0

(‘amrvac’, ‘m1d41’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust41_moment_1

0

(‘amrvac’, ‘m2d41’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust41_moment_2

0

(‘amrvac’, ‘m3d41’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust41_moment_3

0

(‘amrvac’, ‘m1d42’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust42_moment_1

0

(‘amrvac’, ‘m2d42’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust42_moment_2

0

(‘amrvac’, ‘m3d42’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust42_moment_3

0

(‘amrvac’, ‘m1d43’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust43_moment_1

0

(‘amrvac’, ‘m2d43’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust43_moment_2

0

(‘amrvac’, ‘m3d43’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust43_moment_3

0

(‘amrvac’, ‘m1d44’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust44_moment_1

0

(‘amrvac’, ‘m2d44’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust44_moment_2

0

(‘amrvac’, ‘m3d44’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust44_moment_3

0

(‘amrvac’, ‘m1d45’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust45_moment_1

0

(‘amrvac’, ‘m2d45’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust45_moment_2

0

(‘amrvac’, ‘m3d45’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust45_moment_3

0

(‘amrvac’, ‘m1d46’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust46_moment_1

0

(‘amrvac’, ‘m2d46’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust46_moment_2

0

(‘amrvac’, ‘m3d46’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust46_moment_3

0

(‘amrvac’, ‘m1d47’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust47_moment_1

0

(‘amrvac’, ‘m2d47’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust47_moment_2

0

(‘amrvac’, ‘m3d47’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust47_moment_3

0

(‘amrvac’, ‘m1d48’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust48_moment_1

0

(‘amrvac’, ‘m2d48’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust48_moment_2

0

(‘amrvac’, ‘m3d48’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust48_moment_3

0

(‘amrvac’, ‘m1d49’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust49_moment_1

0

(‘amrvac’, ‘m2d49’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust49_moment_2

0

(‘amrvac’, ‘m3d49’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust49_moment_3

0

(‘amrvac’, ‘m1d50’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust50_moment_1

0

(‘amrvac’, ‘m2d50’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust50_moment_2

0

(‘amrvac’, ‘m3d50’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust50_moment_3

0

(‘amrvac’, ‘m1d51’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust51_moment_1

0

(‘amrvac’, ‘m2d51’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust51_moment_2

0

(‘amrvac’, ‘m3d51’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust51_moment_3

0

(‘amrvac’, ‘m1d52’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust52_moment_1

0

(‘amrvac’, ‘m2d52’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust52_moment_2

0

(‘amrvac’, ‘m3d52’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust52_moment_3

0

(‘amrvac’, ‘m1d53’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust53_moment_1

0

(‘amrvac’, ‘m2d53’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust53_moment_2

0

(‘amrvac’, ‘m3d53’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust53_moment_3

0

(‘amrvac’, ‘m1d54’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust54_moment_1

0

(‘amrvac’, ‘m2d54’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust54_moment_2

0

(‘amrvac’, ‘m3d54’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust54_moment_3

0

(‘amrvac’, ‘m1d55’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust55_moment_1

0

(‘amrvac’, ‘m2d55’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust55_moment_2

0

(‘amrvac’, ‘m3d55’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust55_moment_3

0

(‘amrvac’, ‘m1d56’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust56_moment_1

0

(‘amrvac’, ‘m2d56’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust56_moment_2

0

(‘amrvac’, ‘m3d56’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust56_moment_3

0

(‘amrvac’, ‘m1d57’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust57_moment_1

0

(‘amrvac’, ‘m2d57’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust57_moment_2

0

(‘amrvac’, ‘m3d57’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust57_moment_3

0

(‘amrvac’, ‘m1d58’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust58_moment_1

0

(‘amrvac’, ‘m2d58’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust58_moment_2

0

(‘amrvac’, ‘m3d58’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust58_moment_3

0

(‘amrvac’, ‘m1d59’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust59_moment_1

0

(‘amrvac’, ‘m2d59’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust59_moment_2

0

(‘amrvac’, ‘m3d59’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust59_moment_3

0

(‘amrvac’, ‘m1d60’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust60_moment_1

0

(‘amrvac’, ‘m2d60’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust60_moment_2

0

(‘amrvac’, ‘m3d60’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust60_moment_3

0

(‘amrvac’, ‘m1d61’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust61_moment_1

0

(‘amrvac’, ‘m2d61’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust61_moment_2

0

(‘amrvac’, ‘m3d61’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust61_moment_3

0

(‘amrvac’, ‘m1d62’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust62_moment_1

0

(‘amrvac’, ‘m2d62’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust62_moment_2

0

(‘amrvac’, ‘m3d62’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust62_moment_3

0

(‘amrvac’, ‘m1d63’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust63_moment_1

0

(‘amrvac’, ‘m2d63’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust63_moment_2

0

(‘amrvac’, ‘m3d63’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust63_moment_3

0

(‘amrvac’, ‘m1d64’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust64_moment_1

0

(‘amrvac’, ‘m2d64’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust64_moment_2

0

(‘amrvac’, ‘m3d64’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust64_moment_3

0

(‘amrvac’, ‘m1d65’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust65_moment_1

0

(‘amrvac’, ‘m2d65’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust65_moment_2

0

(‘amrvac’, ‘m3d65’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust65_moment_3

0

(‘amrvac’, ‘m1d66’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust66_moment_1

0

(‘amrvac’, ‘m2d66’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust66_moment_2

0

(‘amrvac’, ‘m3d66’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust66_moment_3

0

(‘amrvac’, ‘m1d67’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust67_moment_1

0

(‘amrvac’, ‘m2d67’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust67_moment_2

0

(‘amrvac’, ‘m3d67’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust67_moment_3

0

(‘amrvac’, ‘m1d68’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust68_moment_1

0

(‘amrvac’, ‘m2d68’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust68_moment_2

0

(‘amrvac’, ‘m3d68’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust68_moment_3

0

(‘amrvac’, ‘m1d69’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust69_moment_1

0

(‘amrvac’, ‘m2d69’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust69_moment_2

0

(‘amrvac’, ‘m3d69’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust69_moment_3

0

(‘amrvac’, ‘m1d70’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust70_moment_1

0

(‘amrvac’, ‘m2d70’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust70_moment_2

0

(‘amrvac’, ‘m3d70’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust70_moment_3

0

(‘amrvac’, ‘m1d71’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust71_moment_1

0

(‘amrvac’, ‘m2d71’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust71_moment_2

0

(‘amrvac’, ‘m3d71’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust71_moment_3

0

(‘amrvac’, ‘m1d72’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust72_moment_1

0

(‘amrvac’, ‘m2d72’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust72_moment_2

0

(‘amrvac’, ‘m3d72’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust72_moment_3

0

(‘amrvac’, ‘m1d73’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust73_moment_1

0

(‘amrvac’, ‘m2d73’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust73_moment_2

0

(‘amrvac’, ‘m3d73’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust73_moment_3

0

(‘amrvac’, ‘m1d74’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust74_moment_1

0

(‘amrvac’, ‘m2d74’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust74_moment_2

0

(‘amrvac’, ‘m3d74’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust74_moment_3

0

(‘amrvac’, ‘m1d75’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust75_moment_1

0

(‘amrvac’, ‘m2d75’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust75_moment_2

0

(‘amrvac’, ‘m3d75’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust75_moment_3

0

(‘amrvac’, ‘m1d76’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust76_moment_1

0

(‘amrvac’, ‘m2d76’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust76_moment_2

0

(‘amrvac’, ‘m3d76’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust76_moment_3

0

(‘amrvac’, ‘m1d77’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust77_moment_1

0

(‘amrvac’, ‘m2d77’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust77_moment_2

0

(‘amrvac’, ‘m3d77’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust77_moment_3

0

(‘amrvac’, ‘m1d78’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust78_moment_1

0

(‘amrvac’, ‘m2d78’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust78_moment_2

0

(‘amrvac’, ‘m3d78’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust78_moment_3

0

(‘amrvac’, ‘m1d79’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust79_moment_1

0

(‘amrvac’, ‘m2d79’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust79_moment_2

0

(‘amrvac’, ‘m3d79’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust79_moment_3

0

(‘amrvac’, ‘m1d80’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust80_moment_1

0

(‘amrvac’, ‘m2d80’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust80_moment_2

0

(‘amrvac’, ‘m3d80’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust80_moment_3

0

(‘amrvac’, ‘m1d81’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust81_moment_1

0

(‘amrvac’, ‘m2d81’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust81_moment_2

0

(‘amrvac’, ‘m3d81’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust81_moment_3

0

(‘amrvac’, ‘m1d82’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust82_moment_1

0

(‘amrvac’, ‘m2d82’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust82_moment_2

0

(‘amrvac’, ‘m3d82’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust82_moment_3

0

(‘amrvac’, ‘m1d83’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust83_moment_1

0

(‘amrvac’, ‘m2d83’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust83_moment_2

0

(‘amrvac’, ‘m3d83’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust83_moment_3

0

(‘amrvac’, ‘m1d84’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust84_moment_1

0

(‘amrvac’, ‘m2d84’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust84_moment_2

0

(‘amrvac’, ‘m3d84’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust84_moment_3

0

(‘amrvac’, ‘m1d85’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust85_moment_1

0

(‘amrvac’, ‘m2d85’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust85_moment_2

0

(‘amrvac’, ‘m3d85’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust85_moment_3

0

(‘amrvac’, ‘m1d86’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust86_moment_1

0

(‘amrvac’, ‘m2d86’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust86_moment_2

0

(‘amrvac’, ‘m3d86’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust86_moment_3

0

(‘amrvac’, ‘m1d87’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust87_moment_1

0

(‘amrvac’, ‘m2d87’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust87_moment_2

0

(‘amrvac’, ‘m3d87’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust87_moment_3

0

(‘amrvac’, ‘m1d88’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust88_moment_1

0

(‘amrvac’, ‘m2d88’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust88_moment_2

0

(‘amrvac’, ‘m3d88’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust88_moment_3

0

(‘amrvac’, ‘m1d89’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust89_moment_1

0

(‘amrvac’, ‘m2d89’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust89_moment_2

0

(‘amrvac’, ‘m3d89’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust89_moment_3

0

(‘amrvac’, ‘m1d90’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust90_moment_1

0

(‘amrvac’, ‘m2d90’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust90_moment_2

0

(‘amrvac’, ‘m3d90’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust90_moment_3

0

(‘amrvac’, ‘m1d91’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust91_moment_1

0

(‘amrvac’, ‘m2d91’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust91_moment_2

0

(‘amrvac’, ‘m3d91’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust91_moment_3

0

(‘amrvac’, ‘m1d92’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust92_moment_1

0

(‘amrvac’, ‘m2d92’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust92_moment_2

0

(‘amrvac’, ‘m3d92’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust92_moment_3

0

(‘amrvac’, ‘m1d93’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust93_moment_1

0

(‘amrvac’, ‘m2d93’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust93_moment_2

0

(‘amrvac’, ‘m3d93’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust93_moment_3

0

(‘amrvac’, ‘m1d94’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust94_moment_1

0

(‘amrvac’, ‘m2d94’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust94_moment_2

0

(‘amrvac’, ‘m3d94’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust94_moment_3

0

(‘amrvac’, ‘m1d95’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust95_moment_1

0

(‘amrvac’, ‘m2d95’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust95_moment_2

0

(‘amrvac’, ‘m3d95’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust95_moment_3

0

(‘amrvac’, ‘m1d96’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust96_moment_1

0

(‘amrvac’, ‘m2d96’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust96_moment_2

0

(‘amrvac’, ‘m3d96’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust96_moment_3

0

(‘amrvac’, ‘m1d97’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust97_moment_1

0

(‘amrvac’, ‘m2d97’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust97_moment_2

0

(‘amrvac’, ‘m3d97’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust97_moment_3

0

(‘amrvac’, ‘m1d98’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust98_moment_1

0

(‘amrvac’, ‘m2d98’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust98_moment_2

0

(‘amrvac’, ‘m3d98’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust98_moment_3

0

(‘amrvac’, ‘m1d99’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust99_moment_1

0

(‘amrvac’, ‘m2d99’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust99_moment_2

0

(‘amrvac’, ‘m3d99’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust99_moment_3

0

(‘amrvac’, ‘m1d100’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust100_moment_1

0

(‘amrvac’, ‘m2d100’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust100_moment_2

0

(‘amrvac’, ‘m3d100’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

dust100_moment_3

0

ART-Specific Fields

field name

units

aliases

particle?

display name

(‘art’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘art’, ‘TotalEnergy’)

\(\mathrm{\frac{\rm{code~mass} \cdot \rm{code~velocity}^{2}}{\rm{code~length}^{3}}}\)

total_energy_density

0

(‘art’, ‘XMomentumDensity’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘art’, ‘YMomentumDensity’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘art’, ‘ZMomentumDensity’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘art’, ‘Pressure’)

pressure

0

(‘art’, ‘Gamma’)

gamma

0

(‘art’, ‘GasEnergy’)

\(\mathrm{\frac{\rm{code~mass} \cdot \rm{code~velocity}^{2}}{\rm{code~length}^{3}}}\)

thermal_energy_density

0

(‘art’, ‘MetalDensitySNII’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

metal_ii_density

0

(‘art’, ‘MetalDensitySNIa’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

metal_ia_density

0

(‘art’, ‘PotentialNew’)

potential

0

(‘art’, ‘PotentialOld’)

gas_potential

0

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_velocity_x’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_y’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_z’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_index’)

1

(‘io’, ‘particle_species’)

particle_type

1

(‘io’, ‘particle_creation_time’)

\(\mathrm{\rm{Gyr}}\)

1

(‘io’, ‘particle_mass_initial’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_metallicity1’)

1

(‘io’, ‘particle_metallicity2’)

1

ARTIO-Specific Fields

field name

units

aliases

particle?

display name

(‘artio’, ‘HVAR_GAS_DENSITY’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘artio’, ‘HVAR_GAS_ENERGY’)

\(\mathrm{\frac{\rm{code~mass} \cdot \rm{code~velocity}^{2}}{\rm{code~length}^{3}}}\)

total_energy_density

0

(‘artio’, ‘HVAR_INTERNAL_ENERGY’)

\(\mathrm{\frac{\rm{code~mass} \cdot \rm{code~velocity}^{2}}{\rm{code~length}^{3}}}\)

thermal_energy_density

0

(‘artio’, ‘HVAR_PRESSURE’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

pressure

0

(‘artio’, ‘HVAR_MOMENTUM_X’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘artio’, ‘HVAR_MOMENTUM_Y’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘artio’, ‘HVAR_MOMENTUM_Z’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘artio’, ‘HVAR_GAMMA’)

gamma

0

(‘artio’, ‘HVAR_METAL_DENSITY_Ia’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

metal_ia_density

0

(‘artio’, ‘HVAR_METAL_DENSITY_II’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

metal_ii_density

0

(‘artio’, ‘VAR_POTENTIAL’)

potential

0

(‘artio’, ‘VAR_POTENTIAL_HYDRO’)

gas_potential

0

(‘artio’, ‘RT_HVAR_HI’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

H_density

0

(‘artio’, ‘RT_HVAR_HII’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

H_p1_density

0

(‘artio’, ‘RT_HVAR_H2’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

H2_density

0

(‘artio’, ‘RT_HVAR_HeI’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

He_density

0

(‘artio’, ‘RT_HVAR_HeII’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

He_p1_density

0

(‘artio’, ‘RT_HVAR_HeIII’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

He_p2_density

0

(‘io’, ‘POSITION_X’)

\(\mathrm{\rm{code~length}}\)

particle_position_x

1

(‘io’, ‘POSITION_Y’)

\(\mathrm{\rm{code~length}}\)

particle_position_y

1

(‘io’, ‘POSITION_Z’)

\(\mathrm{\rm{code~length}}\)

particle_position_z

1

(‘io’, ‘VELOCITY_X’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_x

1

(‘io’, ‘VELOCITY_Y’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_y

1

(‘io’, ‘VELOCITY_Z’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_z

1

(‘io’, ‘MASS’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘PID’)

particle_index

1

(‘io’, ‘SPECIES’)

particle_type

1

(‘io’, ‘BIRTH_TIME’)

1

(‘io’, ‘INITIAL_MASS’)

\(\mathrm{\rm{code~mass}}\)

initial_mass

1

(‘io’, ‘METALLICITY_SNIa’)

metallicity_snia

1

(‘io’, ‘METALLICITY_SNII’)

metallicity_snii

1

Athena-Specific Fields

field name

units

aliases

particle?

display name

(‘athena’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘athena’, ‘cell_centered_B_x’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘athena’, ‘cell_centered_B_y’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘athena’, ‘cell_centered_B_z’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘athena’, ‘total_energy’)

\(\mathrm{\rm{code~pressure}}\)

total_energy_density

0

(‘athena’, ‘gravitational_potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

0

AthenaPP-Specific Fields

field name

units

aliases

particle?

display name

(‘athena_pp’, ‘rho’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘athena_pp’, ‘dens’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘athena_pp’, ‘Bcc1’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘athena_pp’, ‘Bcc2’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘athena_pp’, ‘Bcc3’)

\(\mathrm{\rm{code~magnetic}}\)

0

AMReX-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘boxlib’, ‘eden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘boxlib’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘boxlib’, ‘xvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘yvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘zvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_x’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_y’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_z’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_id’)

particle_index

1

(‘io’, ‘particle_mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

Boxlib-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘boxlib’, ‘eden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘boxlib’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘boxlib’, ‘xvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘yvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘zvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_x’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_y’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_z’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_id’)

particle_index

1

(‘io’, ‘particle_mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

Castro-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

density

0

\(\rho\)

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}}\)

momentum_density_x

0

\(\rho u\)

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}}\)

momentum_density_y

0

\(\rho v\)

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{2} \cdot \rm{s}}}\)

momentum_density_z

0

\(\rho w\)

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

\(u\)

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

\(v\)

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

\(w\)

(‘boxlib’, ‘rho_E’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

total_energy_density

0

\(\rho E\)

(‘boxlib’, ‘rho_e’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\(\rho e\)

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

\(T\)

(‘boxlib’, ‘grav_x’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{g} \cdot \mathbf{e}_x\)

(‘boxlib’, ‘grav_y’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{g} \cdot \mathbf{e}_y\)

(‘boxlib’, ‘grav_z’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{g} \cdot \mathbf{e}_z\)

(‘boxlib’, ‘pressure’)

\(\mathrm{\frac{\rm{dyn}}{\rm{cm}^{2}}}\)

0

\(p\)

(‘boxlib’, ‘kineng’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

kinetic_energy_density

0

\(\frac{1}{2}\rho|\mathbf{U}|^2\)

(‘boxlib’, ‘soundspeed’)

\(\mathrm{\rm{cm} / \rm{s}}\)

sound_speed

0

\(Sound Speed\)

(‘boxlib’, ‘Machnumber’)

mach_number

0

\(Mach Number\)

(‘boxlib’, ‘entropy’)

\(\mathrm{\frac{\rm{erg}}{\rm{K} \cdot \rm{g}}}\)

entropy

0

\(s\)

(‘boxlib’, ‘magvort’)

\(\mathrm{1 / \rm{s}}\)

vorticity_magnitude

0

\(|\nabla \times \mathbf{U}|\)

(‘boxlib’, ‘divu’)

\(\mathrm{1 / \rm{s}}\)

velocity_divergence

0

\(\nabla \cdot \mathbf{U}\)

(‘boxlib’, ‘eint_E’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(e(E,U)\)

(‘boxlib’, ‘eint_e’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(e\)

(‘boxlib’, ‘magvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_magnitude

0

\(|\mathbf{U}|\)

(‘boxlib’, ‘radvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

radial_velocity

0

\(\mathbf{U} \cdot \mathbf{e}_r\)

(‘boxlib’, ‘magmom’)

\(\mathrm{\rm{cm} \cdot \rm{g} / \rm{s}}\)

momentum_magnitude

0

\(\rho |\mathbf{U}|\)

(‘boxlib’, ‘maggrav’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(|\mathbf{g}|\)

(‘boxlib’, ‘phiGrav’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(\Phi\)

(‘boxlib’, ‘enuc’)

\(\mathrm{\frac{\rm{erg}}{\rm{g} \cdot \rm{s}}}\)

0

\(\dot{e}_{\rm{nuc}}\)

(‘boxlib’, ‘rho_enuc’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3} \cdot \rm{s}}}\)

0

\(\rho \dot{e}_{\rm{nuc}}\)

(‘boxlib’, ‘angular_momentum_x’)

\(\mathrm{\frac{\rm{g}}{\rm{cm} \cdot \rm{s}}}\)

0

\(\ell_x\)

(‘boxlib’, ‘angular_momentum_y’)

\(\mathrm{\frac{\rm{g}}{\rm{cm} \cdot \rm{s}}}\)

0

\(\ell_y\)

(‘boxlib’, ‘angular_momentum_z’)

\(\mathrm{\frac{\rm{g}}{\rm{cm} \cdot \rm{s}}}\)

0

\(\ell_z\)

(‘boxlib’, ‘phiRot’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(\Phi_{\rm{rot}}\)

(‘boxlib’, ‘rot_x’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{f}_{\rm{rot}} \cdot \mathbf{e}_x\)

(‘boxlib’, ‘rot_y’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{f}_{\rm{rot}} \cdot \mathbf{e}_y\)

(‘boxlib’, ‘rot_z’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

\(\mathbf{f}_{\rm{rot}} \cdot \mathbf{e}_z\)

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

Maestro-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

density

0

(‘boxlib’, ‘x_vel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

\(\tilde{u}\)

(‘boxlib’, ‘y_vel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

\(\tilde{v}\)

(‘boxlib’, ‘z_vel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

\(\tilde{w}\)

(‘boxlib’, ‘magvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_magnitude

0

\(|\tilde{\mathbf{U}} + w_0 \mathbf{e}_r|\)

(‘boxlib’, ‘radial_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

radial_velocity

0

\(\mathbf{U}\cdot \mathbf{e}_r\)

(‘boxlib’, ‘circum_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

tangential_velocity

0

\(U - U\cdot e_r\)

(‘boxlib’, ‘tfromp’)

\(\mathrm{\rm{K}}\)

0

\(T(\rho,p,X)\)

(‘boxlib’, ‘tfromh’)

\(\mathrm{\rm{K}}\)

0

\(T(\rho,h,X)\)

(‘boxlib’, ‘Machnumber’)

mach_number

0

\(M\)

(‘boxlib’, ‘S’)

\(\mathrm{1 / \rm{s}}\)

0

(‘boxlib’, ‘ad_excess’)

0

\(\nabla - \nabla_\mathrm{ad}\)

(‘boxlib’, ‘deltaT’)

0

\([T(\rho,h,X) - T(\rho,p,X)]/T(\rho,h,X)\)

(‘boxlib’, ‘deltagamma’)

0

\(\Gamma_1 - \overline{\Gamma_1}\)

(‘boxlib’, ‘deltap’)

0

\([p(\rho,h,X) - p_0] / p_0\)

(‘boxlib’, ‘divw0’)

\(\mathrm{1 / \rm{s}}\)

0

\(\nabla \cdot \mathbf{w}_0\)

(‘boxlib’, ‘entropy’)

\(\mathrm{\frac{\rm{erg}}{\rm{K} \cdot \rm{g}}}\)

entropy

0

\(s\)

(‘boxlib’, ‘entropypert’)

0

\([s - \overline{s}] / \overline{s}\)

(‘boxlib’, ‘enucdot’)

\(\mathrm{\frac{\rm{erg}}{\rm{g} \cdot \rm{s}}}\)

0

\(\dot{\epsilon}_{nuc}\)

(‘boxlib’, ‘Hext’)

\(\mathrm{\frac{\rm{erg}}{\rm{g} \cdot \rm{s}}}\)

0

\(H_{ext}\)

(‘boxlib’, ‘gpi_x’)

\(\mathrm{\frac{\rm{dyn}}{\rm{cm}^{3}}}\)

0

\(\left(\nabla\pi\right)_x\)

(‘boxlib’, ‘gpi_y’)

\(\mathrm{\frac{\rm{dyn}}{\rm{cm}^{3}}}\)

0

\(\left(\nabla\pi\right)_y\)

(‘boxlib’, ‘gpi_z’)

\(\mathrm{\frac{\rm{dyn}}{\rm{cm}^{3}}}\)

0

\(\left(\nabla\pi\right)_z\)

(‘boxlib’, ‘h’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(h\)

(‘boxlib’, ‘h0’)

\(\mathrm{\rm{erg} / \rm{g}}\)

0

\(h_0\)

(‘boxlib’, ‘momentum’)

\(\mathrm{\rm{cm} \cdot \rm{g} / \rm{s}}\)

momentum_magnitude

0

\(\rho |\mathbf{U}|\)

(‘boxlib’, ‘p0’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\(p_0\)

(‘boxlib’, ‘p0pluspi’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\(p_0 + \pi\)

(‘boxlib’, ‘pi’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\(\pi\)

(‘boxlib’, ‘pioverp0’)

0

\(\pi/p_0\)

(‘boxlib’, ‘rho0’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

0

\(\rho_0\)

(‘boxlib’, ‘rhoh’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

enthalpy_density

0

\((\rho h)\)

(‘boxlib’, ‘rhoh0’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\((\rho h)_0\)

(‘boxlib’, ‘rhohpert’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

0

\((\rho h)^\prime\)

(‘boxlib’, ‘rhopert’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

0

\(\rho^\prime\)

(‘boxlib’, ‘soundspeed’)

\(\mathrm{\rm{cm} / \rm{s}}\)

sound_speed

0

(‘boxlib’, ‘sponge’)

0

(‘boxlib’, ‘tpert’)

\(\mathrm{\rm{K}}\)

0

\(T - \overline{T}\)

(‘boxlib’, ‘vort’)

\(\mathrm{1 / \rm{s}}\)

vorticity_magnitude

0

\(|\nabla\times\tilde{U}|\)

(‘boxlib’, ‘w0_x’)

\(\mathrm{\rm{cm} / \rm{s}}\)

0

\((w_0)_x\)

(‘boxlib’, ‘w0_y’)

\(\mathrm{\rm{cm} / \rm{s}}\)

0

\((w_0)_y\)

(‘boxlib’, ‘w0_z’)

\(\mathrm{\rm{cm} / \rm{s}}\)

0

\((w_0)_z\)

Nyx-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘boxlib’, ‘eden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘boxlib’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘boxlib’, ‘xvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘yvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘zvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_x’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_y’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_z’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_id’)

particle_index

1

(‘io’, ‘particle_mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

Orion-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘boxlib’, ‘eden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘boxlib’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘boxlib’, ‘xvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘yvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘zvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_x’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_y’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_z’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_id’)

particle_index

1

(‘io’, ‘particle_mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

WarpX-Specific Fields

field name

units

aliases

particle?

display name

(‘boxlib’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘boxlib’, ‘eden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘boxlib’, ‘xmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘boxlib’, ‘ymom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘boxlib’, ‘zmom’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘boxlib’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘Temp’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘boxlib’, ‘x_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘y_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘z_velocity’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘boxlib’, ‘xvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘boxlib’, ‘yvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘boxlib’, ‘zvel’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_x’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_y’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_angmomen_z’)

\(\mathrm{\rm{code~length}^{2} / \rm{code~time}}\)

1

(‘io’, ‘particle_id’)

particle_index

1

(‘io’, ‘particle_mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

Chimera-Specific Fields

field name

units

aliases

particle?

display name

(‘chimera’, ‘e_int’)

\(\mathrm{\rm{erg}}\)

Internal Energy

0

\(Internal Energy\)

(‘chimera’, ‘entropy’)

Entropy

0

(‘chimera’, ‘rho_c’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

density Density

0

\(Density\)

(‘chimera’, ‘dudt_nu’)

\(\mathrm{\rm{erg} / \rm{s}}\)

0

(‘chimera’, ‘dudt_nuc’)

\(\mathrm{\rm{erg} / \rm{s}}\)

0

(‘chimera’, ‘grav_x_c’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

(‘chimera’, ‘grav_y_c’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

(‘chimera’, ‘grav_z_c’)

\(\mathrm{\frac{\rm{cm}}{\rm{s}^{2}}}\)

0

(‘chimera’, ‘press’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

pressure

0

\(Pressure\)

(‘chimera’, ‘t_c’)

\(\mathrm{\rm{K}}\)

temperature

0

\(Temperature\)

(‘chimera’, ‘u_c’)

\(\mathrm{\rm{cm} / \rm{s}}\)

v_radial

0

\(Radial Velocity\)

(‘chimera’, ‘v_c’)

\(\mathrm{\rm{cm} / \rm{s}}\)

v_theta

0

\(Theta Velocity\)

(‘chimera’, ‘v_csound’)

0

(‘chimera’, ‘wBVMD’)

\(\mathrm{1 / \rm{s}}\)

0

\(BruntViasala_freq\)

(‘chimera’, ‘w_c’)

\(\mathrm{\rm{cm} / \rm{s}}\)

v_phi

0

\(Phi Velocity\)

(‘chimera’, ‘ye_c’)

0

(‘chimera’, ‘ylep’)

0

(‘chimera’, ‘a_nuc_rep_c’)

0

(‘chimera’, ‘be_nuc_rep_c’)

0

(‘chimera’, ‘e_book’)

0

(‘chimera’, ‘nse_c’)

0

(‘chimera’, ‘z_nuc_rep_c’)

0

Cholla-Specific Fields

field name

units

aliases

particle?

display name

(‘cholla’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘cholla’, ‘momentum_x’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_x

0

(‘cholla’, ‘momentum_y’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_y

0

(‘cholla’, ‘momentum_z’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_z

0

(‘cholla’, ‘Energy’)

\(\mathrm{\rm{code~pressure}}\)

total_energy_density

0

(‘cholla’, ‘scalar0’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

0

(‘cholla’, ‘metal_density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

metal_density

0

EnzoE-Specific Fields

field name

units

aliases

particle?

display name

(‘enzo_e’, ‘velocity_x’)

\(\mathrm{\rm{code~velocity}}\)

velocity_x

0

(‘enzo_e’, ‘velocity_y’)

\(\mathrm{\rm{code~velocity}}\)

velocity_y

0

(‘enzo_e’, ‘velocity_z’)

\(\mathrm{\rm{code~velocity}}\)

velocity_z

0

(‘enzo_e’, ‘acceleration_x’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

acceleration_x

0

(‘enzo_e’, ‘acceleration_y’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

acceleration_y

0

(‘enzo_e’, ‘acceleration_z’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

acceleration_z

0

(‘enzo_e’, ‘density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘enzo_e’, ‘density_total’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

total_density

0

(‘enzo_e’, ‘total_energy’)

\(\mathrm{\rm{code~velocity}^{2}}\)

specific_total_energy

0

(‘enzo_e’, ‘internal_energy’)

\(\mathrm{\rm{code~velocity}^{2}}\)

specific_thermal_energy

0

(‘enzo_e’, ‘bfield_x’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘enzo_e’, ‘bfield_y’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘enzo_e’, ‘bfield_z’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘enzo_e’, ‘bfieldi_x’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘enzo_e’, ‘bfieldi_y’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘enzo_e’, ‘bfieldi_z’)

\(\mathrm{\rm{code~magnetic}}\)

0

(‘io’, ‘x’)

\(\mathrm{\rm{code~length}}\)

particle_position_x

1

(‘io’, ‘y’)

\(\mathrm{\rm{code~length}}\)

particle_position_y

1

(‘io’, ‘z’)

\(\mathrm{\rm{code~length}}\)

particle_position_z

1

(‘io’, ‘vx’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_x

1

(‘io’, ‘vy’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_y

1

(‘io’, ‘vz’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_z

1

(‘io’, ‘ax’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

particle_acceleration_x

1

(‘io’, ‘ay’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

particle_acceleration_y

1

(‘io’, ‘az’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

particle_acceleration_z

1

(‘io’, ‘mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

FLASH-Specific Fields

field name

units

aliases

particle?

display name

(‘flash’, ‘velx’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

velocity_x

0

(‘flash’, ‘vely’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

velocity_y

0

(‘flash’, ‘velz’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

velocity_z

0

(‘flash’, ‘dens’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

0

(‘flash’, ‘temp’)

\(\mathrm{\rm{code~temperature}}\)

temperature

0

(‘flash’, ‘pres’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

pressure

0

(‘flash’, ‘gpot’)

\(\mathrm{\frac{\rm{code~length}^{2}}{\rm{code~time}^{2}}}\)

gravitational_potential

0

(‘flash’, ‘gpol’)

\(\mathrm{\frac{\rm{code~length}^{2}}{\rm{code~time}^{2}}}\)

0

(‘flash’, ‘tion’)

\(\mathrm{\rm{code~temperature}}\)

0

(‘flash’, ‘tele’)

\(\mathrm{\rm{code~temperature}}\)

0

(‘flash’, ‘trad’)

\(\mathrm{\rm{code~temperature}}\)

0

(‘flash’, ‘pion’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

0

(‘flash’, ‘pele’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

0

\(Electron Pressure, P_e\)

(‘flash’, ‘prad’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

0

\(Radiation Pressure\)

(‘flash’, ‘eion’)

\(\mathrm{\frac{\rm{code~length}^{2} \cdot \rm{code~mass}}{\rm{code~time}^{2}}}\)

0

\(Ion Internal Specific Energy\)

(‘flash’, ‘eele’)

\(\mathrm{\frac{\rm{code~length}^{2} \cdot \rm{code~mass}}{\rm{code~time}^{2}}}\)

0

\(Electron Internal Specific Energy\)

(‘flash’, ‘erad’)

\(\mathrm{\frac{\rm{code~length}^{2} \cdot \rm{code~mass}}{\rm{code~time}^{2}}}\)

0

\(Radiation Internal Specific Energy\)

(‘flash’, ‘pden’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

0

\(Particle Mass Density\)

(‘flash’, ‘depo’)

\(\mathrm{\frac{\rm{code~length}^{2}}{\rm{code~time}^{2}}}\)

0

(‘flash’, ‘ye’)

0

\(Y_e\)

(‘flash’, ‘magp’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

0

(‘flash’, ‘divb’)

\(\mathrm{\rm{code~magnetic} / \rm{code~length}}\)

0

(‘flash’, ‘game’)

0

\(\gamma_e\ \rm{(ratio\ of\ specific\ heats)}\)

(‘flash’, ‘gamc’)

0

\(\gamma_c\ \rm{(ratio\ of\ specific\ heats)}\)

(‘flash’, ‘flam’)

0

(‘flash’, ‘absr’)

0

\(Absorption Coefficient\)

(‘flash’, ‘emis’)

0

\(Emissivity\)

(‘flash’, ‘cond’)

0

\(Conductivity\)

(‘flash’, ‘dfcf’)

0

\(Diffusion Equation Scalar\)

(‘flash’, ‘fllm’)

0

\(Flux Limit\)

(‘flash’, ‘pipe’)

0

\(P_i/P_e\)

(‘flash’, ‘tite’)

0

\(T_i/T_e\)

(‘flash’, ‘dbgs’)

0

\(Debug for Shocks\)

(‘flash’, ‘cham’)

0

\(Chamber Material Fraction\)

(‘flash’, ‘targ’)

0

\(Target Material Fraction\)

(‘flash’, ‘sumy’)

0

(‘flash’, ‘mgdc’)

0

\(Emission Minus Absorption Diffusion Terms\)

(‘flash’, ‘magx’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_x\)

(‘flash’, ‘magy’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_y\)

(‘flash’, ‘magz’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_z\)

(‘io’, ‘particle_posx’)

\(\mathrm{\rm{code~length}}\)

particle_position_x

1

(‘io’, ‘particle_posy’)

\(\mathrm{\rm{code~length}}\)

particle_position_y

1

(‘io’, ‘particle_posz’)

\(\mathrm{\rm{code~length}}\)

particle_position_z

1

(‘io’, ‘particle_velx’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

particle_velocity_x

1

(‘io’, ‘particle_vely’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

particle_velocity_y

1

(‘io’, ‘particle_velz’)

\(\mathrm{\rm{code~length} / \rm{code~time}}\)

particle_velocity_z

1

(‘io’, ‘particle_tag’)

particle_index

1

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘particle_gpot’)

\(\mathrm{\frac{\rm{code~length}^{2}}{\rm{code~time}^{2}}}\)

particle_gravitational_potential

1

Gadget-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocity’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘MaximumTemperature’)

\(\mathrm{\rm{K}}\)

1

(‘io’, ‘Temperature’)

\(\mathrm{\rm{K}}\)

temperature

1

(‘io’, ‘Epsilon’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Metals’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Phi’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘FormationTime’)

\(\mathrm{\rm{code~time}}\)

creation_time

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘InitialMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘TrueMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ElevenMetalMasses’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ColdFraction’)

cold_fraction

1

(‘io’, ‘HotTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘CloudFraction’)

cold_fraction

1

(‘io’, ‘HotPhaseTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

ArepoHDF5-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocity’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘MaximumTemperature’)

\(\mathrm{\rm{K}}\)

1

(‘io’, ‘Temperature’)

\(\mathrm{\rm{K}}\)

temperature

1

(‘io’, ‘Epsilon’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Metals’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Phi’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘FormationTime’)

\(\mathrm{\rm{code~time}}\)

creation_time

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘InitialMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘TrueMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ElevenMetalMasses’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ColdFraction’)

cold_fraction

1

(‘io’, ‘HotTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘CloudFraction’)

cold_fraction

1

(‘io’, ‘HotPhaseTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

Eagle-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocity’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘MaximumTemperature’)

\(\mathrm{\rm{K}}\)

1

(‘io’, ‘Temperature’)

\(\mathrm{\rm{K}}\)

temperature

1

(‘io’, ‘Epsilon’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Metals’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Phi’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘FormationTime’)

\(\mathrm{\rm{code~time}}\)

creation_time

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘InitialMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘TrueMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ElevenMetalMasses’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ColdFraction’)

cold_fraction

1

(‘io’, ‘HotTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘CloudFraction’)

cold_fraction

1

(‘io’, ‘HotPhaseTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

GadgetFOF-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘GroupPos_0’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_x

1

(‘io’, ‘GroupPos_1’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_y

1

(‘io’, ‘GroupPos_2’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_z

1

(‘io’, ‘GroupVel_0’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_x

1

(‘io’, ‘GroupVel_1’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_y

1

(‘io’, ‘GroupVel_2’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_z

1

(‘io’, ‘GroupMass’)

\(\mathrm{\rm{code~mass}}\)

Group particle_mass

1

(‘io’, ‘GroupLen’)

Group particle_number

1

(‘io’, ‘GroupNsubs’)

Group subhalo_number

1

(‘io’, ‘GroupFirstSub’)

1

(‘io’, ‘Group_M_Crit200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_Crit500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_Mean200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_TopHat200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_R_Crit200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_Crit500’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_Mean200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_TopHat200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloPos_0’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_x

1

(‘io’, ‘SubhaloPos_1’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_y

1

(‘io’, ‘SubhaloPos_2’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_z

1

(‘io’, ‘SubhaloVel_0’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_x

1

(‘io’, ‘SubhaloVel_1’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_y

1

(‘io’, ‘SubhaloVel_2’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_z

1

(‘io’, ‘SubhaloMass’)

\(\mathrm{\rm{code~mass}}\)

Subhalo particle_mass

1

(‘io’, ‘SubhaloLen’)

Subhalo particle_number

1

(‘io’, ‘SubhaloCM_0’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_x

1

(‘io’, ‘SubhaloCM_1’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_y

1

(‘io’, ‘SubhaloCM_2’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_z

1

(‘io’, ‘SubhaloSpin_0’)

Subhalo spin_x

1

(‘io’, ‘SubhaloSpin_1’)

Subhalo spin_y

1

(‘io’, ‘SubhaloSpin_2’)

Subhalo spin_z

1

(‘io’, ‘SubhaloGrNr’)

Subhalo group_identifier

1

(‘io’, ‘SubhaloHalfmassRad’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloIDMostbound’)

1

(‘io’, ‘SubhaloMassInHalfRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloParent’)

1

(‘io’, ‘SubhaloVelDisp’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo velocity_dispersion

1

(‘io’, ‘SubhaloVmax’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘SubhaloVmaxRad’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

GadgetFOFHalo-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘GroupPos_0’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_x

1

(‘io’, ‘GroupPos_1’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_y

1

(‘io’, ‘GroupPos_2’)

\(\mathrm{\rm{code~length}}\)

Group particle_position_z

1

(‘io’, ‘GroupVel_0’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_x

1

(‘io’, ‘GroupVel_1’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_y

1

(‘io’, ‘GroupVel_2’)

\(\mathrm{\rm{code~velocity}}\)

Group particle_velocity_z

1

(‘io’, ‘GroupMass’)

\(\mathrm{\rm{code~mass}}\)

Group particle_mass

1

(‘io’, ‘GroupLen’)

Group particle_number

1

(‘io’, ‘GroupNsubs’)

Group subhalo_number

1

(‘io’, ‘GroupFirstSub’)

1

(‘io’, ‘Group_M_Crit200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_Crit500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_Mean200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_M_TopHat200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Group_R_Crit200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_Crit500’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_Mean200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Group_R_TopHat200’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloPos_0’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_x

1

(‘io’, ‘SubhaloPos_1’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_y

1

(‘io’, ‘SubhaloPos_2’)

\(\mathrm{\rm{code~length}}\)

Subhalo particle_position_z

1

(‘io’, ‘SubhaloVel_0’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_x

1

(‘io’, ‘SubhaloVel_1’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_y

1

(‘io’, ‘SubhaloVel_2’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo particle_velocity_z

1

(‘io’, ‘SubhaloMass’)

\(\mathrm{\rm{code~mass}}\)

Subhalo particle_mass

1

(‘io’, ‘SubhaloLen’)

Subhalo particle_number

1

(‘io’, ‘SubhaloCM_0’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_x

1

(‘io’, ‘SubhaloCM_1’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_y

1

(‘io’, ‘SubhaloCM_2’)

\(\mathrm{\rm{code~length}}\)

Subhalo center_of_mass_z

1

(‘io’, ‘SubhaloSpin_0’)

Subhalo spin_x

1

(‘io’, ‘SubhaloSpin_1’)

Subhalo spin_y

1

(‘io’, ‘SubhaloSpin_2’)

Subhalo spin_z

1

(‘io’, ‘SubhaloGrNr’)

Subhalo group_identifier

1

(‘io’, ‘SubhaloHalfmassRad’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloIDMostbound’)

1

(‘io’, ‘SubhaloMassInHalfRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRad’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloParent’)

1

(‘io’, ‘SubhaloVelDisp’)

\(\mathrm{\rm{code~velocity}}\)

Subhalo velocity_dispersion

1

(‘io’, ‘SubhaloVmax’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘SubhaloVmaxRad’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘GroupMassType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘GroupLenType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloLenType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_0’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_0’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_1’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_1’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_2’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_2’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_3’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_3’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_4’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_4’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloHalfmassRadType_5’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘SubhaloMassInHalfRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInMaxRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘SubhaloMassInRadType_5’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ID’)

member_ids

1

GAMER-Specific Fields

field name

units

aliases

particle?

display name

(‘gamer’, ‘Dens’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

0

(‘gamer’, ‘MomX’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_x

0

(‘gamer’, ‘MomY’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_y

0

(‘gamer’, ‘MomZ’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{2} \cdot \rm{code~time}}}\)

momentum_density_z

0

(‘gamer’, ‘Engy’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length} \cdot \rm{code~time}^{2}}}\)

total_energy_density

0

(‘gamer’, ‘Pote’)

\(\mathrm{\frac{\rm{code~length}^{2}}{\rm{code~time}^{2}}}\)

gravitational_potential

0

(‘gamer’, ‘CCMagX’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_x\)

(‘gamer’, ‘CCMagY’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_y\)

(‘gamer’, ‘CCMagZ’)

\(\mathrm{\rm{code~magnetic}}\)

0

\(B_z\)

(‘gamer’, ‘Real’)

\(\mathrm{\frac{\sqrt{\rm{code~mass}}}{\rm{code~length}^{3/2}}}\)

psidm_real_part

0

(‘gamer’, ‘Imag’)

\(\mathrm{\frac{\sqrt{\rm{code~mass}}}{\rm{code~length}^{3/2}}}\)

psidm_imaginary_part

0

(‘gamer’, ‘ParDens’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

particle_density_on_grid

0

(‘gamer’, ‘TotalDens’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

total_density_on_grid

0

(‘io’, ‘ParMass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘ParPosX’)

\(\mathrm{\rm{code~length}}\)

particle_position_x

1

(‘io’, ‘ParPosY’)

\(\mathrm{\rm{code~length}}\)

particle_position_y

1

(‘io’, ‘ParPosZ’)

\(\mathrm{\rm{code~length}}\)

particle_position_z

1

(‘io’, ‘ParVelX’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_x

1

(‘io’, ‘ParVelY’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_y

1

(‘io’, ‘ParVelZ’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity_z

1

(‘io’, ‘ParCreTime’)

\(\mathrm{\rm{code~time}}\)

particle_creation_time

1

GDF-Specific Fields

field name

units

aliases

particle?

display name

(‘gdf’, ‘density’)

\(\mathrm{\frac{\rm{g}}{\rm{cm}^{3}}}\)

density

0

(‘gdf’, ‘specific_energy’)

\(\mathrm{\rm{erg} / \rm{g}}\)

specific_thermal_energy

0

(‘gdf’, ‘pressure’)

\(\mathrm{\frac{\rm{erg}}{\rm{cm}^{3}}}\)

pressure

0

(‘gdf’, ‘temperature’)

\(\mathrm{\rm{K}}\)

temperature

0

(‘gdf’, ‘velocity_x’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_x

0

(‘gdf’, ‘velocity_y’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_y

0

(‘gdf’, ‘velocity_z’)

\(\mathrm{\rm{cm} / \rm{s}}\)

velocity_z

0

(‘gdf’, ‘mag_field_x’)

\(\mathrm{\rm{G}}\)

magnetic_field_x

0

(‘gdf’, ‘mag_field_y’)

\(\mathrm{\rm{G}}\)

magnetic_field_y

0

(‘gdf’, ‘mag_field_z’)

\(\mathrm{\rm{G}}\)

magnetic_field_z

0

Gizmo-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘ElectronAbundance’)

1

(‘io’, ‘NeutralHydrogenAbundance’)

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘Metallicity_01’)

He_metallicity

1

(‘io’, ‘Metallicity_02’)

C_metallicity

1

(‘io’, ‘Metallicity_03’)

N_metallicity

1

(‘io’, ‘Metallicity_04’)

O_metallicity

1

(‘io’, ‘Metallicity_05’)

Ne_metallicity

1

(‘io’, ‘Metallicity_06’)

Mg_metallicity

1

(‘io’, ‘Metallicity_07’)

Si_metallicity

1

(‘io’, ‘Metallicity_08’)

S_metallicity

1

(‘io’, ‘Metallicity_09’)

Ca_metallicity

1

(‘io’, ‘Metallicity_10’)

Fe_metallicity

1

(‘io’, ‘ArtificialViscosity’)

1

(‘io’, ‘MagneticField’)

\(\mathrm{\rm{code~magnetic}}\)

particle_magnetic_field

1

(‘io’, ‘DivergenceOfMagneticField’)

\(\mathrm{\rm{code~magnetic} / \rm{code~length}}\)

1

(‘io’, ‘StellarFormationTime’)

1

(‘io’, ‘BH_Mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘BH_Mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘BH_Mass_AlphaDisk’)

\(\mathrm{\rm{code~mass}}\)

1

CM1-Specific Fields

field name

units

aliases

particle?

display name

(‘nc4_cm1’, ‘uinterp’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_x

0

(‘nc4_cm1’, ‘vinterp’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_y

0

(‘nc4_cm1’, ‘winterp’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_z

0

(‘nc4_cm1’, ‘u’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_x

0

(‘nc4_cm1’, ‘v’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_y

0

(‘nc4_cm1’, ‘w’)

\(\mathrm{\rm{m} / \rm{s}}\)

velocity_z

0

(‘nc4_cm1’, ‘hwin_sr’)

\(\mathrm{\rm{m} / \rm{s}}\)

storm_relative_horizontal_wind_speed

0

(‘nc4_cm1’, ‘windmag_sr’)

\(\mathrm{\rm{m} / \rm{s}}\)

storm_relative_3D_wind_speed

0

(‘nc4_cm1’, ‘hwin_gr’)

\(\mathrm{\rm{m} / \rm{s}}\)

ground_relative_horizontal_wind_speed

0

(‘nc4_cm1’, ‘thpert’)

\(\mathrm{\rm{K}}\)

potential_temperature_perturbation

0

(‘nc4_cm1’, ‘thrhopert’)

\(\mathrm{\rm{K}}\)

density_potential_temperature_perturbation

0

(‘nc4_cm1’, ‘prespert’)

\(\mathrm{\rm{hPa}}\)

presure_perturbation

0

(‘nc4_cm1’, ‘rhopert’)

\(\mathrm{\frac{\rm{kg}}{\rm{m}^{3}}}\)

density_perturbation

0

(‘nc4_cm1’, ‘dbz’)

\(\mathrm{\rm{dB}}\)

simulated_reflectivity

0

(‘nc4_cm1’, ‘qvpert’)

\(\mathrm{\rm{g} / \rm{kg}}\)

water_vapor_mixing_ratio_perturbation

0

(‘nc4_cm1’, ‘qc’)

\(\mathrm{\rm{g} / \rm{kg}}\)

cloud_liquid_water_mixing_ratio

0

(‘nc4_cm1’, ‘qr’)

\(\mathrm{\rm{g} / \rm{kg}}\)

rain_mixing_ratio

0

(‘nc4_cm1’, ‘qi’)

\(\mathrm{\rm{g} / \rm{kg}}\)

cloud_ice_mixing_ratio

0

(‘nc4_cm1’, ‘qs’)

\(\mathrm{\rm{g} / \rm{kg}}\)

snow_mixing_ratio

0

(‘nc4_cm1’, ‘qg’)

\(\mathrm{\rm{g} / \rm{kg}}\)

graupel_or_hail_mixing_ratio

0

(‘nc4_cm1’, ‘qcloud’)

\(\mathrm{\rm{g} / \rm{kg}}\)

sum_of_cloud_water_and_cloud_ice_mixing_ratios

0

(‘nc4_cm1’, ‘qprecip’)

\(\mathrm{\rm{g} / \rm{kg}}\)

sum_of_rain_graupel_snow_mixing_ratios

0

(‘nc4_cm1’, ‘nci’)

\(\mathrm{\frac{1}{\rm{cm}^{3}}}\)

number_concerntration_of_cloud_ice

0

(‘nc4_cm1’, ‘ncr’)

\(\mathrm{\frac{1}{\rm{cm}^{3}}}\)

number_concentration_of_rain

0

(‘nc4_cm1’, ‘ncs’)

\(\mathrm{\frac{1}{\rm{cm}^{3}}}\)

number_concentration_of_snow

0

(‘nc4_cm1’, ‘ncg’)

\(\mathrm{\frac{1}{\rm{cm}^{3}}}\)

number_concentration_of_graupel_or_hail

0

(‘nc4_cm1’, ‘xvort’)

\(\mathrm{1 / \rm{s}}\)

vorticity_x

0

(‘nc4_cm1’, ‘yvort’)

\(\mathrm{1 / \rm{s}}\)

vorticity_y

0

(‘nc4_cm1’, ‘zvort’)

\(\mathrm{1 / \rm{s}}\)

vorticity_z

0

(‘nc4_cm1’, ‘hvort’)

\(\mathrm{1 / \rm{s}}\)

horizontal_vorticity_magnitude

0

(‘nc4_cm1’, ‘vortmag’)

\(\mathrm{1 / \rm{s}}\)

vorticity_magnitude

0

(‘nc4_cm1’, ‘streamvort’)

\(\mathrm{1 / \rm{s}}\)

streamwise_vorticity

0

(‘nc4_cm1’, ‘khh’)

\(\mathrm{\rm{m}^{2} / \rm{s}}\)

khh

0

(‘nc4_cm1’, ‘khv’)

\(\mathrm{\rm{m}^{2} / \rm{s}}\)

khv

0

(‘nc4_cm1’, ‘kmh’)

\(\mathrm{\rm{m}^{2} / \rm{s}}\)

kmh

0

(‘nc4_cm1’, ‘kmv’)

\(\mathrm{\rm{m}^{2} / \rm{s}}\)

kmv

0

OWLSSubfind-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘CenterOfMass_0’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_x

1

(‘io’, ‘CenterOfMass_1’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_y

1

(‘io’, ‘CenterOfMass_2’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_z

1

(‘io’, ‘CentreOfMass_0’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_x

1

(‘io’, ‘CentreOfMass_1’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_y

1

(‘io’, ‘CentreOfMass_2’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

particle_position_z

1

(‘io’, ‘CenterOfMassVelocity_0’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_x

1

(‘io’, ‘CenterOfMassVelocity_1’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_y

1

(‘io’, ‘CenterOfMassVelocity_2’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_z

1

(‘io’, ‘Velocity_0’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_x

1

(‘io’, ‘Velocity_1’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_y

1

(‘io’, ‘Velocity_2’)

\(\mathrm{1.0 \times 10^{5}~\rm{cm}/(1+z) / \rm{s}}\)

particle_velocity_z

1

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Halo_M_Crit200’)

\(\mathrm{\rm{code~mass}}\)

Virial Mass

1

(‘io’, ‘Halo_M_Crit2500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_M_Crit500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_M_Mean200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_M_Mean2500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_M_Mean500’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_M_TopHat200’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Halo_R_Crit200’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

Virial Radius

1

(‘io’, ‘Halo_R_Crit2500’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘Halo_R_Crit500’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘Halo_R_Mean200’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘Halo_R_Mean2500’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘Halo_R_Mean500’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘Halo_R_TopHat200’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘BH_Mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘Stars/Mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘BH_Mdot’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

RAMSES-Specific Fields

field name

units

aliases

particle?

display name

(‘ramses’, ‘Density’)

\(\mathrm{\rm{code~density}}\)

density

0

(‘ramses’, ‘x-velocity’)

\(\mathrm{\rm{code~velocity}}\)

velocity_x

0

(‘ramses’, ‘y-velocity’)

\(\mathrm{\rm{code~velocity}}\)

velocity_y

0

(‘ramses’, ‘z-velocity’)

\(\mathrm{\rm{code~velocity}}\)

velocity_z

0

(‘ramses’, ‘Pres_IR’)

\(\mathrm{\rm{code~pressure}}\)

pres_IR pressure_IR

0

(‘ramses’, ‘Pressure’)

\(\mathrm{\rm{code~pressure}}\)

pressure

0

(‘ramses’, ‘Metallicity’)

metallicity

0

(‘ramses’, ‘HII’)

H_p1_fraction

0

(‘ramses’, ‘HeII’)

He_p1_fraction

0

(‘ramses’, ‘HeIII’)

He_p2_fraction

0

(‘ramses’, ‘x-acceleration’)

\(\mathrm{\frac{\rm{code~length}}{\rm{code~time}^{2}}}\)

acceleration_x

0

(‘ramses’, ‘y-acceleration’)

\(\mathrm{\frac{\rm{code~length}}{\rm{code~time}^{2}}}\)

acceleration_y

0

(‘ramses’, ‘z-acceleration’)

\(\mathrm{\frac{\rm{code~length}}{\rm{code~time}^{2}}}\)

acceleration_z

0

(‘ramses’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

potential

0

(‘ramses’, ‘B_x_left’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_x_left

0

(‘ramses’, ‘B_x_right’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_x_right

0

(‘ramses’, ‘B_y_left’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_y_left

0

(‘ramses’, ‘B_y_right’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_y_right

0

(‘ramses’, ‘B_z_left’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_z_left

0

(‘ramses’, ‘B_z_right’)

\(\mathrm{\rm{code~magnetic}}\)

magnetic_field_z_right

0

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘particle_velocity_x’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_y’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_z’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_identity’)

particle_index

1

(‘io’, ‘particle_refinement_level’)

1

(‘io’, ‘particle_birth_time’)

\(\mathrm{\rm{code~time}}\)

age

1

(‘io’, ‘conformal_birth_time’)

1

(‘io’, ‘particle_metallicity’)

1

(‘io’, ‘particle_family’)

1

(‘io’, ‘particle_tag’)

1

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_angular_momentum_x’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} \cdot \rm{code~velocity}}\)

1

(‘io’, ‘particle_angular_momentum_y’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} \cdot \rm{code~velocity}}\)

1

(‘io’, ‘particle_angular_momentum_z’)

\(\mathrm{\rm{code~length} \cdot \rm{code~mass} \cdot \rm{code~velocity}}\)

1

(‘io’, ‘particle_formation_time’)

\(\mathrm{\rm{code~time}}\)

1

(‘io’, ‘particle_accretion_Rate’)

\(\mathrm{\rm{code~mass} / \rm{code~time}}\)

1

(‘io’, ‘particle_delta_mass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_rho_gas’)

\(\mathrm{\rm{code~density}}\)

1

(‘io’, ‘particle_cs**2’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_etherm’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘particle_velocity_x_gas’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_y_gas’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_velocity_z_gas’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘particle_mass_bh’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘particle_level’)

1

(‘io’, ‘particle_radius_star’)

\(\mathrm{\rm{code~length}}\)

1

Rockstar-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘particle_identifier’)

1

(‘io’, ‘particle_position_x’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘particle_position_y’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘particle_position_z’)

\(\mathrm{\rm{Mpc}/(1+z) / h}\)

1

(‘io’, ‘particle_velocity_x’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_velocity_y’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_velocity_z’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_corevel_x’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_corevel_y’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_corevel_z’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_bulkvel_x’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_bulkvel_y’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_bulkvel_z’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘particle_mass’)

\(\mathrm{\rm{M}_\odot / h}\)

1

\(Mass\)

(‘io’, ‘virial_radius’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

\(Radius\)

(‘io’, ‘child_r’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

(‘io’, ‘vmax_r’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘mgrav’)

1

(‘io’, ‘vmax’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(V_{max}\)

(‘io’, ‘rvmax’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

(‘io’, ‘rs’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

\(R_s\)

(‘io’, ‘klypin_rs’)

\(\mathrm{\rm{kpc}/(1+z) / h}\)

1

\(Klypin R_s\)

(‘io’, ‘vrms’)

\(\mathrm{\rm{km} / \rm{s}}\)

1

\(V_{rms}\)

(‘io’, ‘Jx’)

1

\(J_x\)

(‘io’, ‘Jy’)

1

\(J_y\)

(‘io’, ‘Jz’)

1

\(J_z\)

(‘io’, ‘energy’)

1

(‘io’, ‘spin’)

1

\(Spin Parameter\)

(‘io’, ‘alt_m1’)

\(\mathrm{\rm{M}_\odot / h}\)

1

(‘io’, ‘alt_m2’)

\(\mathrm{\rm{M}_\odot / h}\)

1

(‘io’, ‘alt_m3’)

\(\mathrm{\rm{M}_\odot / h}\)

1

(‘io’, ‘alt_m4’)

\(\mathrm{\rm{M}_\odot / h}\)

1

(‘io’, ‘Xoff’)

1

(‘io’, ‘Voff’)

1

(‘io’, ‘b_to_a’)

1

\(Ellipsoidal b to a\)

(‘io’, ‘c_to_a’)

1

\(Ellipsoidal c to a\)

(‘io’, ‘Ax’)

1

\(A_x\)

(‘io’, ‘Ay’)

1

\(A_y\)

(‘io’, ‘Az’)

1

\(A_z\)

(‘io’, ‘b_to_a2’)

1

(‘io’, ‘c_to_a2’)

1

(‘io’, ‘A2x’)

1

\(A2_x\)

(‘io’, ‘A2y’)

1

\(A2_y\)

(‘io’, ‘A2z’)

1

\(A2_z\)

(‘io’, ‘bullock_spin’)

1

\(Bullock Spin Parameter\)

(‘io’, ‘kin_to_pot’)

1

\(Kinetic to Potential\)

(‘io’, ‘m_pe_b’)

1

(‘io’, ‘m_pe_d’)

1

(‘io’, ‘num_p’)

1

\(Number of Particles\)

(‘io’, ‘num_child_particles’)

1

\(Number of Child Particles\)

(‘io’, ‘p_start’)

1

(‘io’, ‘desc’)

1

(‘io’, ‘flags’)

1

(‘io’, ‘n_core’)

1

(‘io’, ‘min_pos_err’)

1

(‘io’, ‘min_vel_err’)

1

(‘io’, ‘min_bulkvel_err’)

1

Swift-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocity’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘MaximumTemperature’)

\(\mathrm{\rm{K}}\)

1

(‘io’, ‘Temperature’)

\(\mathrm{\rm{K}}\)

temperature

1

(‘io’, ‘Epsilon’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Metals’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Phi’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘FormationTime’)

\(\mathrm{\rm{code~time}}\)

creation_time

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘InitialMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘TrueMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ElevenMetalMasses’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ColdFraction’)

cold_fraction

1

(‘io’, ‘HotTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘CloudFraction’)

cold_fraction

1

(‘io’, ‘HotPhaseTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

Tipsy-Specific Fields

field name

units

aliases

particle?

display name

(‘io’, ‘Mass’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Masses’)

\(\mathrm{\rm{code~mass}}\)

particle_mass

1

(‘io’, ‘Coordinates’)

\(\mathrm{\rm{code~length}}\)

particle_position

1

(‘io’, ‘Velocity’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘Velocities’)

\(\mathrm{\rm{code~velocity}}\)

particle_velocity

1

(‘io’, ‘ParticleIDs’)

particle_index

1

(‘io’, ‘InternalEnergy’)

\(\mathrm{\rm{code~specific~energy}}\)

specific_thermal_energy

1

(‘io’, ‘SmoothingLength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

(‘io’, ‘Density’)

\(\mathrm{\frac{\rm{code~mass}}{\rm{code~length}^{3}}}\)

density

1

(‘io’, ‘MaximumTemperature’)

\(\mathrm{\rm{K}}\)

1

(‘io’, ‘Temperature’)

\(\mathrm{\rm{K}}\)

temperature

1

(‘io’, ‘Epsilon’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Metals’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Metallicity’)

\(\mathrm{\rm{code~metallicity}}\)

metallicity

1

(‘io’, ‘Phi’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘Potential’)

\(\mathrm{\rm{code~velocity}^{2}}\)

gravitational_potential

1

(‘io’, ‘StarFormationRate’)

\(\mathrm{\rm{M}_\odot / \rm{yr}}\)

star_formation_rate

1

(‘io’, ‘FormationTime’)

\(\mathrm{\rm{code~time}}\)

creation_time

1

(‘io’, ‘Metallicity_00’)

metallicity

1

(‘io’, ‘InitialMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘TrueMass’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ElevenMetalMasses’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘ColdFraction’)

cold_fraction

1

(‘io’, ‘HotTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘CloudFraction’)

cold_fraction

1

(‘io’, ‘HotPhaseTemperature’)

\(\mathrm{\rm{code~temperature}}\)

hot_temperature

1

(‘io’, ‘smoothing_length’)

\(\mathrm{\rm{code~length}}\)

1

(‘io’, ‘uDotFB’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘uDotAV’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘uDotPdV’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘uDotHydro’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘uDotDiff’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘uDot’)

\(\mathrm{\rm{code~mass} \cdot \rm{code~velocity}^{2}}\)

1

(‘io’, ‘coolontime’)

\(\mathrm{\rm{code~time}}\)

1

(‘io’, ‘timeform’)

\(\mathrm{\rm{code~time}}\)

1

(‘io’, ‘massform’)

\(\mathrm{\rm{code~mass}}\)

1

(‘io’, ‘HI’)

\(\mathrm{}\)

H_fraction

1

(‘io’, ‘HII’)

\(\mathrm{}\)

H_p1_fraction

1

(‘io’, ‘HeI’)

\(\mathrm{}\)

He_fraction

1

(‘io’, ‘HeII’)

\(\mathrm{}\)

He_p2_fraction

1

(‘io’, ‘OxMassFrac’)

\(\mathrm{}\)

O_fraction

1

(‘io’, ‘FeMassFrac’)

\(\mathrm{}\)

Fe_fraction

1

(‘io’, ‘c’)

\(\mathrm{\rm{code~velocity}}\)

1

(‘io’, ‘acc’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

1

(‘io’, ‘accg’)

\(\mathrm{\rm{code~velocity} / \rm{code~time}}\)

1

(‘io’, ‘smoothlength’)

\(\mathrm{\rm{code~length}}\)

smoothing_length

1

Index of Fields