from IPython import display
"Image_Video_Files/movie_GasPres_timeseries.mp4", embed=True) display.Video(
In this tutorial post, I’ll show how to use Python-based data analysis and visualization tools to carry out exploratory and diagnostic data analysis of astrophysics simulations. We’ll be exploring simulations of the Large Magellanic Cloud (Bustard+ 2020), which is a dwarf satellite galaxy of the Milky Way actively blowing out gas in a “galactic wind” (shown below).
In this notebook (part I), we will extract a few mock observables from the dataset, including rotation measure (which is a probe of magnetic field strength) and ion column densities. Then we’ll make a few mock absorption line spectra comparable to that from the COS-Halos spectrograph aboard the Hubble Space Telescope.
In part II, we will plot values of “ram pressure” across the LMC disk and tabulate them at specific points where there are observational sightlines (this part, followed by an analysis of correlations between local ram pressure and observed ion abundances forms the basis for a funded Hubble Space Telescope (HST) grant (PI: Yong Zheng, Co-I: Chad Bustard)
Mock Observables from Models of the Large Magellanic Cloud
Background
Why were these simulations created?
How gas flows in and out of galaxies is an important and open question in galaxy formation and evolution. Large-scale supernova-driven outflows (or winds) from galaxies are prevalent throughout the Universe and can greatly impact galaxy evolution by quenching star formation and redistributing metals from the inner galaxy to the circumgalactic medium. The composition of these outflows and the physical processes that drive them, however, are not well understood, and there are large discrepancies between observations and theory. This project closes those gaps by creating synthetic, multi-wavelength observations of outflow simulations to be compared to observations from Chandra, HST, JWST, and other current and future telescopes.
Specifically, our simulations focus on the Large Magellanic Cloud (LMC), a dwarf galaxy roughly 50 kiloparsecs from the Milky Way that exhibits evidence for galactic winds. The LMC also has a rich interaction history with its neighbor, the Small Magellanic Cloud (SMC), which allows us to probe how a galaxy’s environment affects outflow generation and dynamics. While falling into the Milky Way halo, the Clouds orbit around each other, triggering bursts of star formation and also tearing each other apart as their gravitational forces loosen and strip material. Combined with the constant headwind they experience during their infall, their galactic dance flings gas behind the Clouds, contributing to the Trailing Magellanic Stream. This massive gaseous tail extending tens of kiloparsecs behind the Clouds may someday fall onto the Milky Way disk and enhance our Galactic ecosystem by providing more fuel to form stars. Fortunately, because of our birds-eye view, the Magellanic System gives us an incredible window into how galaxies expel and feed on gas; both the large-scale gas cycles in and between galaxies, as well as the small-scale, internal processes that drive gas flows.
More specifically, this project looks at the generation of supernova-driven outflows from the LMC and their interaction with ram pressure, the pressure that a galaxy feels as it moves through a static background. Individually, these processes are known to oppose gravity and remove gas from galaxies, but in concert, their effects are less well known.
What goes into these simulations?
In Bustard et al. 2018, we modeled individual, idealized gas outbursts from the LMC and their interaction with a headwind directed parallel to the LMC disk axis.
Here, in Bustard et al. 2020, we increase complexity and realism in important ways:
We use active particles in FLASH to represent clusters of stars that evolve and explode over a given time period, depositing energy and momentum to the surrounding cells according to the fitting functions of Martizzi et al. 2015 and the star cluster implementation of Semenov et al. 2016.
Part of the energy released from supernovae goes into cosmic rays. Cosmic rays are relativistic particles, comprising only about a billionth of all particles in the Milky Way, but their energies are so high that, collectively, the cosmic ray population has an equal importance to galaxy dynamics and thermodynamics. Cosmic rays are of specific interest because of their ability to help launch galactic outflows. The FLASH cosmic ray module we employ has been used in numerous galaxy-scale simulations as well as in recent localized simulations of a stratified ISM made unstable by cosmic ray streaming (Heintz, Bustard, and Zweibel 2020).
Probably the most novel part of these simulations…the creation of star cluster particles is directly tied to the spatially resolved star formation history of the LMC! Small-scale structures resolved by observations of the Magellanic Clouds, as well as the reconstructed star formation histories of the Clouds, afford us the opportunity to test the cumulative effects of various physical processes on outflow and fountain generation. Specifically, we have included into our model the derived star formation sites in the LMC over the past billion years. This is done by reading in data files containing the star formation rate at over 1300 (x,y) coordinates at 10 time snapshots. In between these coarse time snapshots, we randomly draw cluster masses from a probability distribution function, which we can vary, and populate each (x,y) coordinate with star clusters such that the total mass formed as stars matches the total mass known to form during that time interval. We leave the number of star forming events as a free parameter; fewer events necessitates either larger mass particles or more particles per event (supernovae that are more clustered), while more frequent events necessitates lower mass particles. This allows us to probe the effects of supernova clustering on outflow generation.
What do the full simulations look like?
The video below shows volume renderings of the LMC gas pressure over the course of a billion (simulated) years of LMC evolution, including the generation of supernova-driven outflows and ram pressure stripping of loosely connected gas.
In the following cells, we’ll take a closer look at the simulation data ourselves…
# Import all the packages we need
#!pip install --upgrade yt
#!pip install trident
!pip install aplpy
import yt
import trident
from trident import LightRay
import aplpy
import numpy as np
#import matplotlib as plt
from yt.units.yt_array import YTQuantity
from yt import YTArray
import h5py
import matplotlib.pyplot as plt
from astropy.io import fits
from astropy.table import Table
from astropy import wcs
from astropy.wcs import WCS
import csv
import pandas as pd
!pip install cmasher # a nice repository of colorblind-friendly, aesthetically pleasing colormaps
import cmasher as cmr
Requirement already satisfied: aplpy in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (2.1.0)
Requirement already satisfied: numpy in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (1.25.2)
Requirement already satisfied: astropy>=3.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (5.3.1)
Requirement already satisfied: matplotlib>=2.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (3.7.2)
Requirement already satisfied: reproject>=0.4 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (0.12.0)
Requirement already satisfied: pyregion>=2.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (2.2.0)
Requirement already satisfied: pillow>=4.3 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (10.0.0)
Requirement already satisfied: pyavm>=0.9.4 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (0.9.5)
Requirement already satisfied: scikit-image>=0.14 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (0.21.0)
Requirement already satisfied: shapely>=1.7 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from aplpy) (2.0.1)
Requirement already satisfied: pyerfa>=2.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from astropy>=3.1->aplpy) (2.0.0.3)
Requirement already satisfied: PyYAML>=3.13 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from astropy>=3.1->aplpy) (6.0.1)
Requirement already satisfied: packaging>=19.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from astropy>=3.1->aplpy) (23.1)
Requirement already satisfied: contourpy>=1.0.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (1.1.0)
Requirement already satisfied: cycler>=0.10 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (0.11.0)
Requirement already satisfied: fonttools>=4.22.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (4.42.0)
Requirement already satisfied: kiwisolver>=1.0.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (1.4.4)
Requirement already satisfied: pyparsing<3.1,>=2.3.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (3.0.9)
Requirement already satisfied: python-dateutil>=2.7 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.0->aplpy) (2.8.2)
Requirement already satisfied: astropy-healpix>=0.6 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (1.0.0)
Requirement already satisfied: scipy>=1.5 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (1.11.1)
Requirement already satisfied: dask[array]>=2021.8 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (2023.9.1)
Requirement already satisfied: cloudpickle in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (2.2.1)
Requirement already satisfied: zarr in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (2.16.1)
Requirement already satisfied: fsspec in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from reproject>=0.4->aplpy) (2023.9.0)
Requirement already satisfied: networkx>=2.8 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from scikit-image>=0.14->aplpy) (3.1)
Requirement already satisfied: imageio>=2.27 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from scikit-image>=0.14->aplpy) (2.31.1)
Requirement already satisfied: tifffile>=2022.8.12 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from scikit-image>=0.14->aplpy) (2023.7.18)
Requirement already satisfied: PyWavelets>=1.1.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from scikit-image>=0.14->aplpy) (1.4.1)
Requirement already satisfied: lazy_loader>=0.2 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from scikit-image>=0.14->aplpy) (0.3)
Requirement already satisfied: click>=8.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from dask[array]>=2021.8->reproject>=0.4->aplpy) (8.1.7)
Requirement already satisfied: partd>=1.2.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from dask[array]>=2021.8->reproject>=0.4->aplpy) (1.4.0)
Requirement already satisfied: toolz>=0.10.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from dask[array]>=2021.8->reproject>=0.4->aplpy) (0.12.0)
Requirement already satisfied: importlib-metadata>=4.13.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from dask[array]>=2021.8->reproject>=0.4->aplpy) (6.8.0)
Requirement already satisfied: six>=1.5 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from python-dateutil>=2.7->matplotlib>=2.0->aplpy) (1.16.0)
Requirement already satisfied: asciitree in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from zarr->reproject>=0.4->aplpy) (0.3.3)
Requirement already satisfied: fasteners in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from zarr->reproject>=0.4->aplpy) (0.18)
Requirement already satisfied: numcodecs>=0.10.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from zarr->reproject>=0.4->aplpy) (0.11.0)
Requirement already satisfied: zipp>=0.5 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from importlib-metadata>=4.13.0->dask[array]>=2021.8->reproject>=0.4->aplpy) (3.16.2)
Requirement already satisfied: entrypoints in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from numcodecs>=0.10.0->zarr->reproject>=0.4->aplpy) (0.4)
Requirement already satisfied: locket in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from partd>=1.2.0->dask[array]>=2021.8->reproject>=0.4->aplpy) (1.0.0)
Requirement already satisfied: cmasher in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (1.6.3)
Requirement already satisfied: colorspacious>=1.1.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from cmasher) (1.1.2)
Requirement already satisfied: e13tools>=0.9.4 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from cmasher) (0.9.6)
Requirement already satisfied: matplotlib>=2.2.4 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from cmasher) (3.7.2)
Requirement already satisfied: numpy>=1.16.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from cmasher) (1.25.2)
Requirement already satisfied: contourpy>=1.0.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (1.1.0)
Requirement already satisfied: cycler>=0.10 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (0.11.0)
Requirement already satisfied: fonttools>=4.22.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (4.42.0)
Requirement already satisfied: kiwisolver>=1.0.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (1.4.4)
Requirement already satisfied: packaging>=20.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (23.1)
Requirement already satisfied: pillow>=6.2.0 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (10.0.0)
Requirement already satisfied: pyparsing<3.1,>=2.3.1 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (3.0.9)
Requirement already satisfied: python-dateutil>=2.7 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from matplotlib>=2.2.4->cmasher) (2.8.2)
Requirement already satisfied: six>=1.5 in /Library/Frameworks/Python.framework/Versions/3.11/lib/python3.11/site-packages (from python-dateutil>=2.7->matplotlib>=2.2.4->cmasher) (1.16.0)
# Get the HDF5 file from my Google Drive
# Note: Can delete this cell if the HDF5 file is already downloaded
#!pip install gdown
#!gdown "https://drive.google.com/uc?id=1BCvIdYOA3VZj91Fdh9seOki0ww3Rqiky"
A first look at the simulation data
For the remainder of this notebook, we employ the yt
package, a visualization and analysis toolkit for astrophysics: https://yt-project.org/.
Let’s start by loading the present-day LMC snapshot and printing off the fields that yt
knows about. Then let’s take a look at density and temperature slices of the simulations parallel and perpendicular to the axis of the disk.
# Load our dataset with yt
# for large data files (or multiple files), yt can be parallelized with this command. Here we don't need it
yt.enable_parallelism()
# general way to load in a series of snapshots, in this case just the final snapshot of the 50 I output during the simulation
= yt.load("windCRs_hdf5_plt_cnt_0050")
ds
= ds.all_data()
dd
# just giving the simulation box periodic boundaries (so we can calculate gradients if we want to without throwing errors)
#ds.periodicity=(True,True,True)
# rearranging coordinates
1] = 0
ds.coordinates.x_axis[1] = 2
ds.coordinates.y_axis[
# Let's take a look at all the quantities or "fields" known to yt derived from the ~10 output variables in the HDF5 file
print(ds.derived_field_list)
yt : [ERROR ] 2023-09-13 16:08:02,635 Could not enable parallelism: mpi4py is not installed
yt : [INFO ] 2023-09-13 16:08:02,764 Parameters: current_time = 3.156010944496386e+16
yt : [INFO ] 2023-09-13 16:08:02,765 Parameters: domain_dimensions = [96 96 96]
yt : [INFO ] 2023-09-13 16:08:02,768 Parameters: domain_left_edge = [-6.171e+22 -6.171e+22 -6.171e+22]
yt : [INFO ] 2023-09-13 16:08:02,768 Parameters: domain_right_edge = [1.234e+23 1.234e+23 1.234e+23]
yt : [INFO ] 2023-09-13 16:08:02,768 Parameters: cosmological_simulation = 0
[('flash', 'cell_volume'), ('flash', 'cloo'), ('flash', 'cray'), ('flash', 'dens'), ('flash', 'dx'), ('flash', 'dy'), ('flash', 'dz'), ('flash', 'haco'), ('flash', 'hrat'), ('flash', 'igm '), ('flash', 'ism '), ('flash', 'magx'), ('flash', 'magy'), ('flash', 'magz'), ('flash', 'mtl '), ('flash', 'path_element_x'), ('flash', 'path_element_y'), ('flash', 'path_element_z'), ('flash', 'pres'), ('flash', 'temp'), ('flash', 'velx'), ('flash', 'vely'), ('flash', 'velz'), ('flash', 'volume'), ('flash', 'x'), ('flash', 'y'), ('flash', 'z'), ('gas', 'alfven_speed'), ('gas', 'angular_momentum_magnitude'), ('gas', 'angular_momentum_x'), ('gas', 'angular_momentum_y'), ('gas', 'angular_momentum_z'), ('gas', 'averaged_density'), ('gas', 'baroclinic_vorticity_magnitude'), ('gas', 'baroclinic_vorticity_x'), ('gas', 'baroclinic_vorticity_y'), ('gas', 'baroclinic_vorticity_z'), ('gas', 'cell_mass'), ('gas', 'cell_volume'), ('gas', 'courant_time_step'), ('gas', 'cutting_plane_magnetic_field_x'), ('gas', 'cutting_plane_magnetic_field_y'), ('gas', 'cutting_plane_magnetic_field_z'), ('gas', 'cutting_plane_velocity_x'), ('gas', 'cutting_plane_velocity_y'), ('gas', 'cutting_plane_velocity_z'), ('gas', 'density'), ('gas', 'density_gradient_magnitude'), ('gas', 'density_gradient_x'), ('gas', 'density_gradient_y'), ('gas', 'density_gradient_z'), ('gas', 'dx'), ('gas', 'dy'), ('gas', 'dynamical_time'), ('gas', 'dz'), ('gas', 'four_velocity_magnitude'), ('gas', 'four_velocity_t'), ('gas', 'four_velocity_x'), ('gas', 'four_velocity_y'), ('gas', 'four_velocity_z'), ('gas', 'jeans_mass'), ('gas', 'kT'), ('gas', 'kinetic_energy_density'), ('gas', 'lorentz_factor'), ('gas', 'mach_alfven'), ('gas', 'mach_number'), ('gas', 'magnetic_energy_density'), ('gas', 'magnetic_field_cylindrical_radius'), ('gas', 'magnetic_field_cylindrical_theta'), ('gas', 'magnetic_field_cylindrical_z'), ('gas', 'magnetic_field_divergence'), ('gas', 'magnetic_field_divergence_absolute'), ('gas', 'magnetic_field_los'), ('gas', 'magnetic_field_magnitude'), ('gas', 'magnetic_field_poloidal'), ('gas', 'magnetic_field_poloidal_magnitude'), ('gas', 'magnetic_field_spherical_phi'), ('gas', 'magnetic_field_spherical_radius'), ('gas', 'magnetic_field_spherical_theta'), ('gas', 'magnetic_field_strength'), ('gas', 'magnetic_field_toroidal'), ('gas', 'magnetic_field_toroidal_magnitude'), ('gas', 'magnetic_field_x'), ('gas', 'magnetic_field_y'), ('gas', 'magnetic_field_z'), ('gas', 'magnetic_pressure'), ('gas', 'mass'), ('gas', 'mean_molecular_weight'), ('gas', 'momentum_density_x'), ('gas', 'momentum_density_y'), ('gas', 'momentum_density_z'), ('gas', 'momentum_x'), ('gas', 'momentum_y'), ('gas', 'momentum_z'), ('gas', 'number_density'), ('gas', 'path_element_x'), ('gas', 'path_element_y'), ('gas', 'path_element_z'), ('gas', 'plasma_beta'), ('gas', 'pressure'), ('gas', 'pressure_gradient_magnitude'), ('gas', 'pressure_gradient_x'), ('gas', 'pressure_gradient_y'), ('gas', 'pressure_gradient_z'), ('gas', 'radial_mach_number'), ('gas', 'radial_magnetic_field'), ('gas', 'radial_magnetic_field_absolute'), ('gas', 'radial_velocity'), ('gas', 'radial_velocity_absolute'), ('gas', 'relative_magnetic_field_x'), ('gas', 'relative_magnetic_field_y'), ('gas', 'relative_magnetic_field_z'), ('gas', 'relative_velocity_x'), ('gas', 'relative_velocity_y'), ('gas', 'relative_velocity_z'), ('gas', 'shear'), ('gas', 'shear_criterion'), ('gas', 'shear_mach'), ('gas', 'sound_speed'), ('gas', 'specific_angular_momentum_magnitude'), ('gas', 'specific_angular_momentum_x'), ('gas', 'specific_angular_momentum_y'), ('gas', 'specific_angular_momentum_z'), ('gas', 'tangential_magnetic_field'), ('gas', 'tangential_over_magnetic_field_magnitude'), ('gas', 'tangential_over_velocity_magnitude'), ('gas', 'tangential_velocity'), ('gas', 'temperature'), ('gas', 'velocity_cylindrical_radius'), ('gas', 'velocity_cylindrical_theta'), ('gas', 'velocity_cylindrical_z'), ('gas', 'velocity_divergence'), ('gas', 'velocity_divergence_absolute'), ('gas', 'velocity_los'), ('gas', 'velocity_magnitude'), ('gas', 'velocity_spherical_phi'), ('gas', 'velocity_spherical_radius'), ('gas', 'velocity_spherical_theta'), ('gas', 'velocity_x'), ('gas', 'velocity_y'), ('gas', 'velocity_z'), ('gas', 'volume'), ('gas', 'vorticity_growth_magnitude'), ('gas', 'vorticity_growth_magnitude_absolute'), ('gas', 'vorticity_growth_timescale'), ('gas', 'vorticity_growth_x'), ('gas', 'vorticity_growth_y'), ('gas', 'vorticity_growth_z'), ('gas', 'vorticity_magnitude'), ('gas', 'vorticity_squared'), ('gas', 'vorticity_stretching_magnitude'), ('gas', 'vorticity_stretching_x'), ('gas', 'vorticity_stretching_y'), ('gas', 'vorticity_stretching_z'), ('gas', 'vorticity_x'), ('gas', 'vorticity_y'), ('gas', 'vorticity_z'), ('gas', 'x'), ('gas', 'y'), ('gas', 'z'), ('index', 'cell_volume'), ('index', 'cylindrical_radius'), ('index', 'cylindrical_theta'), ('index', 'cylindrical_z'), ('index', 'dx'), ('index', 'dy'), ('index', 'dz'), ('index', 'grid_indices'), ('index', 'grid_level'), ('index', 'morton_index'), ('index', 'ones'), ('index', 'ones_over_dx'), ('index', 'path_element_x'), ('index', 'path_element_y'), ('index', 'path_element_z'), ('index', 'radius'), ('index', 'spherical_phi'), ('index', 'spherical_radius'), ('index', 'spherical_theta'), ('index', 'virial_radius_fraction'), ('index', 'volume'), ('index', 'x'), ('index', 'y'), ('index', 'z'), ('index', 'zeros')]
Let’s take a quick look at the simulations to see what we have. We’ll start with Slice plots, which just look at a 2D array of cells, both in the plane of the disk and vertical to the plane of the disk.
# Plot a slice of the hydrogen number density -- # of hydrogen particles per cubic centimeter -- in the plane of the disk
= ("gas","number_density")
field = yt.SlicePlot(ds, "z", field,center = (0,0,0), width=(20, 'kpc'))
proj =field, cmap='cmr.eclipse')
proj.set_cmap(fieldr"Density (cm$^{-3}$)")
proj.set_colorbar_label(field, 1e-3,1e0)
proj.set_zlim(field,
proj.annotate_timestamp()
proj.show()
= yt.SlicePlot(ds, "x", field,center = (0,0,0), width=(20, 'kpc'))
proj =field, cmap='cmr.eclipse')
proj.set_cmap(fieldr"Density (cm$^{-3}$)")
proj.set_colorbar_label(field, 1e-3,1e0)
proj.set_zlim(field,
proj.annotate_timestamp()
proj.show()
= ("gas","temperature")
field = yt.SlicePlot(ds, "z", field,center = (0,0,0), width=(20, 'kpc'))
proj =field, cmap='cmr.eclipse')
proj.set_cmap(fieldr"Temperature (K)")
proj.set_colorbar_label(field, 1e3,1e7)
proj.set_zlim(field,
proj.annotate_timestamp()
proj.show()
= yt.SlicePlot(ds, "x", field,center = (0,0,0), width=(20, 'kpc'))
proj =field, cmap='cmr.eclipse')
proj.set_cmap(fieldr"Temperature (K)")
proj.set_colorbar_label(field, 1e3,1e7)
proj.set_zlim(field,
proj.annotate_timestamp() proj.show()
yt : [INFO ] 2023-09-13 16:08:03,989 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:03,989 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:03,990 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:03,990 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:03,992 Making a fixed resolution buffer of (('gas', 'number_density')) 800 by 800
yt : [INFO ] 2023-09-13 16:08:04,561 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,562 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,563 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,563 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,563 Making a fixed resolution buffer of (('gas', 'number_density')) 800 by 800
yt : [INFO ] 2023-09-13 16:08:04,921 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,921 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,922 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,923 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:04,923 Making a fixed resolution buffer of (('gas', 'temperature')) 800 by 800
yt : [INFO ] 2023-09-13 16:08:05,441 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,441 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,442 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,442 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,442 Making a fixed resolution buffer of (('gas', 'temperature')) 800 by 800
We can see a lot of interesting physics at play here, as well as some info about the simulation methodology.
First, you might notice in the last figure, which shows a vertical view of the temperature, that the actual cells of the simulation are noticeable in the region far above the disk. This is because we derefine the grid in areas with lower density. The cells are more densely spaced near the center of the galaxy, specifically at regions where the gas density is highest; this technique is called adaptive mesh refinement (AMR) and is commonly used to focus resolution on certain areas of the simulation box. In this case, every n timesteps in the simulation (here set to be ~100 timesteps), the grid will re-assess the gas density and restructure itself. This technique saves on computation time and memory. If the entire simulation domain were tiled by small cells, the simulation would be intractable.
Second, check out the structures that have formed in the LMC disk. Clusters of supernova explosions have heated and ejected the gas (as one can see in the vertical slices), carving out hot, diffuse holes surrounded by dense shells. This is exactly what we see when we observe a neutral hydrogen map of the LMC, and we will confirm that later in this exercise when we create mock HI column density maps, as well as maps of other common and useful ions.
Of course, this is just an example “slice” in the plane of the disk. In reality, we see the full, integrated column of gas along our line of sight, which is at an angle to the disk orientation. Let’s show that view instead…
# density projection along the line of sight
= [-0.561,0.099,0.822] # vector normal to cutting plane
L = [0,0,1]
north_vector
# Plot the column density (projected density)
= ("gas","number_density")
field = yt.OffAxisProjectionPlot(ds, L, field,center = (0,0,0), width=(20, 'kpc'))
proj =field, cmap='cmr.eclipse')
proj.set_cmap(fieldr"Column Density (cm$^{-2}$)")
proj.set_colorbar_label(field, 1.E19, 5.E21)
proj.set_zlim(field,
proj.annotate_timestamp() proj.show()
yt : [INFO ] 2023-09-13 16:08:05,762 xlim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,762 ylim = -30856775809623249649664.000000 30856775809623249649664.000000
yt : [INFO ] 2023-09-13 16:08:05,762 zlim = -92554999999999995019264.000000 92554999999999995019264.000000
yt : [INFO ] 2023-09-13 16:08:05,763 Making a fixed resolution buffer of (('gas', 'number_density')) 800 by 800
Towards a better comparison to real observations
So far we’ve made a column density map along the line-of-sight to the LMC, which is a good start, but that is still not exactly what we get from observations.
- Observations are typically plotted in Right Ascension (RA), Declination (DEC) coordinates
- Observations never give us the full gas density…instead we obtain abundances of different ions, which exist at certain densities and temperatures
- Ion abundances are obtained through e.g. absorption line spectroscopy. So what we ultimately want, to best compare to observations, are maps of various ion column densities and mock absorption lines through different sightlines.
Let’s start by using the astropy
package to convert from simulation coordinates to RA, DEC coordinates
# Restrict our plot to just the galaxy (cells with an ISM tag > 0.6)
= dd.cut_region('(obj["ism "] > 0.6)')
cut_data
= yt.FITSOffAxisProjection(ds,L,field,center = (0,0,0),width=(20, 'kpc'),data_source=cut_data)
prj_fits = [79.0,-68.68] # in degrees, what Jack told me to use
sky_center = (4123.71, "arcsec/kpc") # could also use a YTQuantity
sky_scale =["RA---TAN","DEC--TAN"], replace_old_wcs=True)
prj_fits.create_sky_wcs(sky_center, sky_scale, ctype"LMC_H.fits",overwrite=True) prj_fits.writeto(
yt : [INFO ] 2023-09-13 16:08:19,662 Making a FITS image of field number_density
# We'll plot images multiple times, so let's make this a function
# Requires: file -- file name, e.g. "LMC_H.fits"
# Requires: ion -- ion name, e.g. "H"
# Requires: min_max = (min, max) of field value for colorbar = (1e19,5e21) by default
def plotFits(file,ion,min_max=(1e19,5e21)):
= fits.getdata(file)
image_data print(type(image_data))
print(image_data.shape)
= min_max
vmin,vmax = aplpy.FITSFigure(file)
fig
fig.add_grid()="cmr.eclipse",stretch = 'log', vmin=vmin, vmax = vmax)
fig.show_colorscale(cmap"top")
fig.tick_labels.set_xposition(8.0)
fig.ticks.set_xspacing(8.0)
fig.ticks.set_yspacing(
fig.add_colorbar()+ r' Column Density (cm$^{-2}$)')
fig.colorbar.set_axis_label_text(ion
# fig.tick_labels.set_xformat('hh:mm')
'dd')
fig.tick_labels.set_xformat('dd')
fig.tick_labels.set_yformat(# fig.set_theme('pretty')
#fig.colorbar.show(log_format=False)
=20) fig.colorbar.set_font(size
"LMC_H.fits", "H",min_max=(1e19,5e21)) plotFits(
<class 'numpy.ndarray'>
(512, 512)
Let’s now separate out different ions instead of showing the full gas column density. Here, we use the Trident package, which assumes that the gas is in photoionization equilibrium (PIE) with the metagalactic UV background. I wrote a new radiative cooling / heating routine in the FLASH simulations that uses the same assumption, calculating cooling rates as a function of the evolving gas density, metallicity, and temperature. So this is a consistent assumption.
# I've created and output a few relevant *tracers* with values in [0,1] from the FLASH simulations: metallicity and concentration of ISM (interstellar medium) matter
# Trident needs the metallicity field to be called "metallicity", so do this here..
def _metallicity(field, data):
= data['mtl ']
val return val
# add the new metallicity field and weight it by ISM concentration so we preferentially select the galaxy instead of the background
'gas', 'metallicity'), function=_metallicity, units='dimensionless',sampling_type='cell', force_override=True)
ds.add_field((
# Based on that metallicity and the PIE assumption, tell Trident to calculate HI, HII, and OVI abundances
# Note: As of YT 4.0, these fields seem to be included without needing to add them with Trident.
=['H I', 'H II', 'Si II', 'Si III', 'Si IV', 'O VI'], ftype="gas")
trident.add_ion_fields(ds, ions
# create all the projections, write them to FITS files for later use, and make initial mock images
# this may take a few minutes
= yt.FITSOffAxisProjection(ds,L,'H_p0_number_density',center = (0,0,0),width=(20, 'kpc'),data_source=cut_data)
prj_fits =["RA---TAN","DEC--TAN"], replace_old_wcs=True)
prj_fits.create_sky_wcs(sky_center, sky_scale, ctype"LMC_HI.fits", overwrite=True)
prj_fits.writeto(
= yt.FITSOffAxisProjection(ds,L,'H_p1_number_density',center = (0,0,0),width=(20, 'kpc'),data_source=cut_data)
prj_fits =["RA---TAN","DEC--TAN"], replace_old_wcs=True)
prj_fits.create_sky_wcs(sky_center, sky_scale, ctype"LMC_HII.fits", overwrite=True) prj_fits.writeto(
yt : [INFO ] 2023-09-13 16:08:31,718 Making a FITS image of field H_p0_number_density
yt : [INFO ] 2023-09-13 16:08:43,008 Making a FITS image of field H_p1_number_density
# Make images
"LMC_HI.fits", "H I")
plotFits("LMC_HII.fits", "H II") plotFits(
<class 'numpy.ndarray'>
(512, 512)
<class 'numpy.ndarray'>
(512, 512)
HI probes neutral hydrogen, which is quite abundant in the LMC disk
HII probes singly ionized hydrogen. The fact that there is a significant column of ionized hydrogen suggests that estimates of total LMC gas mass from just neutral hydrogen are underestimates; instead, this simulated LMC appears to have a diffuse halo of ionized gas surrounding the disk, in this case developed from ram pressure stripping and galactic outflows driven by supernovae.
Mock COS-Halos spectra
Finally, observations rarely can produce a beautiful, full map of ion densities. Instead, we rely on absorption line spectroscopy along many lines of sight (rays) puncturing the LMC disk and pointed towards either background quasars (very bright objects) or bright stars in the LMC disk. Using Trident, we can create mock spectra according to the specifications of the COS-Halos spectrograph aboard HST.
In the following, we’ll use Trident to get Si II and Si III spectra along two rays probing the near-side of the LMC disk (the background light source is assumed to be a bright LMC star instead of a background quasar). We’ll compare spectral widths, which give a measure of the turbulent velocity dispersion, and then create velocity dispersion maps to make more sense of our spectra.
# Somewhat boring stuff where I've modified the Trident plotting function to accept multiple rays on one plot
from yt.funcs import \
mylogimport numpy as np
import matplotlib.figure
from matplotlib.backends.backend_agg import \
FigureCanvasAgg
# Define a helper unit to convert units
def kpc2codeunits(ds, kpc_array):
# A function which takes coordinates in kpc
# and returns a YTArray in code_length
= 1000*3.0856775809623245e+18
KPC2CM = YTQuantity(kpc_array[0],'kpc').in_cgs()
x = YTQuantity(kpc_array[1],'kpc').in_cgs()
y = YTQuantity(kpc_array[2],'kpc').in_cgs()
z = ds.arr([x, y, z],'code_length')
pos return pos
# Trident function modified by Chad
def plot_spectrum_Chad(wavelength, flux, filename="spectrum.png",
=None, flux_limits=None,
lambda_limits=None, label=None, figsize=None, step=False,
title=0.2, features=None, axis_labels=None):
stagger"""
Plot a spectrum or a collection of spectra and save to disk.
This function wraps some Matplotlib plotting functionality for
plotting spectra generated with the :class:`~trident.SpectrumGenerator`.
In its simplest form, it accepts a wavelength array consisting of
wavelength values and a corresponding flux array consisting of relative
flux values, and it plots them and saves to disk.
In addition, it can plot several spectra on the same axes simultaneously
by passing a list of arrays to the ``wavelength``, ``flux`` arguments
(and optionally to the ``label`` and ``step`` keywords).
Returns the Matplotlib Figure object for further processing.
**Parameters**
:wavelength: array of floats or list of arrays of floats
Wavelength values in angstroms. Either as an array of floats in the
case of plotting a single spectrum, or as a list of arrays of floats
in the case of plotting several spectra on the same axes.
:flux: array of floats or list of arrays of floats
Relative flux values (from 0 to 1) corresponding to wavelength array.
Either as an array of floats in the case of plotting a single
spectrum, or as a list of arrays of floats in the case of plotting
several spectra on the same axes.
:filename: string, optional
Output filename of the plotted spectrum. Will be a png file.
Default: 'spectrum.png'
:lambda_limits: tuple or list of floats, optional
The minimum and maximum of the wavelength range (x-axis) for the plot
in angstroms. If specified as None, will use whole lambda range
of spectrum. Example: (1200, 1400) for 1200-1400 Angstroms
Default: None
:flux_limits: tuple or list of floats, optional
The minimum and maximum of the flux range (y-axis) for the plot.
If specified as None, limits are automatically from
[0, 1.1*max(flux)]. Example: (0, 1) for normal flux range before
postprocessing.
Default: None
:step: boolean or list of booleans, optional
Plot the spectrum as a series of step functions. Appropriate for
plotting processed and noisy data. Use a list of booleans when
plotting multiple spectra, where each boolean corresponds to the entry
in the ``wavelength`` and ``flux`` lists.
:title: string, optional
Optional title for plot
Default: None
:label: string or list of strings, optional
Label for each spectrum to be plotted. Useful if plotting multiple
spectra simultaneously. Will automatically trigger a legend to be
generated.
Default: None
:stagger: float, optional
If plotting multiple spectra on the same axes, do we offset them in
the y direction? If set to None, no. If set to a float, stagger them
by the flux value specified by this parameter.
:features: dict, optional
Include vertical lines with labels to represent certain spectral
features. Each entry in the dictionary consists of a key string to
be overplot and the value float as to where in wavelength space it
will be plot as a vertical line with the corresponding label.
Example: features={'Ly a' : 1216, 'Ly b' : 1026}
Default: None
:axis_labels: tuple of strings, optional
Optionally set the axis labels directly. If set to None, defaults to
('Wavelength [$\\rm\\AA$]', 'Relative Flux').
Default: None
**Returns**
Matplotlib Figure object for further processing
**Example**
Plot a flat spectrum
>>> import numpy as np
>>> import trident
>>> wavelength = np.arange(1200, 1400)
>>> flux = np.ones(len(wavelength))
>>> trident.plot_spectrum(wavelength, flux)
Generate a one-zone ray, create a Lyman alpha spectrum from it, and add
gaussian noise to it. Plot both the raw spectrum and the noisy spectrum
on top of each other.
>>> import trident
>>> ray = trident.make_onezone_ray(column_densities={'H_p0_number_density':1e21})
>>> sg_final = trident.SpectrumGenerator(lambda_min=1200, lambda_max=1300, dlambda=0.5)
>>> sg_final.make_spectrum(ray, lines=['Ly a'])
>>> sg_final.save_spectrum('spec_raw.h5')
>>> sg_final.add_gaussian_noise(10)
>>> sg_raw = trident.load_spectrum('spec_raw.h5')
>>> trident.plot_spectrum([sg_raw.lambda_field, sg_final.lambda_field],
... [sg_raw.flux_field, sg_final.flux_field], stagger=0, step=[False, True],
... label=['Raw', 'Noisy'], filename='raw_and_noise.png')
"""
= 20
myfsize
# number of rows and columns
= 1
n_rows = 1
n_columns
# blank space between edge of figure and active plot area
= 0.07
top_buffer = 0.15
bottom_buffer = 0.06
left_buffer = 0.03
right_buffer
# blank space between plots
= 0.05
hor_buffer = 0.05
vert_buffer
# calculate the height and width of each panel
= ((1.0 - left_buffer - right_buffer -
panel_width -1)*hor_buffer)) / n_columns)
((n_columns= ((1.0 - top_buffer - bottom_buffer -
panel_height -1)*vert_buffer)) / n_rows)
((n_rows
# create a figure (figsize is in inches)
if figsize is None:
= (12, 4)
figsize = matplotlib.figure.Figure(figsize=figsize, frameon=True)
figure
# get the row and column number
= 0
my_row = 0
my_column
# calculate the position of the bottom, left corner of this plot
= left_buffer + (my_column * panel_width) + \
left_side * hor_buffer
my_column = 1.0 - (top_buffer + (my_row * panel_height) + \
top_side * vert_buffer)
my_row = top_side - panel_height
bottom_side # create an axes object on which we will make the plot
= figure.add_axes((left_side, bottom_side, panel_width, panel_height))
my_axes
# Are we overplotting several spectra? or just one?
if not (isinstance(wavelength, list) and isinstance(flux, list)):
= [wavelength]
wavelengths = [flux]
fluxs = [label]
labels = [step]
steps else:
= wavelength
wavelengths = flux
fluxs if label is not None:
= label
labels else:
= [None]*len(fluxs)
labels if step is not None:
= step
steps else:
= [None]*len(fluxs)
steps
# A running maximum of flux for use in ylim scaling in final plot
= 0.
max_flux
for i, (wavelength, flux) in enumerate(zip(wavelengths, fluxs)):
# Do we stagger the fluxes?
if stagger is not None:
-= stagger * i
flux
# Do we include labels and a legend?
if steps[i]:
=labels[i])
my_axes.step(wavelength, flux, labelelse:
=labels[i])
my_axes.plot(wavelength, flux, label
= np.max(flux)
new_max_flux if new_max_flux > max_flux:
= new_max_flux
max_flux
# Return the fluxes to their normal values
# if they've been staggered
if stagger is not None:
+= stagger * i
flux
# Do we include a title?
if title is not None:
my_axes.set_title(title)
if lambda_limits is None:
= (wavelength.min(), wavelength.max())
lambda_limits 0], lambda_limits[1])
my_axes.set_xlim(lambda_limits[
if flux_limits is None:
= (0, 1.1*max_flux)
flux_limits 0], flux_limits[1])
my_axes.set_ylim(flux_limits[if axis_labels is None:
= ('Wavelength [$\\rm\\AA$]', 'Relative Flux')
axis_labels 0],fontsize=myfsize)
my_axes.xaxis.set_label_text(axis_labels[1],fontsize=myfsize)
my_axes.yaxis.set_label_text(axis_labels[
# Don't let the x-axis switch to offset values for tick labels
False)
my_axes.get_xaxis().get_major_formatter().set_useOffset(
for tick in my_axes.xaxis.get_major_ticks():
14)
tick.label.set_fontsize(for tick in my_axes.yaxis.get_major_ticks():
14)
tick.label.set_fontsize(
if label is not None: my_axes.legend(fontsize=14)
# Overplot the relevant features on the plot
if features is not None:
for feature in features:
= feature
label = features[feature]
wavelength # Draw line
'--', color='k')
my_axes.plot([wavelength, wavelength], flux_limits, # Write text
= flux_limits[1] - 0.05*(flux_limits[1] - flux_limits[0])
text_location
my_axes.text(wavelength, text_location, label,# horizontalalignment='left',
='right',
horizontalalignment# verticalalignment='top', rotation='horizontal',fontsize=14)
='top', rotation='vertical',fontsize=12)
verticalalignment
"Writing spectrum plot to png file: %s" % filename)
mylog.info(= FigureCanvasAgg(figure)
canvas
canvas.print_figure(filename)return figure
# If not already created, create a directory called LightRays to store the ray.h5 files in
import os
# Directory
= "LightRays"
directory
if (os.path.exists(directory)==False):
os.mkdir(directory)print("Directory '% s' created" % directory)
# Let's probe two different regions of the disk. The first ray will puncture close to the center, while another ray will puncture further out
= [-3.0,-3.0,0.0]
start_coords1 = [-3.0-0.561*10.0,-3.0-0.099*10.0,-0.822*10.0]
end_coords1 = kpc2codeunits(ds, start_coords1)
ray_start1 = kpc2codeunits(ds, end_coords1)
ray_end1 = 'ray1'
rayName1 ='all' # let Trident know about all the absorption lines
line_list
= [3.0,7.0,0.0]
start_coords2 = [3.0-0.561*10.0,7.0-0.099*10.0,-0.822*10.0]
end_coords2 = kpc2codeunits(ds, start_coords2)
ray_start2 = kpc2codeunits(ds, end_coords2)
ray_end2 = 'ray2'
rayName2 ='all'
line_list
= trident.make_simple_ray(ds,
ray1 =ray_start1,
start_position=ray_end1,
end_position=rayName1+'.h5',
data_filename=line_list,
lines='gas')
ftype
= trident.make_simple_ray(ds,
ray2 =ray_start2,
start_position=ray_end2,
end_position=rayName2+'.h5',
data_filename=line_list,
lines='gas')
ftype
# Show where the light rays start and end
= yt.ProjectionPlot(ds, 1, 'density', weight_field='ism ')
q
q.annotate_timestamp()=True)
q.annotate_ray(ray1, arrow=True)
q.annotate_ray(ray2, arrow'density', 'cmr.eclipse')
q.set_cmap('density', 1e-28, 1e-24)
q.set_zlim( q.show()
yt : [INFO ] 2023-09-13 16:08:45,157 Getting segment at z = 0.0: [-0.05000828 -0.05000828 0. ] unitary to [-0.14352376 -0.06651101 -0.13702269] unitary.
yt : [INFO ] 2023-09-13 16:08:45,158 Getting subsegment: [-0.05000828 -0.05000828 0. ] unitary to [-0.14352376 -0.06651101 -0.13702269] unitary.
yt : [INFO ] 2023-09-13 16:08:45,196 Saving field data to yt dataset: ray1.h5.
yt : [INFO ] 2023-09-13 16:08:45,306 Parameters: current_time = 3.156010944496386e+16 code_time
yt : [INFO ] 2023-09-13 16:08:45,306 Parameters: domain_dimensions = [1 1 1]
yt : [INFO ] 2023-09-13 16:08:45,306 Parameters: domain_left_edge = [-6.171e+22 -6.171e+22 -6.171e+22] code_length
yt : [INFO ] 2023-09-13 16:08:45,307 Parameters: domain_right_edge = [1.234e+23 1.234e+23 1.234e+23] code_length
yt : [INFO ] 2023-09-13 16:08:45,307 Parameters: cosmological_simulation = 0
yt : [INFO ] 2023-09-13 16:08:45,313 Getting segment at z = 0.0: [0.05000828 0.11668599 0. ] unitary to [-0.0435072 0.10018325 -0.13702269] unitary.
yt : [INFO ] 2023-09-13 16:08:45,313 Getting subsegment: [0.05000828 0.11668599 0. ] unitary to [-0.0435072 0.10018325 -0.13702269] unitary.
yt : [INFO ] 2023-09-13 16:08:45,350 Saving field data to yt dataset: ray2.h5.
yt : [INFO ] 2023-09-13 16:08:45,449 Parameters: current_time = 3.156010944496386e+16 code_time
yt : [INFO ] 2023-09-13 16:08:45,449 Parameters: domain_dimensions = [1 1 1]
yt : [INFO ] 2023-09-13 16:08:45,450 Parameters: domain_left_edge = [-6.171e+22 -6.171e+22 -6.171e+22] code_length
yt : [INFO ] 2023-09-13 16:08:45,450 Parameters: domain_right_edge = [1.234e+23 1.234e+23 1.234e+23] code_length
yt : [INFO ] 2023-09-13 16:08:45,450 Parameters: cosmological_simulation = 0
yt : [INFO ] 2023-09-13 16:08:46,473 Projection completed
yt : [INFO ] 2023-09-13 16:08:46,475 xlim = -61709999999999992135680.000000 123399999999999997902848.000000
yt : [INFO ] 2023-09-13 16:08:46,475 ylim = -61709999999999992135680.000000 123399999999999997902848.000000
yt : [INFO ] 2023-09-13 16:08:46,477 xlim = -61709999999999992135680.000000 123399999999999997902848.000000
yt : [INFO ] 2023-09-13 16:08:46,477 ylim = -61709999999999992135680.000000 123399999999999997902848.000000
yt : [INFO ] 2023-09-13 16:08:46,478 Making a fixed resolution buffer of (('gas', 'density')) 800 by 800
Now let’s generate a spectrum. Let’s focus on wavelengths between 1150 and 1300 angstroms, where we’ll find Si II and Si III lines
= 1150, 1300
lambda_min,lambda_max = trident.SpectrumGenerator(lambda_min=lambda_min, lambda_max=lambda_max, dlambda=0.01)
sg1 ='all', use_peculiar_velocity=True,
sg1.make_spectrum(ray1, lines=True)
store_observables
sg1.add_milky_way_foreground()='avg_COS.txt')
sg1.apply_lsf(filename30)
sg1.add_gaussian_noise('LightRays/spec_all_ray1.h5')
sg1.save_spectrum(
= trident.SpectrumGenerator(lambda_min=lambda_min, lambda_max=lambda_max, dlambda=0.01)
sg2 ='all', use_peculiar_velocity=True,
sg2.make_spectrum(ray2, lines=True)
store_observables
sg2.add_milky_way_foreground()='avg_COS.txt')
sg2.apply_lsf(filename30)
sg2.add_gaussian_noise('LightRays/spec_all_ray2.h5') sg2.save_spectrum(
yt : [INFO ] 2023-09-13 16:08:46,798 Setting instrument to Custom
yt : [INFO ] 2023-09-13 16:08:46,824 Allocating for 107 particles
yt : [INFO ] 2023-09-13 16:08:46,875 Using all 213 available lines in 'lines.txt'.
yt : [INFO ] 2023-09-13 16:08:46,877 Creating C_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,882 Creating C_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,884 Creating C_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,886 Creating C_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,887 Creating N_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,892 Creating N_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,894 Creating N_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,896 Creating N_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,897 Creating N_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,899 Creating O_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,904 Creating O_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,906 Creating O_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,907 Creating O_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,909 Creating O_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,911 Creating Ne_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,917 Creating Ne_p5_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,919 Creating Ne_p6_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,922 Creating Ne_p7_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,925 Creating Na_p8_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,930 Creating Mg_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,936 Creating Mg_p9_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,938 Creating Al_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,944 Creating Al_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,947 Creating Si_p11_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,953 Creating P_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,957 Creating P_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,960 Creating S_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,967 Creating S_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,970 Creating S_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,974 Creating S_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,976 Creating S_p5_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,979 Creating S_p13_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,982 Creating Ar_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,989 Creating Ar_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,993 Creating Ar_p6_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:46,996 Creating Ca_p9_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:47,004 Creating Fe_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:47,015 Creating spectrum
Adding line - Ly a [1215.670000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly a [1215.670000 A]: 13%|█▎ | 14/107 [00:00<00:00, 131.32it/s]Adding line - Ly a [1215.670000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 650.00it/s]
Adding line - Ly b [1025.722200 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly b [1025.722200 A]: 99%|█████████▉| 106/107 [00:00<00:00, 5378.81it/s]
Adding line - Ly c [972.536740 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly c [972.536740 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9047.36it/s]
Adding line - Ly d [949.742980 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly d [949.742980 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9102.00it/s]
Adding line - Ly e [937.803400 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly e [937.803400 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9651.92it/s]
Adding line - Ly 6 [930.748200 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 6 [930.748200 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9746.07it/s]
Adding line - Ly 7 [926.225640 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 7 [926.225640 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9831.41it/s]
Adding line - Ly 8 [923.150300 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 8 [923.150300 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9819.47it/s]
Adding line - Ly 9 [920.963026 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 9 [920.963026 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9747.14it/s]
Adding line - Ly 10 [919.351351 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 10 [919.351351 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9593.81it/s]
Adding line - Ly 11 [918.129312 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 11 [918.129312 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9650.24it/s]
Adding line - Ly 12 [917.180525 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 12 [917.180525 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9706.28it/s]
Adding line - Ly 13 [916.429085 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 13 [916.429085 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9875.97it/s]
Adding line - Ly 14 [915.823759 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 14 [915.823759 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9692.95it/s]
Adding line - Ly 15 [915.328939 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 15 [915.328939 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9716.89it/s]
Adding line - Ly 16 [914.919249 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 16 [914.919249 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9869.61it/s]
Adding line - Ly 17 [914.576207 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 17 [914.576207 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9785.11it/s]
Adding line - Ly 18 [914.286092 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 18 [914.286092 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9765.98it/s]
Adding line - Ly 19 [914.038542 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 19 [914.038542 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9709.67it/s]
Adding line - Ly 20 [913.825614 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 20 [913.825614 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9796.75it/s]
Adding line - Ly 21 [913.641137 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 21 [913.641137 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9920.48it/s]
Adding line - Ly 22 [913.480256 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 22 [913.480256 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9862.38it/s]
Adding line - Ly 23 [913.339110 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 23 [913.339110 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9838.59it/s]
Adding line - Ly 24 [913.214596 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 24 [913.214596 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10011.40it/s]
Adding line - Ly 25 [913.104199 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 25 [913.104199 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9834.89it/s]
Adding line - Ly 26 [913.005863 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 26 [913.005863 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9785.97it/s]
Adding line - Ly 27 [912.917891 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 27 [912.917891 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9828.37it/s]
Adding line - Ly 28 [912.838877 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 28 [912.838877 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9979.27it/s]
Adding line - Ly 29 [912.767643 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 29 [912.767643 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9861.51it/s]
Adding line - Ly 30 [912.703200 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 30 [912.703200 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9963.16it/s]
Adding line - Ly 31 [912.644712 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 31 [912.644712 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10050.32it/s]
Adding line - Ly 32 [912.591467 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 32 [912.591467 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10005.77it/s]
Adding line - Ly 33 [912.542856 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 33 [912.542856 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10149.21it/s]
Adding line - Ly 34 [912.498356 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 34 [912.498356 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10034.22it/s]
Adding line - Ly 35 [912.457516 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 35 [912.457516 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10259.52it/s]
Adding line - Ly 36 [912.419946 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 36 [912.419946 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10211.92it/s]
Adding line - Ly 37 [912.385306 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 37 [912.385306 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10211.92it/s]
Adding line - Ly 38 [912.353298 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 38 [912.353298 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10134.86it/s]
Adding line - Ly 39 [912.323663 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly 39 [912.323663 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10010.50it/s]
Adding line - C I 1657 [1656.929000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1657 [1656.929000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 13164.25it/s]
Adding line - C I 1560 [1560.309000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1560 [1560.309000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14156.41it/s]
Adding line - C I 1329 [1328.834000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1329 [1328.834000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15064.93it/s]
Adding line - C I 1280 [1280.135000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1280 [1280.135000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15795.51it/s]
Adding line - C I 1277 [1277.245000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1277 [1277.245000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 11604.01it/s]
Adding line - C I 1261 [1260.735000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1261 [1260.735000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14808.52it/s]
Adding line - C I 1194 [1193.995000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1194 [1193.995000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 17266.54it/s]
Adding line - C I 1193 [1193.031000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1193 [1193.031000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15617.95it/s]
Adding line - C I 1189 [1188.833000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1189 [1188.833000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 17319.68it/s]
Adding line - C I 1158 [1157.910000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C I 1158 [1157.910000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16648.43it/s]
Adding line - C II* 1336 [1335.663000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C II* 1336 [1335.663000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14292.02it/s]
Adding line - C II 1335 [1334.532000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C II 1335 [1334.532000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7348.94it/s]
yt : [INFO ] 2023-09-13 16:08:47,770 26 out of 107 line components are unresolved.
Adding line - C II* 1037 [1037.018000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C II* 1037 [1037.018000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 3418.58it/s]
yt : [INFO ] 2023-09-13 16:08:47,802 27 out of 107 line components are unresolved.
Adding line - C II 1036 [1036.337000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C II 1036 [1036.337000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 4424.42it/s]
yt : [INFO ] 2023-09-13 16:08:47,827 33 out of 107 line components are unresolved.
Adding line - C II 904 [903.962000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C II 904 [903.962000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 2261.14it/s]
yt : [INFO ] 2023-09-13 16:08:47,877 31 out of 107 line components are unresolved.
Adding line - C III 977 [977.020000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C III 977 [977.020000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 4732.36it/s]
Adding line - C IV 1551 [1550.772000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C IV 1551 [1550.772000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16043.45it/s]
Adding line - C IV 1548 [1548.187000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - C IV 1548 [1548.187000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14916.83it/s]
Adding line - N I 1201 [1200.710000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1201 [1200.710000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 11389.10it/s]
Adding line - N I 1200 [1200.223000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1200 [1200.223000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10381.21it/s]
Adding line - N I 1200 [1199.550000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1200 [1199.550000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19037.26it/s]
yt : [INFO ] 2023-09-13 16:08:47,947 3 out of 107 line components are unresolved.
Adding line - N I 1135 [1134.980000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1135 [1134.980000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15132.10it/s]
Adding line - N I 1134 [1134.415000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1134 [1134.415000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16768.99it/s]
Adding line - N I 1134 [1134.165000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 1134 [1134.165000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22893.73it/s]
yt : [INFO ] 2023-09-13 16:08:47,968 33 out of 107 line components are unresolved.
Adding line - N I 965 [965.041000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 965 [965.041000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20760.00it/s]
Adding line - N I 965 [964.626000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 965 [964.626000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19343.73it/s]
Adding line - N I 964 [963.990000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 964 [963.990000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18291.62it/s]
Adding line - N I 954 [954.104000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 954 [954.104000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20384.04it/s]
Adding line - N I 954 [953.970000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 954 [953.970000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12933.33it/s]
Adding line - N I 954 [953.655000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 954 [953.655000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15472.83it/s]
Adding line - N I 953 [953.415000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 953 [953.415000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18861.20it/s]
Adding line - N I 952 [952.415000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 952 [952.415000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 21372.76it/s]
Adding line - N I 952 [952.303000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N I 952 [952.303000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20638.58it/s]
yt : [INFO ] 2023-09-13 16:08:48,031 30 out of 107 line components are unresolved.
Adding line - N II 1084 [1083.990000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N II 1084 [1083.990000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8667.78it/s]
yt : [INFO ] 2023-09-13 16:08:48,046 33 out of 107 line components are unresolved.
Adding line - N II 916 [915.612000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N II 916 [915.612000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7371.36it/s]
yt : [INFO ] 2023-09-13 16:08:48,063 32 out of 107 line components are unresolved.
Adding line - N III 990 [989.799000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N III 990 [989.799000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16705.35it/s]
yt : [INFO ] 2023-09-13 16:08:48,072 33 out of 107 line components are unresolved.
Adding line - N IV 765 [765.147000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N IV 765 [765.147000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23782.83it/s]
Adding line - N V 1243 [1242.804000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N V 1243 [1242.804000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24982.93it/s]
Adding line - N V 1239 [1238.821000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - N V 1239 [1238.821000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25353.34it/s]
Adding line - O I* 1306 [1306.029000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I* 1306 [1306.029000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12914.55it/s]
Adding line - O I* 1305 [1304.858000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I* 1305 [1304.858000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10475.38it/s]
Adding line - O I 1302 [1302.168000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 1302 [1302.168000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9728.16it/s]
Adding line - O I 1039 [1039.230000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 1039 [1039.230000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 13627.05it/s]
Adding line - O I 989 [988.773000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 989 [988.773000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7670.61it/s]
Adding line - O I 989 [988.655000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 989 [988.655000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16990.07it/s]
Adding line - O I 976 [976.448000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 976 [976.448000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18489.40it/s]
Adding line - O I 951 [950.885000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 951 [950.885000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19978.26it/s]
Adding line - O I 937 [936.629000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 937 [936.629000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20915.29it/s]
Adding line - O I 930 [929.517000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 930 [929.517000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22166.64it/s]
Adding line - O I 925 [924.950000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 925 [924.950000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 21496.77it/s]
Adding line - O I 922 [922.008000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O I 922 [922.008000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10857.58it/s]
Adding line - O II 834 [834.465400 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O II 834 [834.465400 A]: 99%|█████████▉| 106/107 [00:00<00:00, 4749.10it/s]
Adding line - O II 833 [833.330300 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O II 833 [833.330300 A]: 99%|█████████▉| 106/107 [00:00<00:00, 5392.18it/s]
Adding line - O II 833 [832.758300 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O II 833 [832.758300 A]: 99%|█████████▉| 106/107 [00:00<00:00, 6370.21it/s]
Adding line - O III* 835 [835.289000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O III* 835 [835.289000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18678.94it/s]
Adding line - O III* 835 [835.289000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O III* 835 [835.289000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18569.72it/s]
Adding line - O III 833 [832.929000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O III 833 [832.929000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19102.70it/s]
Adding line - O III* 703 [702.838000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O III* 703 [702.838000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20682.74it/s]
Adding line - O III 702 [702.337000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O III 702 [702.337000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20141.17it/s]
Adding line - O IV* 790 [790.199000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV* 790 [790.199000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24413.61it/s]
Adding line - O IV 788 [787.710000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV 788 [787.710000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23661.32it/s]
Adding line - O IV* 610 [609.829000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV* 610 [609.829000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23507.44it/s]
Adding line - O IV 608 [608.397000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV 608 [608.397000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23922.31it/s]
Adding line - O IV* 555 [554.513000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV* 555 [554.513000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24139.22it/s]
Adding line - O IV 554 [554.076000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV 554 [554.076000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24361.44it/s]
Adding line - O IV 553 [553.329000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O IV 553 [553.329000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24169.41it/s]
Adding line - O V 630 [629.732000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O V 630 [629.732000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26368.32it/s]
Adding line - O VI 1038 [1037.613000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O VI 1038 [1037.613000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20365.36it/s]
Adding line - O VI 1032 [1031.912000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - O VI 1032 [1031.912000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15235.81it/s]
Adding line - Ne V* 572 [572.335000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne V* 572 [572.335000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26680.04it/s]
Adding line - Ne V* 570 [569.828000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne V* 570 [569.828000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26739.41it/s]
Adding line - Ne V 568 [568.424000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne V 568 [568.424000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26288.80it/s]
Adding line - Ne VI* 563 [562.805000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne VI* 563 [562.805000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22147.86it/s]
Adding line - Ne VI 559 [558.603000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne VI 559 [558.603000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 21690.79it/s]
Adding line - Ne VII 465 [465.221000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne VII 465 [465.221000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22815.02it/s]
Adding line - Ne VIII 780 [780.324000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne VIII 780 [780.324000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 17693.96it/s]
Adding line - Ne VIII 770 [770.409000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ne VIII 770 [770.409000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14257.19it/s]
Adding line - Na IX 694 [694.150000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Na IX 694 [694.150000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 27249.09it/s]
Adding line - Na IX 682 [681.720000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Na IX 682 [681.720000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 27698.97it/s]
Adding line - Mg II 1240 [1240.394700 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Mg II 1240 [1240.394700 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16253.43it/s]
Adding line - Mg II 1240 [1239.925300 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Mg II 1240 [1239.925300 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16525.90it/s]
Adding line - Mg X 625 [624.941000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Mg X 625 [624.941000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25817.10it/s]
Adding line - Mg X 610 [609.793000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Mg X 610 [609.793000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25463.70it/s]
Adding line - Al II 1671 [1670.787400 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Al II 1671 [1670.787400 A]: 99%|█████████▉| 106/107 [00:00<00:00, 6908.39it/s]
Adding line - Al III 1863 [1862.789500 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Al III 1863 [1862.789500 A]: 99%|█████████▉| 106/107 [00:00<00:00, 15125.41it/s]
Adding line - Al III 1855 [1854.716400 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Al III 1855 [1854.716400 A]: 99%|█████████▉| 106/107 [00:00<00:00, 13943.74it/s]
Adding line - Si II* 1817 [1816.928000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1817 [1816.928000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19251.59it/s]
Adding line - Si II 1808 [1808.013000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1808 [1808.013000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19743.16it/s]
Adding line - Si II* 1309 [1309.276000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1309 [1309.276000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 6015.21it/s]
Adding line - Si II 1304 [1304.370000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1304 [1304.370000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 1765.52it/s]
Adding line - Si II* 1265 [1264.738000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1265 [1264.738000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 2621.36it/s]
Adding line - Si II 1260 [1260.422000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1260 [1260.422000 A]: 25%|██▌ | 27/107 [00:00<00:00, 262.76it/s]Adding line - Si II 1260 [1260.422000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 948.35it/s]
Adding line - Si II* 1197 [1197.394000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1197 [1197.394000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 2622.01it/s]
Adding line - Si II* 1194 [1194.500000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1194 [1194.500000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 1097.74it/s]
Adding line - Si II 1193 [1193.290000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1193 [1193.290000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 1341.29it/s]
Adding line - Si II 1190 [1190.416000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1190 [1190.416000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 2703.67it/s]
Adding line - Si II* 1024 [1023.700000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 1024 [1023.700000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 17905.61it/s]
Adding line - Si II 1021 [1020.699000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 1021 [1020.699000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 19905.81it/s]
Adding line - Si II* 993 [992.683000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II* 993 [992.683000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7003.17it/s]
Adding line - Si II 990 [989.873000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si II 990 [989.873000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 6837.84it/s]
Adding line - Si III 1206 [1206.500000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si III 1206 [1206.500000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 5455.24it/s]
yt : [INFO ] 2023-09-13 16:08:49,064 32 out of 107 line components are unresolved.
Adding line - Si IV 1403 [1402.770000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si IV 1403 [1402.770000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14339.96it/s]
yt : [INFO ] 2023-09-13 16:08:49,074 33 out of 107 line components are unresolved.
Adding line - Si XII 521 [520.665000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si XII 521 [520.665000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 28540.01it/s]
Adding line - Si XII 499 [499.406000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si XII 499 [499.406000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 27756.04it/s]
Adding line - P IV 951 [950.657000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - P IV 951 [950.657000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25671.01it/s]
Adding line - P V 1128 [1128.008000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - P V 1128 [1128.008000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25425.84it/s]
Adding line - P V 1118 [1117.977000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - P V 1118 [1117.977000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25232.48it/s]
Adding line - S II 1260 [1259.519000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 1260 [1259.519000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 13449.79it/s]
Adding line - S II 1254 [1253.811000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 1254 [1253.811000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14956.48it/s]
Adding line - S II 1251 [1250.584000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 1251 [1250.584000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16396.08it/s]
Adding line - S II 913 [912.736000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 913 [912.736000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10816.37it/s]
Adding line - S II 910 [910.485000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 910 [910.485000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8866.74it/s]
Adding line - S II 907 [906.876000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 907 [906.876000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8151.45it/s]
Adding line - S II 766 [765.684000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 766 [765.684000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 3255.92it/s]
Adding line - S II 764 [764.416000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 764 [764.416000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 3457.61it/s]
Adding line - S II 764 [763.656000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S II 764 [763.656000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 4718.05it/s]
Adding line - S III* 1201 [1200.966000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1201 [1200.966000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14433.54it/s]
Adding line - S III* 1194 [1194.058000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1194 [1194.058000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14413.42it/s]
Adding line - S III 1190 [1190.203000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III 1190 [1190.203000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 14564.99it/s]
Adding line - S III* 1021 [1021.323000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1021 [1021.323000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22847.85it/s]
Adding line - S III* 1021 [1021.108000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1021 [1021.108000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24836.39it/s]
Adding line - S III* 1016 [1015.779000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.779000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24829.46it/s]
Adding line - S III* 1016 [1015.567000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.567000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23915.88it/s]
Adding line - S III* 1016 [1015.502000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.502000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 24195.71it/s]
Adding line - S III 1012 [1012.495000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III 1012 [1012.495000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22924.42it/s]
Adding line - S III* 729 [728.685000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 729 [728.685000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8935.35it/s]
Adding line - S III* 726 [725.858000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 726 [725.858000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 11110.18it/s]
Adding line - S III 724 [724.288000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III 724 [724.288000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 13661.81it/s]
Adding line - S III* 703 [702.779000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 703 [702.779000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8705.11it/s]
Adding line - S III* 700 [700.288000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 700 [700.288000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9473.40it/s]
Adding line - S III* 700 [700.150000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 700 [700.150000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 11486.79it/s]
Adding line - S III 699 [698.727000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III 699 [698.727000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 9294.18it/s]
Adding line - S III* 681 [680.925000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 681 [680.925000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12419.58it/s]
Adding line - S III* 681 [680.677000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 681 [680.677000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 6409.43it/s]
Adding line - S III* 678 [678.456000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III* 678 [678.456000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 8363.67it/s]
Adding line - S III 678 [677.729000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S III 678 [677.729000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7633.60it/s]
Adding line - S IV* 1073 [1072.973000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV* 1073 [1072.973000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25402.60it/s]
Adding line - S IV* 816 [815.941000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV* 816 [815.941000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25999.78it/s]
Adding line - S IV 810 [809.656000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV 810 [809.656000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25790.14it/s]
Adding line - S IV* 754 [753.760000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV* 754 [753.760000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25736.40it/s]
Adding line - S IV* 750 [750.221000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV* 750 [750.221000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25591.22it/s]
Adding line - S IV 748 [748.393000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV 748 [748.393000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26120.45it/s]
Adding line - S IV 745 [744.904000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV 745 [744.904000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26231.41it/s]
Adding line - S IV 657 [657.319000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S IV 657 [657.319000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25604.48it/s]
Adding line - S V 786 [786.468000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S V 786 [786.468000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 25094.33it/s]
Adding line - S VI 945 [944.523000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S VI 945 [944.523000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 22874.88it/s]
Adding line - S VI 933 [933.378000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S VI 933 [933.378000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 23549.78it/s]
Adding line - S XIV 446 [445.700000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S XIV 446 [445.700000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 50288.00it/s]
Adding line - S XIV 418 [417.660000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - S XIV 418 [417.660000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 48467.92it/s]
Adding line - Ar I 1067 [1066.660000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar I 1067 [1066.660000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 32494.97it/s]
Adding line - Ar I 1048 [1048.220000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar I 1048 [1048.220000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 20026.86it/s]
Adding line - Ar II* 726 [725.548530 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar II* 726 [725.548530 A]: 99%|█████████▉| 106/107 [00:00<00:00, 18365.67it/s]
Adding line - Ar II 723 [723.360560 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar II 723 [723.360560 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16937.64it/s]
Adding line - Ar II 718 [718.089852 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar II 718 [718.089852 A]: 99%|█████████▉| 106/107 [00:00<00:00, 27277.52it/s]
Adding line - Ar VII 586 [585.748000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ar VII 586 [585.748000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26276.37it/s]
Adding line - Ca X 574 [574.010000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ca X 574 [574.010000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 27227.40it/s]
Adding line - Ca X 558 [557.765000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ca X 558 [557.765000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26612.97it/s]
Adding line - Fe II 1608 [1608.450830 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1608 [1608.450830 A]: 99%|█████████▉| 106/107 [00:00<00:00, 7781.64it/s]
Adding line - Fe II 1143 [1143.225730 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1143 [1143.225730 A]: 99%|█████████▉| 106/107 [00:00<00:00, 17884.00it/s]
Adding line - Fe II 1127 [1127.098400 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1127 [1127.098400 A]: 99%|█████████▉| 106/107 [00:00<00:00, 34292.03it/s]
Adding line - Fe II 1125 [1125.447630 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1125 [1125.447630 A]: 99%|█████████▉| 106/107 [00:00<00:00, 16104.47it/s]
Adding line - Fe II 1122 [1121.974710 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1122 [1121.974710 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12920.93it/s]
Adding line - Fe II 1112 [1112.048320 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1112 [1112.048320 A]: 99%|█████████▉| 106/107 [00:00<00:00, 30868.31it/s]
Adding line - Fe II 1097 [1096.876870 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1097 [1096.876870 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12351.61it/s]
Adding line - Fe II 1083 [1083.420460 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1083 [1083.420460 A]: 99%|█████████▉| 106/107 [00:00<00:00, 30476.85it/s]
Adding line - Fe II 1082 [1081.875260 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1082 [1081.875260 A]: 99%|█████████▉| 106/107 [00:00<00:00, 21060.93it/s]
Adding line - Fe II 1064 [1063.971790 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1064 [1063.971790 A]: 99%|█████████▉| 106/107 [00:00<00:00, 31898.14it/s]
Adding line - Fe II 1063 [1063.176870 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1063 [1063.176870 A]: 99%|█████████▉| 106/107 [00:00<00:00, 10399.43it/s]
Adding line - Fe II 1062 [1062.153100 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1062 [1062.153100 A]: 99%|█████████▉| 106/107 [00:00<00:00, 33343.05it/s]
Adding line - Fe II 1055 [1055.261760 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 1055 [1055.261760 A]: 99%|█████████▉| 106/107 [00:00<00:00, 26787.75it/s]
Adding line - Fe II 938 [937.651330 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 938 [937.651330 A]: 99%|█████████▉| 106/107 [00:00<00:00, 34249.77it/s]
Adding line - Fe II 927 [926.896870 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 927 [926.896870 A]: 99%|█████████▉| 106/107 [00:00<00:00, 39188.74it/s]
Adding line - Fe II 926 [926.212010 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 926 [926.212010 A]: 99%|█████████▉| 106/107 [00:00<00:00, 12296.95it/s]
Adding line - Fe II 924 [923.878210 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Fe II 924 [923.878210 A]: 99%|█████████▉| 106/107 [00:00<00:00, 41037.13it/s]
yt : [INFO ] 2023-09-13 16:08:49,694 Not adding continuum Ly C: insufficient column density or out of range
yt : [INFO ] 2023-09-13 16:08:49,700 Applying specified line spread function.
yt : [INFO ] 2023-09-13 16:08:49,704 Writing spectrum to hdf5 file: LightRays/spec_all_ray1.h5.
yt : [INFO ] 2023-09-13 16:08:49,706 Setting instrument to Custom
yt : [INFO ] 2023-09-13 16:08:49,743 Allocating for 121 particles
yt : [INFO ] 2023-09-13 16:08:49,797 Using all 213 available lines in 'lines.txt'.
yt : [INFO ] 2023-09-13 16:08:49,799 Creating C_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,801 Creating C_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,802 Creating C_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,803 Creating C_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,803 Creating N_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,804 Creating N_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,805 Creating N_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,806 Creating N_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,807 Creating N_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,808 Creating O_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,809 Creating O_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,810 Creating O_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,811 Creating O_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,812 Creating O_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,813 Creating Ne_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,814 Creating Ne_p5_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,814 Creating Ne_p6_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,815 Creating Ne_p7_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,816 Creating Na_p8_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,817 Creating Mg_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,818 Creating Mg_p9_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,819 Creating Al_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,820 Creating Al_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,821 Creating Si_p11_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,822 Creating P_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,823 Creating P_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,824 Creating S_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,825 Creating S_p2_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,827 Creating S_p3_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,828 Creating S_p4_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,829 Creating S_p5_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,830 Creating S_p13_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,830 Creating Ar_p0_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,831 Creating Ar_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,834 Creating Ar_p6_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,835 Creating Ca_p9_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,836 Creating Fe_p1_number_density from ray's fields.
yt : [INFO ] 2023-09-13 16:08:49,837 Creating spectrum
Adding line - Ly a [1215.670000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly a [1215.670000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 1868.61it/s]
Adding line - Ly b [1025.722200 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly b [1025.722200 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8824.70it/s]
Adding line - Ly c [972.536740 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly c [972.536740 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9383.06it/s]
Adding line - Ly d [949.742980 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly d [949.742980 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9378.68it/s]
Adding line - Ly e [937.803400 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly e [937.803400 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9826.56it/s]
Adding line - Ly 6 [930.748200 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 6 [930.748200 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9791.96it/s]
Adding line - Ly 7 [926.225640 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 7 [926.225640 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9977.33it/s]
Adding line - Ly 8 [923.150300 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 8 [923.150300 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9869.92it/s]
Adding line - Ly 9 [920.963026 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 9 [920.963026 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10436.40it/s]
Adding line - Ly 10 [919.351351 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 10 [919.351351 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11319.89it/s]
Adding line - Ly 11 [918.129312 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 11 [918.129312 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11005.30it/s]
Adding line - Ly 12 [917.180525 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 12 [917.180525 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10316.19it/s]
Adding line - Ly 13 [916.429085 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 13 [916.429085 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10705.67it/s]
Adding line - Ly 14 [915.823759 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 14 [915.823759 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11515.17it/s]
Adding line - Ly 15 [915.328939 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 15 [915.328939 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10831.46it/s]
Adding line - Ly 16 [914.919249 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 16 [914.919249 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11519.38it/s]
Adding line - Ly 17 [914.576207 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 17 [914.576207 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10495.82it/s]
Adding line - Ly 18 [914.286092 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 18 [914.286092 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11585.41it/s]
Adding line - Ly 19 [914.038542 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 19 [914.038542 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8535.42it/s]
Adding line - Ly 20 [913.825614 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 20 [913.825614 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8957.24it/s]
Adding line - Ly 21 [913.641137 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 21 [913.641137 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10628.81it/s]
Adding line - Ly 22 [913.480256 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 22 [913.480256 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11638.99it/s]
Adding line - Ly 23 [913.339110 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 23 [913.339110 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10609.31it/s]
Adding line - Ly 24 [913.214596 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 24 [913.214596 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10598.81it/s]
Adding line - Ly 25 [913.104199 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 25 [913.104199 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10933.11it/s]
Adding line - Ly 26 [913.005863 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 26 [913.005863 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10847.81it/s]
Adding line - Ly 27 [912.917891 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 27 [912.917891 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10770.27it/s]
Adding line - Ly 28 [912.838877 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 28 [912.838877 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11315.31it/s]
Adding line - Ly 29 [912.767643 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 29 [912.767643 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10724.83it/s]
Adding line - Ly 30 [912.703200 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 30 [912.703200 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10771.89it/s]
Adding line - Ly 31 [912.644712 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 31 [912.644712 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11037.40it/s]
Adding line - Ly 32 [912.591467 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 32 [912.591467 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11156.55it/s]
Adding line - Ly 33 [912.542856 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 33 [912.542856 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10855.99it/s]
Adding line - Ly 34 [912.498356 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 34 [912.498356 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10871.47it/s]
Adding line - Ly 35 [912.457516 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 35 [912.457516 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11022.17it/s]
Adding line - Ly 36 [912.419946 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 36 [912.419946 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12738.96it/s]
Adding line - Ly 37 [912.385306 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 37 [912.385306 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11580.88it/s]
Adding line - Ly 38 [912.353298 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 38 [912.353298 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12066.18it/s]
Adding line - Ly 39 [912.323663 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly 39 [912.323663 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11716.48it/s]
Adding line - C I 1657 [1656.929000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1657 [1656.929000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18273.84it/s]
Adding line - C I 1560 [1560.309000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1560 [1560.309000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18870.59it/s]
Adding line - C I 1329 [1328.834000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1329 [1328.834000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22341.82it/s]
Adding line - C I 1280 [1280.135000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1280 [1280.135000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17768.08it/s]
Adding line - C I 1277 [1277.245000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1277 [1277.245000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16251.22it/s]
Adding line - C I 1261 [1260.735000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1261 [1260.735000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20291.75it/s]
Adding line - C I 1194 [1193.995000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1194 [1193.995000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19621.71it/s]
Adding line - C I 1193 [1193.031000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1193 [1193.031000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19031.86it/s]
Adding line - C I 1189 [1188.833000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1189 [1188.833000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19181.27it/s]
Adding line - C I 1158 [1157.910000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C I 1158 [1157.910000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21085.73it/s]
Adding line - C II* 1336 [1335.663000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C II* 1336 [1335.663000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16735.93it/s]
Adding line - C II 1335 [1334.532000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C II 1335 [1334.532000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10530.96it/s]
Adding line - C II* 1037 [1037.018000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C II* 1037 [1037.018000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8722.69it/s]
Adding line - C II 1036 [1036.337000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C II 1036 [1036.337000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10919.11it/s]
yt : [INFO ] 2023-09-13 16:08:50,512 30 out of 121 line components are unresolved.
Adding line - C II 904 [903.962000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C II 904 [903.962000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 3770.13it/s]
yt : [INFO ] 2023-09-13 16:08:50,547 26 out of 121 line components are unresolved.
Adding line - C III 977 [977.020000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C III 977 [977.020000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 5645.73it/s]
Adding line - C IV 1551 [1550.772000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C IV 1551 [1550.772000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 13605.35it/s]
Adding line - C IV 1548 [1548.187000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - C IV 1548 [1548.187000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 13264.37it/s]
Adding line - N I 1201 [1200.710000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1201 [1200.710000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16715.37it/s]
Adding line - N I 1200 [1200.223000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1200 [1200.223000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15267.28it/s]
Adding line - N I 1200 [1199.550000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1200 [1199.550000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22271.63it/s]
Adding line - N I 1135 [1134.980000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1135 [1134.980000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23252.17it/s]
Adding line - N I 1134 [1134.415000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1134 [1134.415000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25193.54it/s]
Adding line - N I 1134 [1134.165000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 1134 [1134.165000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 30178.47it/s]
yt : [INFO ] 2023-09-13 16:08:50,635 30 out of 121 line components are unresolved.
Adding line - N I 965 [965.041000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 965 [965.041000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 26449.97it/s]
Adding line - N I 965 [964.626000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 965 [964.626000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25035.64it/s]
Adding line - N I 964 [963.990000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 964 [963.990000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25532.21it/s]
Adding line - N I 954 [954.104000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 954 [954.104000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27322.97it/s]
Adding line - N I 954 [953.970000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 954 [953.970000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22530.84it/s]
Adding line - N I 954 [953.655000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 954 [953.655000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21699.35it/s]
Adding line - N I 953 [953.415000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 953 [953.415000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22966.76it/s]
Adding line - N I 952 [952.415000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 952 [952.415000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 28770.81it/s]
Adding line - N I 952 [952.303000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N I 952 [952.303000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29592.93it/s]
yt : [INFO ] 2023-09-13 16:08:50,689 18 out of 121 line components are unresolved.
Adding line - N II 1084 [1083.990000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N II 1084 [1083.990000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11042.73it/s]
yt : [INFO ] 2023-09-13 16:08:50,702 30 out of 121 line components are unresolved.
Adding line - N II 916 [915.612000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N II 916 [915.612000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11051.94it/s]
yt : [INFO ] 2023-09-13 16:08:50,715 29 out of 121 line components are unresolved.
Adding line - N III 990 [989.799000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N III 990 [989.799000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17428.46it/s]
yt : [INFO ] 2023-09-13 16:08:50,725 32 out of 121 line components are unresolved.
Adding line - N IV 765 [765.147000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N IV 765 [765.147000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18052.96it/s]
Adding line - N V 1243 [1242.804000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N V 1243 [1242.804000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22193.06it/s]
Adding line - N V 1239 [1238.821000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - N V 1239 [1238.821000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21633.13it/s]
Adding line - O I* 1306 [1306.029000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I* 1306 [1306.029000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16920.48it/s]
Adding line - O I* 1305 [1304.858000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I* 1305 [1304.858000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15675.25it/s]
Adding line - O I 1302 [1302.168000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 1302 [1302.168000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 14307.71it/s]
yt : [INFO ] 2023-09-13 16:08:50,775 30 out of 121 line components are unresolved.
Adding line - O I 1039 [1039.230000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 1039 [1039.230000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19821.07it/s]
Adding line - O I 989 [988.773000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 989 [988.773000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 14964.51it/s]
Adding line - O I 989 [988.655000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 989 [988.655000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22122.83it/s]
Adding line - O I 976 [976.448000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 976 [976.448000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25104.32it/s]
Adding line - O I 951 [950.885000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 951 [950.885000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24493.48it/s]
Adding line - O I 937 [936.629000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 937 [936.629000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24038.42it/s]
Adding line - O I 930 [929.517000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 930 [929.517000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24660.29it/s]
Adding line - O I 925 [924.950000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 925 [924.950000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 26236.26it/s]
Adding line - O I 922 [922.008000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O I 922 [922.008000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19080.92it/s]
yt : [INFO ] 2023-09-13 16:08:50,837 31 out of 121 line components are unresolved.
Adding line - O II 834 [834.465400 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O II 834 [834.465400 A]: 99%|█████████▉| 120/121 [00:00<00:00, 7713.07it/s]
Adding line - O II 833 [833.330300 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O II 833 [833.330300 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8779.59it/s]
Adding line - O II 833 [832.758300 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O II 833 [832.758300 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9845.01it/s]
Adding line - O III* 835 [835.289000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O III* 835 [835.289000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22243.08it/s]
Adding line - O III* 835 [835.289000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O III* 835 [835.289000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19739.45it/s]
Adding line - O III 833 [832.929000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O III 833 [832.929000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19845.30it/s]
yt : [INFO ] 2023-09-13 16:08:50,905 32 out of 121 line components are unresolved.
Adding line - O III* 703 [702.838000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O III* 703 [702.838000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21163.76it/s]
Adding line - O III 702 [702.337000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O III 702 [702.337000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20807.66it/s]
Adding line - O IV* 790 [790.199000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV* 790 [790.199000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18080.20it/s]
Adding line - O IV 788 [787.710000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV 788 [787.710000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18381.96it/s]
yt : [INFO ] 2023-09-13 16:08:50,936 34 out of 121 line components are unresolved.
Adding line - O IV* 610 [609.829000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV* 610 [609.829000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18148.65it/s]
Adding line - O IV 608 [608.397000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV 608 [608.397000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18080.20it/s]
Adding line - O IV* 555 [554.513000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV* 555 [554.513000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17714.93it/s]
Adding line - O IV 554 [554.076000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV 554 [554.076000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18329.08it/s]
Adding line - O IV 553 [553.329000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O IV 553 [553.329000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18367.87it/s]
Adding line - O V 630 [629.732000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O V 630 [629.732000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23068.86it/s]
yt : [INFO ] 2023-09-13 16:08:50,986 30 out of 121 line components are unresolved.
Adding line - O VI 1038 [1037.613000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O VI 1038 [1037.613000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23327.61it/s]
Adding line - O VI 1032 [1031.912000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - O VI 1032 [1031.912000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18696.75it/s]
yt : [INFO ] 2023-09-13 16:08:51,002 34 out of 121 line components are unresolved.
Adding line - Ne V* 572 [572.335000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne V* 572 [572.335000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23734.63it/s]
Adding line - Ne V* 570 [569.828000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne V* 570 [569.828000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23151.63it/s]
Adding line - Ne V 568 [568.424000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne V 568 [568.424000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23152.70it/s]
Adding line - Ne VI* 563 [562.805000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne VI* 563 [562.805000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20664.99it/s]
Adding line - Ne VI 559 [558.603000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne VI 559 [558.603000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20056.44it/s]
yt : [INFO ] 2023-09-13 16:08:51,041 35 out of 121 line components are unresolved.
Adding line - Ne VII 465 [465.221000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne VII 465 [465.221000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24839.19it/s]
yt : [INFO ] 2023-09-13 16:08:51,048 32 out of 121 line components are unresolved.
Adding line - Ne VIII 780 [780.324000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne VIII 780 [780.324000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25033.15it/s]
yt : [INFO ] 2023-09-13 16:08:51,055 34 out of 121 line components are unresolved.
Adding line - Ne VIII 770 [770.409000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ne VIII 770 [770.409000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20456.69it/s]
Adding line - Na IX 694 [694.150000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Na IX 694 [694.150000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27497.62it/s]
Adding line - Na IX 682 [681.720000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Na IX 682 [681.720000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27708.04it/s]
yt : [INFO ] 2023-09-13 16:08:51,077 30 out of 121 line components are unresolved.
Adding line - Mg II 1240 [1240.394700 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Mg II 1240 [1240.394700 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18309.08it/s]
Adding line - Mg II 1240 [1239.925300 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Mg II 1240 [1239.925300 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18080.84it/s]
yt : [INFO ] 2023-09-13 16:08:51,093 34 out of 121 line components are unresolved.
Adding line - Mg X 625 [624.941000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Mg X 625 [624.941000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25636.25it/s]
Adding line - Mg X 610 [609.793000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Mg X 610 [609.793000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 26749.39it/s]
Adding line - Al II 1671 [1670.787400 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Al II 1671 [1670.787400 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11794.73it/s]
Adding line - Al III 1863 [1862.789500 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Al III 1863 [1862.789500 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17446.58it/s]
Adding line - Al III 1855 [1854.716400 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Al III 1855 [1854.716400 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16513.01it/s]
Adding line - Si II* 1817 [1816.928000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1817 [1816.928000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20817.99it/s]
Adding line - Si II 1808 [1808.013000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1808 [1808.013000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19972.88it/s]
yt : [INFO ] 2023-09-13 16:08:51,151 30 out of 121 line components are unresolved.
Adding line - Si II* 1309 [1309.276000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1309 [1309.276000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10504.36it/s]
Adding line - Si II 1304 [1304.370000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1304 [1304.370000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 3542.16it/s]
Adding line - Si II* 1265 [1264.738000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1265 [1264.738000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 5689.06it/s]
Adding line - Si II 1260 [1260.422000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1260 [1260.422000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 2044.05it/s]
Adding line - Si II* 1197 [1197.394000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1197 [1197.394000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 5552.98it/s]
Adding line - Si II* 1194 [1194.500000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1194 [1194.500000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 2420.73it/s]
Adding line - Si II 1193 [1193.290000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1193 [1193.290000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 2943.84it/s]
Adding line - Si II 1190 [1190.416000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1190 [1190.416000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 5791.57it/s]
yt : [INFO ] 2023-09-13 16:08:51,417 32 out of 121 line components are unresolved.
Adding line - Si II* 1024 [1023.700000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 1024 [1023.700000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23827.89it/s]
Adding line - Si II 1021 [1020.699000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 1021 [1020.699000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 25945.49it/s]
Adding line - Si II* 993 [992.683000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II* 993 [992.683000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12231.26it/s]
Adding line - Si II 990 [989.873000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si II 990 [989.873000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12535.28it/s]
yt : [INFO ] 2023-09-13 16:08:51,451 30 out of 121 line components are unresolved.
Adding line - Si III 1206 [1206.500000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si III 1206 [1206.500000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 6416.09it/s]
yt : [INFO ] 2023-09-13 16:08:51,471 29 out of 121 line components are unresolved.
Adding line - Si IV 1403 [1402.770000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si IV 1403 [1402.770000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16107.67it/s]
yt : [INFO ] 2023-09-13 16:08:51,482 35 out of 121 line components are unresolved.
Adding line - Si XII 521 [520.665000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si XII 521 [520.665000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 34405.39it/s]
Adding line - Si XII 499 [499.406000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si XII 499 [499.406000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 34141.67it/s]
yt : [INFO ] 2023-09-13 16:08:51,493 34 out of 121 line components are unresolved.
Adding line - P IV 951 [950.657000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - P IV 951 [950.657000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29154.11it/s]
yt : [INFO ] 2023-09-13 16:08:51,500 32 out of 121 line components are unresolved.
Adding line - P V 1128 [1128.008000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - P V 1128 [1128.008000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19675.40it/s]
Adding line - P V 1118 [1117.977000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - P V 1118 [1117.977000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21523.97it/s]
yt : [INFO ] 2023-09-13 16:08:51,516 31 out of 121 line components are unresolved.
Adding line - S II 1260 [1259.519000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 1260 [1259.519000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17472.63it/s]
Adding line - S II 1254 [1253.811000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 1254 [1253.811000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17641.04it/s]
Adding line - S II 1251 [1250.584000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 1251 [1250.584000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 18195.23it/s]
yt : [INFO ] 2023-09-13 16:08:51,539 34 out of 121 line components are unresolved.
Adding line - S II 913 [912.736000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 913 [912.736000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19976.05it/s]
Adding line - S II 910 [910.485000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 910 [910.485000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 16787.85it/s]
Adding line - S II 907 [906.876000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 907 [906.876000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15635.32it/s]
Adding line - S II 766 [765.684000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 766 [765.684000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 6639.71it/s]
Adding line - S II 764 [764.416000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 764 [764.416000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 7336.33it/s]
Adding line - S II 764 [763.656000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S II 764 [763.656000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8773.78it/s]
yt : [INFO ] 2023-09-13 16:08:51,615 31 out of 121 line components are unresolved.
Adding line - S III* 1201 [1200.966000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1201 [1200.966000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15523.92it/s]
Adding line - S III* 1194 [1194.058000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1194 [1194.058000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15488.09it/s]
Adding line - S III 1190 [1190.203000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III 1190 [1190.203000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 14752.66it/s]
yt : [INFO ] 2023-09-13 16:08:51,642 32 out of 121 line components are unresolved.
Adding line - S III* 1021 [1021.323000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1021 [1021.323000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23818.87it/s]
Adding line - S III* 1021 [1021.108000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1021 [1021.108000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24444.71it/s]
Adding line - S III* 1016 [1015.779000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.779000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24229.36it/s]
Adding line - S III* 1016 [1015.567000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.567000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23948.06it/s]
Adding line - S III* 1016 [1015.502000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 1016 [1015.502000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 24450.64it/s]
Adding line - S III 1012 [1012.495000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III 1012 [1012.495000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 22632.15it/s]
yt : [INFO ] 2023-09-13 16:08:51,679 34 out of 121 line components are unresolved.
Adding line - S III* 729 [728.685000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 729 [728.685000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 11295.25it/s]
Adding line - S III* 726 [725.858000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 726 [725.858000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 13418.19it/s]
Adding line - S III 724 [724.288000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III 724 [724.288000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15633.37it/s]
Adding line - S III* 703 [702.779000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 703 [702.779000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10954.76it/s]
Adding line - S III* 700 [700.288000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 700 [700.288000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12639.47it/s]
Adding line - S III* 700 [700.150000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 700 [700.150000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 13879.23it/s]
Adding line - S III 699 [698.727000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III 699 [698.727000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 12316.57it/s]
Adding line - S III* 681 [680.925000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 681 [680.925000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 15544.05it/s]
Adding line - S III* 681 [680.677000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 681 [680.677000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 8295.42it/s]
Adding line - S III* 678 [678.456000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III* 678 [678.456000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 10506.12it/s]
Adding line - S III 678 [677.729000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S III 678 [677.729000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 9863.73it/s]
yt : [INFO ] 2023-09-13 16:08:51,803 32 out of 121 line components are unresolved.
Adding line - S IV* 1073 [1072.973000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV* 1073 [1072.973000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29664.44it/s]
yt : [INFO ] 2023-09-13 16:08:51,809 34 out of 121 line components are unresolved.
Adding line - S IV* 816 [815.941000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV* 816 [815.941000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 30878.31it/s]
Adding line - S IV 810 [809.656000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV 810 [809.656000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29916.58it/s]
Adding line - S IV* 754 [753.760000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV* 754 [753.760000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29154.11it/s]
Adding line - S IV* 750 [750.221000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV* 750 [750.221000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27972.91it/s]
Adding line - S IV 748 [748.393000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV 748 [748.393000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29556.43it/s]
Adding line - S IV 745 [744.904000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV 745 [744.904000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 29709.96it/s]
Adding line - S IV 657 [657.319000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S IV 657 [657.319000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 28287.33it/s]
Adding line - S V 786 [786.468000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S V 786 [786.468000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 20703.24it/s]
Adding line - S VI 945 [944.523000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S VI 945 [944.523000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19611.01it/s]
Adding line - S VI 933 [933.378000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S VI 933 [933.378000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 19169.58it/s]
yt : [INFO ] 2023-09-13 16:08:51,874 36 out of 121 line components are unresolved.
Adding line - S XIV 446 [445.700000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S XIV 446 [445.700000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 35064.55it/s]
Adding line - S XIV 418 [417.660000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - S XIV 418 [417.660000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 35086.54it/s]
yt : [INFO ] 2023-09-13 16:08:51,885 34 out of 121 line components are unresolved.
Adding line - Ar I 1067 [1066.660000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar I 1067 [1066.660000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 42828.16it/s]
Adding line - Ar I 1048 [1048.220000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar I 1048 [1048.220000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 42238.71it/s]
Adding line - Ar II* 726 [725.548530 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar II* 726 [725.548530 A]: 99%|█████████▉| 120/121 [00:00<00:00, 31386.66it/s]
yt : [INFO ] 2023-09-13 16:08:51,900 35 out of 121 line components are unresolved.
Adding line - Ar II 723 [723.360560 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar II 723 [723.360560 A]: 99%|█████████▉| 120/121 [00:00<00:00, 30853.70it/s]
Adding line - Ar II 718 [718.089852 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar II 718 [718.089852 A]: 99%|█████████▉| 120/121 [00:00<00:00, 43494.34it/s]
Adding line - Ar VII 586 [585.748000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ar VII 586 [585.748000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 23373.11it/s]
Adding line - Ca X 574 [574.010000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ca X 574 [574.010000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27112.50it/s]
Adding line - Ca X 558 [557.765000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ca X 558 [557.765000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27154.92it/s]
yt : [INFO ] 2023-09-13 16:08:51,932 31 out of 121 line components are unresolved.
Adding line - Fe II 1608 [1608.450830 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1608 [1608.450830 A]: 99%|█████████▉| 120/121 [00:00<00:00, 14687.65it/s]
yt : [INFO ] 2023-09-13 16:08:51,941 34 out of 121 line components are unresolved.
Adding line - Fe II 1143 [1143.225730 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1143 [1143.225730 A]: 99%|█████████▉| 120/121 [00:00<00:00, 27541.26it/s]
Adding line - Fe II 1127 [1127.098400 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1127 [1127.098400 A]: 99%|█████████▉| 120/121 [00:00<00:00, 38725.59it/s]
Adding line - Fe II 1125 [1125.447630 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1125 [1125.447630 A]: 99%|█████████▉| 120/121 [00:00<00:00, 28991.21it/s]
Adding line - Fe II 1122 [1121.974710 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1122 [1121.974710 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21478.96it/s]
Adding line - Fe II 1112 [1112.048320 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1112 [1112.048320 A]: 99%|█████████▉| 120/121 [00:00<00:00, 36199.40it/s]
Adding line - Fe II 1097 [1096.876870 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1097 [1096.876870 A]: 99%|█████████▉| 120/121 [00:00<00:00, 21269.29it/s]
Adding line - Fe II 1083 [1083.420460 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1083 [1083.420460 A]: 99%|█████████▉| 120/121 [00:00<00:00, 33907.07it/s]
Adding line - Fe II 1082 [1081.875260 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1082 [1081.875260 A]: 99%|█████████▉| 120/121 [00:00<00:00, 35013.32it/s]
Adding line - Fe II 1064 [1063.971790 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1064 [1063.971790 A]: 99%|█████████▉| 120/121 [00:00<00:00, 34870.20it/s]
Adding line - Fe II 1063 [1063.176870 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1063 [1063.176870 A]: 99%|█████████▉| 120/121 [00:00<00:00, 17999.37it/s]
Adding line - Fe II 1062 [1062.153100 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1062 [1062.153100 A]: 99%|█████████▉| 120/121 [00:00<00:00, 35140.44it/s]
Adding line - Fe II 1055 [1055.261760 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 1055 [1055.261760 A]: 99%|█████████▉| 120/121 [00:00<00:00, 35897.33it/s]
Adding line - Fe II 938 [937.651330 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 938 [937.651330 A]: 99%|█████████▉| 120/121 [00:00<00:00, 40323.38it/s]
Adding line - Fe II 927 [926.896870 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 927 [926.896870 A]: 99%|█████████▉| 120/121 [00:00<00:00, 42136.16it/s]
Adding line - Fe II 926 [926.212010 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 926 [926.212010 A]: 99%|█████████▉| 120/121 [00:00<00:00, 26582.68it/s]
Adding line - Fe II 924 [923.878210 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Fe II 924 [923.878210 A]: 99%|█████████▉| 120/121 [00:00<00:00, 39116.85it/s]
yt : [INFO ] 2023-09-13 16:08:52,020 Not adding continuum Ly C: insufficient column density or out of range
yt : [INFO ] 2023-09-13 16:08:52,024 Applying specified line spread function.
yt : [INFO ] 2023-09-13 16:08:52,027 Writing spectrum to hdf5 file: LightRays/spec_all_ray2.h5.
from IPython.display import display, Image
# Load the saved spectra and plot them together
= trident.load_spectrum('LightRays/spec_all_ray1.h5')
sg1 = trident.load_spectrum('LightRays/spec_all_ray2.h5')
sg2
= 'LightRays/COS130_1150_1300_allLines.png'
filename
plot_spectrum_Chad([sg1.lambda_field,sg2.lambda_field],
[sg1.flux_field,sg2.flux_field],= [0,1.5],
flux_limits =0.0, step=[True, True],
stagger=['Ray 1', 'Ray 2'], filename=filename)
label
= Image(filename=filename)
fig display(fig)
yt : [INFO ] 2023-09-13 16:08:52,034 Setting instrument to Custom
/var/folders/9t/skzkm_4169g47x95n5b3b5_h0000gn/T/ipykernel_3715/2514315971.py:250: MatplotlibDeprecationWarning: The label function was deprecated in Matplotlib 3.1 and will be removed in 3.8. Use Tick.label1 instead.
tick.label.set_fontsize(14)
/var/folders/9t/skzkm_4169g47x95n5b3b5_h0000gn/T/ipykernel_3715/2514315971.py:252: MatplotlibDeprecationWarning: The label function was deprecated in Matplotlib 3.1 and will be removed in 3.8. Use Tick.label1 instead.
tick.label.set_fontsize(14)
yt : [INFO ] 2023-09-13 16:08:52,052 Writing spectrum plot to png file: LightRays/COS130_1150_1300_allLines.png
We see a lot of overlapping absorption lines between Ray 1 and Ray 2, except for around 1210-1220 A. Let’s zoom in on this region and label a few lines that I know are interesting: Si III 1206.5 and Lyman alpha.
= 1200, 1230
lambda_min,lambda_max = trident.SpectrumGenerator(lambda_min=lambda_min, lambda_max=lambda_max, dlambda=0.01)
sg1 ={'Si III 1206','Ly a'}, use_peculiar_velocity=True,
sg1.make_spectrum(ray1, lines=True)
store_observables
sg1.add_milky_way_foreground()='avg_COS.txt')
sg1.apply_lsf(filename30)
sg1.add_gaussian_noise('LightRays/spec_SiIII_Lya_ray1.h5')
sg1.save_spectrum(
= trident.SpectrumGenerator(lambda_min=lambda_min, lambda_max=lambda_max, dlambda=0.01)
sg2 ={'Si III 1206', 'Ly a'}, use_peculiar_velocity=True,
sg2.make_spectrum(ray2, lines=True)
store_observables
sg2.add_milky_way_foreground()='avg_COS.txt')
sg2.apply_lsf(filename30)
sg2.add_gaussian_noise('LightRays/spec_SiIII_Lya_ray2.h5')
sg2.save_spectrum(
plot_spectrum_Chad([sg1.lambda_field,sg2.lambda_field],
[sg1.flux_field,sg2.flux_field],= [0,1.5],
flux_limits ={'Si III' : 1206.5, 'Ly a' : 1215.67},
features=0.0, step=[True, True],
stagger=['Ray 1', 'Ray 2'], filename='LightRays/COS130_1200_1230_SiIII_Lya.png')
label
"LightRays/COS130_1200_1230_SiIII_Lya.png", embed=True)) display(Image(
yt : [INFO ] 2023-09-13 16:08:52,150 Setting instrument to Custom
yt : [INFO ] 2023-09-13 16:08:52,153 Creating spectrum
yt : [INFO ] 2023-09-13 16:08:52,157 33 out of 107 line components are unresolved.
Adding line - Si III 1206 [1206.500000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Si III 1206 [1206.500000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 5012.98it/s]
Adding line - Ly a [1215.670000 A]: 0%| | 0/107 [00:00<?, ?it/s]Adding line - Ly a [1215.670000 A]: 22%|██▏ | 24/107 [00:00<00:00, 236.08it/s]Adding line - Ly a [1215.670000 A]: 99%|█████████▉| 106/107 [00:00<00:00, 853.08it/s]
yt : [INFO ] 2023-09-13 16:08:52,306 Not adding continuum Ly C: insufficient column density or out of range
yt : [INFO ] 2023-09-13 16:08:52,309 Applying specified line spread function.
yt : [INFO ] 2023-09-13 16:08:52,310 Writing spectrum to hdf5 file: LightRays/spec_SiIII_Lya_ray1.h5.
yt : [INFO ] 2023-09-13 16:08:52,313 Setting instrument to Custom
yt : [INFO ] 2023-09-13 16:08:52,315 Creating spectrum
yt : [INFO ] 2023-09-13 16:08:52,320 30 out of 121 line components are unresolved.
Adding line - Si III 1206 [1206.500000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Si III 1206 [1206.500000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 4164.77it/s]
Adding line - Ly a [1215.670000 A]: 0%| | 0/121 [00:00<?, ?it/s]Adding line - Ly a [1215.670000 A]: 99%|█████████▉| 120/121 [00:00<00:00, 1853.34it/s]
yt : [INFO ] 2023-09-13 16:08:52,418 Not adding continuum Ly C: insufficient column density or out of range
yt : [INFO ] 2023-09-13 16:08:52,420 Applying specified line spread function.
yt : [INFO ] 2023-09-13 16:08:52,423 Writing spectrum to hdf5 file: LightRays/spec_SiIII_Lya_ray2.h5.
/var/folders/9t/skzkm_4169g47x95n5b3b5_h0000gn/T/ipykernel_3715/2514315971.py:250: MatplotlibDeprecationWarning: The label function was deprecated in Matplotlib 3.1 and will be removed in 3.8. Use Tick.label1 instead.
tick.label.set_fontsize(14)
/var/folders/9t/skzkm_4169g47x95n5b3b5_h0000gn/T/ipykernel_3715/2514315971.py:252: MatplotlibDeprecationWarning: The label function was deprecated in Matplotlib 3.1 and will be removed in 3.8. Use Tick.label1 instead.
tick.label.set_fontsize(14)
yt : [INFO ] 2023-09-13 16:08:52,442 Writing spectrum plot to png file: LightRays/COS130_1200_1230_SiIII_Lya.png
The width of absorption lines, like the Lyman Alpha line shown above, are partially due to turbulent velocity dispersion, i.e. the random motions of fluid elements that redshift and blueshift the light we see on Earth.
# Calculate the velocity standard deviation weighted by density
# Profile plots
= ray1.all_data()
raydat = (raydat['velocity_los']/100000)*raydat['density']
losvel print("Value along ray 1: ")
print(np.std(losvel))
= ray2.all_data()
raydat = (raydat['velocity_los']/100000)*raydat['density']
losvel print("Value along ray 2: ")
print(np.std(losvel))
Value along ray 1:
2.3913198647901003e-24 g/(cm**2*s)
Value along ray 2:
6.301139948527954e-25 g/(cm**2*s)
Turbulent motions are indeed stronger along ray 1 than ray 2, likely accounting for the increased line broadening. In fact, this interpretation makes physical sense given that ray 1 is closer to the LMC center where more star formation and wind driving occur, generating larger velocity and kinetic energy fluctuations.
Other useful mock observables: gamma-ray emission, Faraday rotation measure, and H-alpha emission
Some outcomes of this analysis can be found in Bustard et al. 2020 ApJ (and various AAS poster presentations by UW undergraduates), Ciampa et al. 2021 ApJ, and Livingston et al. 2023, in prep.
Faraday rotation measure
The line-of-sight (LOS) magnetic field strength is commonly probed by Faraday rotation measure, an integral along the LOS with dependence on the LOS magnetic field strength, B\(_{\rm LOS}\) and the electron number density, \(n_{e}\).
Because \(n_{e}\) depends on the ionization state of the gas, this is more complex to calculate and can’t be simply pulled out from yt. Here, we’ve loaded in tables of \(n_{e}/n_{H}\) as a function of the hydrogen number density \(n_{H}\) and the gas temperature. We then use a bilinear interpolator to interpolate between values in this 2D space.
from numpy import *
import h5py
import matplotlib.cm as cm
import matplotlib.mlab as mlab
from yt.fields import interpolated_fields
from yt.fields.field_detector import \
FieldDetectorfrom yt.utilities.linear_interpolators import \
BilinearFieldInterpolator
= yt.load("windCRs_hdf5_plt_cnt_0050")
ds
# pre-tabulated text files for ne/nH, T, nH
= loadtxt('nenh.txt')
nenh = loadtxt('Temps.txt')
tempTxt = loadtxt('NH.txt')
nHTxt
# ne/nH
def _nenh_interp(field, data):
# use yt's bilinear interpolator:
= BilinearFieldInterpolator(nenh,boundaries=[tempTxt,nHTxt],field_names=['temperature','number_density'], truncate=True)
interp
= interp(data)
field_data < 0] = 0.01 # if extrapolating, set a floor value of 1/100 -- this is a bit arbitrary and could be improved in the future
field_data[field_data return(field_data)
'gas','nenh_interp'), function=_nenh_interp, units="", take_log=False, display_name=r'$n_{e} / n_{H}$', sampling_type="cell")
ds.add_field((
def _log10_nenh_interp(field, data): # create the log10 version too just for ease
return(np.log10(data['nenh_interp']))
'gas','log10_nenh_interp'), function=_log10_nenh_interp, units="", take_log=False, display_name=r'log10($n_{e} / n_{H}$)', sampling_type="cell")
ds.add_field((
# Rotation measure
def _rotationMeasure(field, data):
# use yt's bilinear interpolator:
= BilinearFieldInterpolator(nenh,boundaries=[tempTxt,nHTxt],
interp =['temperature','number_density'], truncate=True)
field_names= interp(data)
field_data < 0] = 0.01
field_data[field_data return 0.812*field_data*data['number_density']*((-0.561*data['magnetic_field_x']
+ 0.099*data['magnetic_field_y']
+ 0.822*data['magnetic_field_z'])/1.e-6)*(1./3.0856e18)
'gas','rotationMeasure'), function=_rotationMeasure, units="gauss/cm**3", take_log=False, display_name='Rotation Measure', sampling_type="cell")
ds.add_field((
# B_LOS
def _losBField(field,data):
return (-0.561*data['magnetic_field_x'] + 0.099*data['magnetic_field_y'] + 0.822*data['magnetic_field_z'])/1.e-6
'gas','losBField'), function=_losBField, units="gauss", take_log=False, display_name='Line of Sight B Field', sampling_type="cell") ds.add_field((
yt : [INFO ] 2023-09-13 16:08:52,633 Parameters: current_time = 3.156010944496386e+16
yt : [INFO ] 2023-09-13 16:08:52,634 Parameters: domain_dimensions = [96 96 96]
yt : [INFO ] 2023-09-13 16:08:52,634 Parameters: domain_left_edge = [-6.171e+22 -6.171e+22 -6.171e+22]
yt : [INFO ] 2023-09-13 16:08:52,635 Parameters: domain_right_edge = [1.234e+23 1.234e+23 1.234e+23]
yt : [INFO ] 2023-09-13 16:08:52,635 Parameters: cosmological_simulation = 0
# Now plot the rotation measure as a mock observation
# first create a FITS file with rotation measure we can call on later
= yt.FITSOffAxisProjection(ds,L,'rotationMeasure',center = (0,0,0), width=(10, 'kpc'))
prj_fits = [79.0,-68.68] # in degrees
sky_center = (4123.71, "arcsec/kpc") # could also use a YTQuantity
sky_scale =["RA---TAN","DEC--TAN"], replace_old_wcs=True)
prj_fits.create_sky_wcs(sky_center, sky_scale, ctype"LMC_Ram_evolved_Faraday.fits", overwrite=True)
prj_fits.writeto(= fits.getdata('LMC_Ram_evolved_Faraday.fits')
image_data
# open the FITS file and plot rotation measure
= aplpy.FITSFigure("LMC_Ram_evolved_Faraday.fits")
fig
fig.add_grid()="RdBu",stretch = 'linear',vmin=-100, vmax = 100)
fig.show_colorscale(cmap"top")
fig.tick_labels.set_xposition(8.0)
fig.ticks.set_xspacing(8.0)
fig.ticks.set_yspacing(
fig.add_colorbar()'hh:mm')
fig.tick_labels.set_xformat('dd')
fig.tick_labels.set_yformat(r'Rotation Measure $\phi$ (rad $ m^{-2}$)') fig.colorbar.set_axis_label_text(
yt : [INFO ] 2023-09-13 16:09:19,729 Making a FITS image of field rotationMeasure
On the surface, this map looks quite reasonable…|RM| is highest near the center of the galaxy where both the density and magnetic field strength are presumably the largest, and due to the tilt of the galaxy, the B field is primarily directed toward us in the lower half and away from us in the upper half of the image. However, these RM values are quite a bit higher than what is observed, suggesting that either the electron density or magnetic field strength are too high. Or it could be that neither is, on average, too large, but they are too large in the same locations.
Let’s take a look at both \(n_{e}/n_{H}\) and \(B_{los}\)
# Now plot ne/nH to get a sense of how ionized the gas is.
= ds.box([0.0,-6.17E22,-3.0856E22],[1.2E23,6.17E22,3.0856E22])
region = [-0.561,0.099,0.822] # vector normal to cutting plane
L = yt.OffAxisProjectionPlot(ds, L, 'nenh_interp',weight_field="density",center=[0.0,0.0,0.0], width=(10, 'kpc'),fontsize=20)
d ="nenh_interp", cmap='PuOr')
d.set_cmap(field"nenh_interp", "$n_{e}/n_{H}$")
d.set_colorbar_label(
d.annotate_timestamp()
d.show()
= yt.OffAxisProjectionPlot(ds, L, "losBField",weight_field="density",center=[0.0,0.0,0.0], width=(10, 'kpc'),fontsize=20)
d ="losBField", cmap='cmr.wildfire')
d.set_cmap(field"losBField", r"B$_{\rm LOS}$")
d.set_colorbar_label(
d.annotate_timestamp() d.show()
yt : [INFO ] 2023-09-13 16:09:20,808 xlim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:09:20,808 ylim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:09:20,808 zlim = -92554999999999995019264.000000 92554999999999995019264.000000
yt : [INFO ] 2023-09-13 16:09:20,809 Making a fixed resolution buffer of (('gas', 'nenh_interp')) 800 by 800
yt : [INFO ] 2023-09-13 16:09:40,122 xlim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:09:40,122 ylim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:09:40,122 zlim = -92554999999999995019264.000000 92554999999999995019264.000000
yt : [INFO ] 2023-09-13 16:09:40,123 Making a fixed resolution buffer of (('gas', 'losBField')) 800 by 800
Let’s also make a phase plot showing cell-by-cell how the gas density, temperature, and ionization given by \(n_{e}/n_{H}\) correlate.
= ds.all_data()
dd = yt.PhasePlot(dd, "number_density", "temperature", "log10_nenh_interp",fontsize = 28)
plot # plot.set_cmap(field="magnetic_field_magnitude", cmap='viridis')
="log10_nenh_interp", cmap='viridis')
plot.set_cmap(field1.E3,1.E7)
plot.set_ylim(1.E-3,1.E1)
plot.set_xlim(# plot.set_zlim(field='magnetic_field_magnitude', zmin=1.E-8, zmax=1.E-5)
='log10_nenh_interp', zmin=-2, zmax=0.1)
plot.set_zlim(field plot.show()
# Check a mass-weighted PDF of ne/nh -- how much of the gas (by mass) has hit the floor I've imposed on ne/nh?
= yt.ProfilePlot(
plot
dd,"gas", "log10_nenh_interp"),
("gas", "rotationMeasure")],accumulation=False
[(
)"gas", "log10_nenh_interp"), False)
plot.set_log(( plot.show()
A huge fraction of the rotation measure comes from cells with floored ne/nh = 1e-2. Yikes!
The lesson: gas ionization is hard to model, and this implementation, which assumes photoionization equilibrium and neglects things like local ionizing radiation fields from massive stars in the LMC disk, is too naive. Nevertheless, the LMC simulations presented here provide useful comparisons to observations when a thorough analysis is done and their limitations are known
H \(\alpha\) emission – probing ~ 2e4 K gas
This shows a quick example of how to measure H-alpha emission from a series of simulation snapshots. For our example, we just use one snapshot, but this script can be applied to any other FLASH simulation output with a “cooling” output variable capturing the radiative cooling rate (See Bustard and Gronke 2022 for a use-case involving idealized simulations of the Magellanic Stream compared to real H-alpha observations)
Input: Set of simulation snapshots Output: A rough image, a table with columns = (time, max emission, average emission, standard deviation of emission)
import matplotlib as plt
from yt.units import Mpc
import collections
import glob
yt.enable_parallelism()
= YTQuantity(1, 'cm**2/s**2')
pUnit
# New function that takes in cooling rate ('cloo') and converts it to H-alpha luminosity
def CoolingmR(field,data):
return data['cloo']*YTQuantity(1,'erg/cm**3/s')/(4.0*np.pi*2.41e-10) # in mR
"gas","CoolingmR"), function=CoolingmR, sampling_type='local',units="erg/cm**3/s")
yt.add_field((
= 1
num_procs
# Could load in more than one data file and create a table with H-alpha statistics,
# but here we only use one data file (the one we downloaded)
= glob.glob('windCRs_hdf5_plt_cnt_0050*')
fns
fns.sort()
# Create an empty dictionary
= {}
data
# Iterate through each dataset in the Time Series (using piter allows it
# to happen in parallel automatically across available processors)
for sto,fn in yt.parallel_objects(fns,num_procs,storage=data):
= yt.load(fn)
ds = ds.all_data()
ad # ds.periodicity = (True,True,True) # deprecated
1] = 0
ds.coordinates.x_axis[1] = 2
ds.coordinates.y_axis[
= [-0.561,0.099,0.822] # vector normal to cutting plane
L = yt.OffAxisProjectionPlot(ds, L, 'CoolingmR',center=[0.0,0.0,0.0], width=(10, 'kpc'),fontsize=20)
d ="CoolingmR", cmap='PuOr')
d.set_cmap(field"CoolingmR", "$mR$")
d.set_colorbar_label(
d.annotate_timestamp()
d.show()
= ad.cut_region(['obj["CoolingmR"] > 0.0'])
dense_ad # c = yt.ProjectionPlot(ds, 1, "cloo",weight_field="density",fontsize=28)
= ds.proj("CoolingmR",1,data_source=dense_ad)
proj
#degrade the resolution to [nx,ny] -- we can play with this to mock the effects of lower resolution instruments
= proj.to_frb(width=(100,'kpc'),resolution=[128,128])
frb = np.array(frb["CoolingmR"])
my_image
#filtered_image = np.array(filter(lambda num: num > 0.0, my_image))
= my_image[my_image > 0.0]
filtered_image
# get max, avg, and standard deviation of cells with >0 emission
= np.amax(filtered_image)
maxCol = np.average(filtered_image)
avgCol = np.std(filtered_image)
stdCol
# Fill the dictionary with extrema and redshift information for each dataset
= ds.current_time.in_units('Myr')
time = ds.basename
sto.result_id = (time, maxCol, avgCol, stdCol)
sto.result # data[ds.basename] = (time, extrema, var)
# Convert dictionary to ordered dictionary to get the right order
= "cool_file_res_128.txt"
filename = open(filename,"w")#write mode
cool_file #if yt.is_root()
"Dataset Time Lum Max Lum average Lum std dev \n")
cool_file.write("--------------------------------------------------------------------------------------------------------------------------------------- \n ")
cool_file.write(for fn, val in sorted(data.items()):
"%s %05.3f %5.3g mR %5.3g mR %5.3g mR \n" % \
cool_file.write(0], val[1], val[2], val[3]))
(fn, val[
cool_file.close()
= open(filename, "r")
cool_file print(cool_file.read())
yt : [ERROR ] 2023-09-13 16:10:17,799 Could not enable parallelism: mpi4py is not installed
yt : [INFO ] 2023-09-13 16:10:17,851 Parameters: current_time = 3.156010944496386e+16
yt : [INFO ] 2023-09-13 16:10:17,852 Parameters: domain_dimensions = [96 96 96]
yt : [INFO ] 2023-09-13 16:10:17,852 Parameters: domain_left_edge = [-6.171e+22 -6.171e+22 -6.171e+22]
yt : [INFO ] 2023-09-13 16:10:17,852 Parameters: domain_right_edge = [1.234e+23 1.234e+23 1.234e+23]
yt : [INFO ] 2023-09-13 16:10:17,852 Parameters: cosmological_simulation = 0
yt : [INFO ] 2023-09-13 16:10:19,083 xlim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:10:19,083 ylim = -15428387904811624824832.000000 15428387904811624824832.000000
yt : [INFO ] 2023-09-13 16:10:19,083 zlim = -92554999999999995019264.000000 92554999999999995019264.000000
yt : [INFO ] 2023-09-13 16:10:19,084 Making a fixed resolution buffer of (('gas', 'CoolingmR')) 800 by 800
yt : [INFO ] 2023-09-13 16:10:30,192 Projection completed
yt : [INFO ] 2023-09-13 16:10:30,194 Making a fixed resolution buffer of (CoolingmR) 128 by 128
Dataset Time Lum Max Lum average Lum std dev
---------------------------------------------------------------------------------------------------------------------------------------
windCRs_hdf5_plt_cnt_0050 1000.080 4.11e+07 mR 8.7e+04 mR 1.89e+06 mR
This script can be extended further to show H-alpha emission across different velocity channels, for instance to see how slow vs fast-moving gas compares in emission. This is left as an exercise for now, but see Ciampa+ 2020 (incl. Bustard) for an example.