From 5b046655f8dd85d6bc43e805af38db90536a96bc Mon Sep 17 00:00:00 2001 From: Anikbh11 Date: Fri, 27 Mar 2020 17:26:57 +0100 Subject: [PATCH 1/3] 21 cm part updated --- .../absorption_spectrum/absorption_line.py | 88 ++++++++++++++++++- .../absorption_spectrum.py | 53 ++++++++--- 2 files changed, 123 insertions(+), 18 deletions(-) diff --git a/trident/absorption_spectrum/absorption_line.py b/trident/absorption_spectrum/absorption_line.py index ddd5750170..2a3a2c8b80 100644 --- a/trident/absorption_spectrum/absorption_line.py +++ b/trident/absorption_spectrum/absorption_line.py @@ -18,10 +18,14 @@ from yt.utilities.physical_constants import \ charge_proton_cgs, \ mass_electron_cgs, \ - speed_of_light_cgs + speed_of_light_cgs, \ + planck_constant_cgs, \ + boltzmann_constant_cgs from yt.utilities.on_demand_imports import _scipy, NotAModule +from yt.units.yt_array import YTArray, YTQuantity special = _scipy.special +signal = _scipy.signal tau_factor = None _cs = None @@ -143,7 +147,6 @@ def voigt_old(a, u): k1 = k1.astype(np.float64).clip(0) return k1 - def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, delta_v=None, delta_lambda=None, lambda_bins=None, n_lambda=12000, dlambda=0.01): @@ -159,7 +162,7 @@ def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, f_value : float absorption line f-value. gamma : float - absorption line gamma value. + absorption line gamma value v_doppler : float in cm/s doppler b-parameter. column_density : float in cm^-2 @@ -213,7 +216,7 @@ def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, # tau_0 tau_X = tau_factor * column_density * f_value / v_doppler tau0 = tau_X * lambda_0 * 1e-8 - + # dimensionless frequency offset in units of doppler freq x = _cs / v_doppler * (lam1 / lambda_bins - 1.0) a = gamma / (4.0 * np.pi * nudop) # damping parameter @@ -222,6 +225,83 @@ def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, return (lambda_bins, tauphi) +def tau_profile_21cm(lambda_0, f_value, gamma, temperature, number_density, + h_now, delta_v=None, delta_lambda=None, + lambda_bins=None, n_lambda=12000, dlambda=0.01): + r""" + Create an optical depth vs. wavelength profile for the + 21 cm forest. The optical depth is calculated using eq. 1 in https://arxiv.org/abs/1510.02296. At this point in the implementation, we make a very reasonable assumption that (1+ 1/H(z) dv/dr) ~ 1. + + Parameters + ---------- + + lambda_0 : float in angstroms + central wavelength. + f_value : float + absorption line f-value. + gamma : float + absorption line gamma value. For this case, represents the einstein coefficient A_10 + temperature : Gas temperature in K + Gas temperature. Assumption that T_K = T_S is made here. + number_density : float in cm^-2 + neutral hydrogen number density. + h_now ; hubble constant at redshift z + H(z) + delta_v : float in cm/s + velocity offset from lambda_0. + Default: None (no shift). + delta_lambda : float in angstroms + wavelength offset. + Default: None (no shift). + lambda_bins : array in angstroms + wavelength array for line deposition. If None, one will be + created using n_lambda and dlambda. + Default: None. + n_lambda : int + size of lambda bins to create if lambda_bins is None. + Default: 12000. + dlambda : float in angstroms + lambda bin width in angstroms if lambda_bins is None. + Default: 0.01. + + """ + global tau_factor + if tau_factor is None: + lam0 = YTQuantity(lambda_0,'angstrom') + gam = YTQuantity(gamma,'1/s') + tau_factor = ((3 / 32 / np.pi) * planck_constant_cgs * gam * + speed_of_light_cgs * lam0**2 / boltzmann_constant_cgs + ).in_cgs().d + + global _cs + if _cs is None: + _cs = speed_of_light_cgs.d[()] + + # shift lambda_0 by delta_v + if delta_v is not None: + lam1 = lambda_0 * (1 + delta_v / _cs) + elif delta_lambda is not None: + lam1 = lambda_0 + delta_lambda + else: + lam1 = lambda_0 + + # create wavelength + if lambda_bins is None: + lambda_bins = lam1 + \ + np.arange(n_lambda, dtype=np.float) * dlambda - \ + n_lambda * dlambda / 2 # wavelength vector (angstroms) + + # tau_0 + tau0 = (tau_factor * number_density) / (temperature * h_now) + idx = np.digitize(lam1,lambda_bins,right=True) + if idx == len(lambda_bins): + phi = np.zeros_like(lambda_bins) + else: + phi = signal.unit_impulse(lambda_bins.size,idx) + tauphi = tau0 * phi # profile scaled with tau0 + + return (lambda_bins, tauphi) + if isinstance(special, NotAModule): voigt = voigt_old diff --git a/trident/absorption_spectrum/absorption_spectrum.py b/trident/absorption_spectrum/absorption_spectrum.py index 7044b513e8..41a1daa51c 100644 --- a/trident/absorption_spectrum/absorption_spectrum.py +++ b/trident/absorption_spectrum/absorption_spectrum.py @@ -35,6 +35,9 @@ from trident.absorption_spectrum.absorption_line import \ tau_profile +from trident.absorption_spectrum.absorption_line import \ + tau_profile_21cm +from yt.utilities.cosmology import Cosmology pyfits = _astropy.pyfits @@ -468,6 +471,10 @@ def make_spectrum(self, input_object, output_file=None, input_ds.domain_left_edge = input_ds.domain_left_edge.to('code_length') input_ds.domain_right_edge = input_ds.domain_right_edge.to('code_length') + self.h0 = getattr(input_ds,'hubble_constant') + self.omega_matter = getattr(input_ds,'omega_matter') + self.omega_lambda = getattr(input_ds,'omega_lambda') + if self.bin_space == 'velocity': self.zero_redshift = getattr(input_ds, 'current_redshift', 0) @@ -707,6 +714,7 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, for store, line in parallel_objects(self.line_list, njobs=njobs, storage=self.line_observables_dict): column_density = field_data[line['field_name']] * field_data['dl'] + number_density = field_data[line['field_name']] if (column_density < 0).any(): mylog.warning( "Setting negative densities for field %s to 0! Bad!" % line['field_name']) @@ -738,19 +746,26 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, # the total number of absorbers per transition n_absorbers = len(lambda_obs) + temperature = field_data['temperature'].d - # thermal broadening b parameter - thermal_b = np.sqrt((2 * boltzmann_constant_cgs * - field_data['temperature']) / - line['atomic_mass']) - + # the actual thermal width of the lines + if line['wavelength'].d == 2.1e9: + thermal_b = YTArray(np.ones(redshift.size),'km/s') + else: + thermal_b = np.sqrt((2 * boltzmann_constant_cgs * + field_data['temperature']) / + line['atomic_mass']) # the actual thermal width of the lines thermal_width = (lambda_obs * thermal_b / c_kms).to('angstrom') + + co = Cosmology(self.h0,self.omega_matter,self.omega_lambda,0.0) + h_now = co.hubble_parameter(np.max(redshift)).d #H(z) # Sanitize units for faster runtime of the tau_profile machinery. lambda_0 = line['wavelength'].d # line's rest frame; angstroms cdens = column_density.in_units("cm**-2").d # cm**-2 + ndens = number_density.in_units("cm**-3").d # cm**-2 thermb = thermal_b.to('cm/s').d # thermal b coefficient; cm / s dlambda = delta_lambda.d # lambda offset; angstroms # Array to store sum of the tau values for each index in the @@ -786,10 +801,9 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, raise RuntimeError('What bin space is this?') resolution = my_width / self.bin_width - n_vbins_per_bin = (10 ** (np.ceil( np.log10( subgrid_resolution / - resolution) ).clip(0, np.inf) ) ).astype('int') + n_vbins_per_bin = (10 ** (np.ceil( np.log10(subgrid_resolution/ + resolution)).clip(0, np.inf))).astype('int') vbin_width = self.bin_width.d / n_vbins_per_bin - # a note to the user about which lines components are unresolved if (my_width < self.bin_width).any(): mylog.info("%d out of %d line components will be " + @@ -872,6 +886,7 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, my_vbins = vbins * \ wavelength_zero_point.d / c_kms.d + \ wavelength_zero_point.d + else: raise RuntimeError('What bin_space is this?') @@ -882,11 +897,18 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, 'increasing the bin size.') % my_vbins.size) # the virtual bins and their corresponding opacities - my_vbins, vtau = \ - tau_profile( - lambda_0, line['f_value'], line['gamma'], - thermb[i], cdens[i], - delta_lambda=dlambda[i], lambda_bins=my_vbins) + if (line['wavelength'].d == 2.1e9): + my_vbins, vtau = \ + tau_profile_21cm( + lambda_0, line['f_value'], line['gamma'], + temperature[i], ndens[i], h_now, + delta_lambda=dlambda[i], lambda_bins=my_vbins) + else: + my_vbins, vtau = \ + tau_profile( + lambda_0, line['f_value'], line['gamma'], + thermb[i], cdens[i], + delta_lambda=dlambda[i], lambda_bins=my_vbins) # If tau has not dropped below min tau threshold by the # edges (ie the wings), then widen the wavelength @@ -925,7 +947,10 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, # normal use of the word by observers. It is an equivalent # with in tau, not in flux, and is only used internally in # this subgrid deposition as EW_tau. - vEW_tau = vtau * vbin_width[i] + if lambda_0 == 2.1e9: + vEW_tau = vtau + else: + vEW_tau = vtau * vbin_width[i] EW_tau = np.zeros(right_index - left_index) EW_tau_indices = np.arange(left_index, right_index) for k, val in enumerate(EW_tau_indices): From c75c6e32d8df5b3e4f4e4d560d02375ea67d70ab Mon Sep 17 00:00:00 2001 From: Anikbh11 Date: Thu, 9 Apr 2020 16:01:27 +0200 Subject: [PATCH 2/3] Added a new option to select line deposition method --- .../absorption_spectrum/absorption_line.py | 58 ++++++++++++++----- .../absorption_spectrum.py | 56 ++++++++++++------ trident/data/line_lists/lines.txt | 6 +- trident/spectrum_generator.py | 14 ++++- 4 files changed, 96 insertions(+), 38 deletions(-) diff --git a/trident/absorption_spectrum/absorption_line.py b/trident/absorption_spectrum/absorption_line.py index 2a3a2c8b80..561f48f594 100644 --- a/trident/absorption_spectrum/absorption_line.py +++ b/trident/absorption_spectrum/absorption_line.py @@ -29,6 +29,13 @@ tau_factor = None _cs = None +def delta(lam1,lambda_bins): + idx = np.digitize(lam1,lambda_bins,right=True) + if idx == len(lambda_bins): + phi = np.zeros_like(lambda_bins) + else: + phi = signal.unit_impulse(lambda_bins.size,idx) + return phi def voigt_scipy(a, u): x = np.asarray(u).astype(np.float64) @@ -149,7 +156,8 @@ def voigt_old(a, u): def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, delta_v=None, delta_lambda=None, - lambda_bins=None, n_lambda=12000, dlambda=0.01): + lambda_bins=None, n_lambda=12000, dlambda=0.01, + deposition_method='voigt'): r""" Create an optical depth vs. wavelength profile for an absorption line using a voigt profile. @@ -183,6 +191,13 @@ def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, dlambda : float in angstroms lambda bin width in angstroms if lambda_bins is None. Default: 0.01. + :deposition_method: 'voigt' or 'delta' + Sets the line profile in which spectra are deposited. If set to + voigt, the resulting line profiles are deposited as voigt profiles + . If set to delta, the line profiles are set to delta. This is + useful for modelling the 21 cm Forest of neutral hydrogen and in cases + where thermal broadening is to be ignored. + Default: voigt """ global tau_factor @@ -220,17 +235,24 @@ def tau_profile(lambda_0, f_value, gamma, v_doppler, column_density, # dimensionless frequency offset in units of doppler freq x = _cs / v_doppler * (lam1 / lambda_bins - 1.0) a = gamma / (4.0 * np.pi * nudop) # damping parameter - phi = voigt(a, x) # line profile + if deposition_method == 'voigt': + phi = voigt(a, x) # line profile + else: + phi = delta(lam1,lambda_bins) tauphi = tau0 * phi # profile scaled with tau0 return (lambda_bins, tauphi) def tau_profile_21cm(lambda_0, f_value, gamma, temperature, number_density, h_now, delta_v=None, delta_lambda=None, - lambda_bins=None, n_lambda=12000, dlambda=0.01): + lambda_bins=None, n_lambda=12000, dlambda=0.01, + deposition_method='voigt'): r""" - Create an optical depth vs. wavelength profile for the - 21 cm forest. The optical depth is calculated using eq. 1 in https://arxiv.org/abs/1510.02296. At this point in the implementation, we make a very reasonable assumption that (1+ 1/H(z) dv/dr) ~ 1. + Create an optical depth vs. wavelength profile for the + 21 cm forest. The optical depth is calculated using eq. 1 + in https://arxiv.org/abs/1510.02296. + At the moment in the implementation, we make a very reasonable + assumption that (1+ 1/H(z) dv/dr) ~ 1. Parameters ---------- @@ -241,12 +263,12 @@ def tau_profile_21cm(lambda_0, f_value, gamma, temperature, number_density, absorption line f-value. gamma : float absorption line gamma value. For this case, represents the einstein coefficient A_10 - temperature : Gas temperature in K + temperature : float in Kelvin Gas temperature. Assumption that T_K = T_S is made here. - number_density : float in cm^-2 - neutral hydrogen number density. - h_now ; hubble constant at redshift z - H(z) + number_density : float in cm^-3 + neutral hydrogen number density + h_now ; float in s^-1 + Hhubble constant at redshift z. H(z) delta_v : float in cm/s velocity offset from lambda_0. Default: None (no shift). @@ -263,6 +285,13 @@ def tau_profile_21cm(lambda_0, f_value, gamma, temperature, number_density, dlambda : float in angstroms lambda bin width in angstroms if lambda_bins is None. Default: 0.01. + :deposition_method: 'voigt' or 'delta' + Sets the line profile in which spectra are deposited. If set to + voigt, the resulting line profiles are deposited as voigt profiles + . If set to delta, the line profiles are set to delta. This is + useful for modelling the 21 cm Forest of neutral hydrogen and in cases + where thermal broadening is to be ignored. + Default: voigt """ global tau_factor @@ -293,11 +322,10 @@ def tau_profile_21cm(lambda_0, f_value, gamma, temperature, number_density, # tau_0 tau0 = (tau_factor * number_density) / (temperature * h_now) - idx = np.digitize(lam1,lambda_bins,right=True) - if idx == len(lambda_bins): - phi = np.zeros_like(lambda_bins) - else: - phi = signal.unit_impulse(lambda_bins.size,idx) + if deposition_method == 'voigt': + raise RuntimeError('21 cm currently only supports delta profile deposition') + else: + phi = delta(lam1,lambda_bins) #line profile as a delta tauphi = tau0 * phi # profile scaled with tau0 return (lambda_bins, tauphi) diff --git a/trident/absorption_spectrum/absorption_spectrum.py b/trident/absorption_spectrum/absorption_spectrum.py index 41a1daa51c..f0086c0c79 100644 --- a/trident/absorption_spectrum/absorption_spectrum.py +++ b/trident/absorption_spectrum/absorption_spectrum.py @@ -91,16 +91,27 @@ class AbsorptionSpectrum(object): wavelength. If set to velocity, the spectra are flux vs. velocity offset from the rest wavelength of the absorption line. Default: wavelength + + :deposition_method: 'voigt' or 'delta' + + Sets the line profile in which spectra are deposited. If set to + voigt, the resulting line profiles are deposited as voigt profiles + . If set to delta, the line profiles are set to delta. This is + useful for modelling the 21 cm Forest of neutral hydrogen and in cases + where thermal broadening is to be ignored. + Default: voigt + """ def __init__(self, lambda_min, lambda_max, n_lambda=None, dlambda=None, - bin_space='wavelength'): + bin_space='wavelength',deposition_method='voigt'): if bin_space not in _bin_space_units: raise RuntimeError( 'Invalid bin_space value: "%s". Valid values are: "%s".' % (bin_space, '", "'.join(list(_bin_space_units)))) self.bin_space = bin_space + self.deposition_method = deposition_method lunits = _bin_space_units[self.bin_space] if dlambda is not None: @@ -471,7 +482,7 @@ def make_spectrum(self, input_object, output_file=None, input_ds.domain_left_edge = input_ds.domain_left_edge.to('code_length') input_ds.domain_right_edge = input_ds.domain_right_edge.to('code_length') - self.h0 = getattr(input_ds,'hubble_constant') + self.hubble_constant = getattr(input_ds,'hubble_constant') self.omega_matter = getattr(input_ds,'omega_matter') self.omega_lambda = getattr(input_ds,'omega_lambda') @@ -748,20 +759,17 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, n_absorbers = len(lambda_obs) temperature = field_data['temperature'].d - # the actual thermal width of the lines - if line['wavelength'].d == 2.1e9: - thermal_b = YTArray(np.ones(redshift.size),'km/s') - else: - thermal_b = np.sqrt((2 * boltzmann_constant_cgs * - field_data['temperature']) / - line['atomic_mass']) + # thermal broadening b parameter + thermal_b = np.sqrt((2 * boltzmann_constant_cgs * + field_data['temperature']) / + line['atomic_mass']) # the actual thermal width of the lines thermal_width = (lambda_obs * thermal_b / c_kms).to('angstrom') - co = Cosmology(self.h0,self.omega_matter,self.omega_lambda,0.0) - h_now = co.hubble_parameter(np.max(redshift)).d #H(z) + co = Cosmology(self.hubble_constant,self.omega_matter,self.omega_lambda,0.0) + h_now = co.hubble_parameter(self.zero_redshift).d #H(z) s^-1 # Sanitize units for faster runtime of the tau_profile machinery. lambda_0 = line['wavelength'].d # line's rest frame; angstroms cdens = column_density.in_units("cm**-2").d # cm**-2 @@ -792,7 +800,6 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, # 3) a bin width will be divisible by vbin_width times a power of # 10; this will assure we don't get spikes in the deposited # spectra from uneven numbers of vbins per bin - if self.bin_space == 'wavelength': my_width = thermal_width elif self.bin_space == 'velocity': @@ -865,7 +872,6 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, # may be <0 or >the size of the array. In the end, we deposit # the bins that actually overlap with the AbsorptionSpectrum's # range in lambda. - left_index, center_index, right_index = \ self._get_bin_indices( my_lambda, self.bin_width, @@ -897,18 +903,20 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, 'increasing the bin size.') % my_vbins.size) # the virtual bins and their corresponding opacities - if (line['wavelength'].d == 2.1e9): + if (line['label'] == '21 cm'): my_vbins, vtau = \ tau_profile_21cm( lambda_0, line['f_value'], line['gamma'], temperature[i], ndens[i], h_now, - delta_lambda=dlambda[i], lambda_bins=my_vbins) + delta_lambda=dlambda[i], lambda_bins=my_vbins, + deposition_method=self.deposition_method) else: my_vbins, vtau = \ tau_profile( lambda_0, line['f_value'], line['gamma'], thermb[i], cdens[i], - delta_lambda=dlambda[i], lambda_bins=my_vbins) + delta_lambda=dlambda[i], lambda_bins=my_vbins, + deposition_method=self.deposition_method) # If tau has not dropped below min tau threshold by the # edges (ie the wings), then widen the wavelength @@ -947,16 +955,26 @@ def _add_lines_to_spectrum(self, field_data, use_peculiar_velocity, # normal use of the word by observers. It is an equivalent # with in tau, not in flux, and is only used internally in # this subgrid deposition as EW_tau. - if lambda_0 == 2.1e9: + # The different behavior for the 21 cm line here stems from + # the fact that line profiles are treated as deltas instead + # of voigt profiles. + if self.deposition_method == 'voigt': + vEW_tau = vtau * vbin_width[i] + elif self.deposition_method == 'delta': vEW_tau = vtau else: - vEW_tau = vtau * vbin_width[i] + raise RuntimeError('Unknown line deposition method') EW_tau = np.zeros(right_index - left_index) EW_tau_indices = np.arange(left_index, right_index) for k, val in enumerate(EW_tau_indices): EW_tau[k] = vEW_tau[n_vbins_per_bin[i] * k: n_vbins_per_bin[i] * (k + 1)].sum() - EW_tau = EW_tau/self.bin_width.d + if self.deposition_method == 'voigt': + EW_tau = EW_tau/self.bin_width.d + elif self.deposition_method == 'delta': + EW_tau = EW_tau + else: + raise RuntimeError('Unknown line deposition method') # only deposit EW_tau bins that actually intersect the original # spectral wavelength range (i.e. lambda_field) diff --git a/trident/data/line_lists/lines.txt b/trident/data/line_lists/lines.txt index 3e3b17131a..e012945ff8 100644 --- a/trident/data/line_lists/lines.txt +++ b/trident/data/line_lists/lines.txt @@ -1,5 +1,6 @@ #Ion Wavelength [A] gamma f_value alt. name H I 1215.670000 4.690000e+08 4.160000e-01 Ly a +H I 2.1000000e9 2.850000e-15 4.160000e-01 21 cm H I 1025.722200 5.570000e+07 7.910000e-02 Ly b H I 972.536740 1.280000e+07 2.900000e-02 Ly c H I 949.742980 4.120000e+06 1.390000e-02 Ly d @@ -49,7 +50,7 @@ C I 1193.031000 6.390000e+07 4.090000e-02 C I 1188.833000 1.950000e+07 1.240000e-02 C I 1157.910000 3.520000e+07 2.120000e-02 C II 1335.663000 4.760000e+07 1.270000e-02 C II* 1336 -C II 1334.532000 2.410000e+08 1.290000e-01 +C II 1334.532000 2.400000e+08 1.280000e-01 C II 1037.018000 1.460000e+09 1.180000e-01 C II* 1037 C II 1036.337000 7.380000e+08 1.190000e-01 C II 903.962000 2.700000e+09 3.310000e-01 @@ -79,7 +80,7 @@ N V 1242.804000 3.370000e+08 7.800000e-02 N V 1238.821000 3.400000e+08 1.560000e-01 O I 1306.029000 6.760000e+07 5.190000e-02 O I* 1306 O I 1304.858000 2.030000e+08 5.180000e-02 O I* 1305 -O I 1302.168000 3.410000e+08 5.200000e-02 +O I 1302.168000 3.150000e+08 4.800000e-02 O I 1039.230000 9.430000e+07 9.160000e-03 O I 988.773000 2.260000e+08 4.640000e-02 O I 988.655000 5.770000e+07 8.460000e-03 @@ -196,6 +197,7 @@ Ar VII 585.748000 7.830000e+09 1.210000e+00 Ca X 574.010000 3.200000e+09 1.600000e-01 Ca X 557.765000 3.500000e+09 3.260000e-01 Fe II 1608.450830 1.910000e+08 5.910000e-02 +Fe II 2382.765200 3.130000e+08 0.320000e-01 Fe II 1143.225730 1.000000e+08 1.900000e-02 Fe II 1127.098400 6.000000e+06 1.100000e-03 Fe II 1125.447630 1.000000e+08 1.600000e-02 diff --git a/trident/spectrum_generator.py b/trident/spectrum_generator.py index f3538d5247..fc83eb853b 100644 --- a/trident/spectrum_generator.py +++ b/trident/spectrum_generator.py @@ -134,6 +134,15 @@ class SpectrumGenerator(AbsorptionSpectrum): velocity offset from the rest wavelength of the absorption line. Default: wavelength + :deposition_method: 'voigt' or 'delta' + + Sets the line profile in which spectra are deposited. If set to + voigt, the resulting line profiles are deposited as voigt profiles + . If set to delta, the line profiles are set to delta. This is + useful for modelling the 21 cm Forest of neutral hydrogen and in cases + where thermal broadening is to be ignored. + Default: voigt + :lsf_kernel: string, optional The filename for the LSF kernel. Files are found in @@ -190,7 +199,7 @@ class SpectrumGenerator(AbsorptionSpectrum): def __init__(self, instrument=None, lambda_min=None, lambda_max=None, n_lambda=None, dlambda=None, lsf_kernel=None, line_database='lines.txt', ionization_table=None, - bin_space='wavelength'): + bin_space='wavelength',deposition_method='voigt'): if instrument is None and \ ((lambda_min is None or lambda_max is None) or \ (dlambda is None and n_lambda is None)): @@ -213,7 +222,8 @@ def __init__(self, instrument=None, lambda_min=None, lambda_max=None, self.instrument.lambda_max, n_lambda=self.instrument.n_lambda, dlambda=self.instrument.dlambda, - bin_space=bin_space) + bin_space=bin_space, + deposition_method=deposition_method) if isinstance(line_database, LineDatabase): self.line_database = line_database From 4edad87889997dbafcef68c6a564cf67d921c938 Mon Sep 17 00:00:00 2001 From: Anikbh11 Date: Thu, 9 Apr 2020 16:38:46 +0200 Subject: [PATCH 3/3] Minor update ensuring lightray redshift is global for wavelength space too --- trident/absorption_spectrum/absorption_spectrum.py | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/trident/absorption_spectrum/absorption_spectrum.py b/trident/absorption_spectrum/absorption_spectrum.py index f0086c0c79..30fc976c68 100644 --- a/trident/absorption_spectrum/absorption_spectrum.py +++ b/trident/absorption_spectrum/absorption_spectrum.py @@ -485,9 +485,7 @@ def make_spectrum(self, input_object, output_file=None, self.hubble_constant = getattr(input_ds,'hubble_constant') self.omega_matter = getattr(input_ds,'omega_matter') self.omega_lambda = getattr(input_ds,'omega_lambda') - - if self.bin_space == 'velocity': - self.zero_redshift = getattr(input_ds, 'current_redshift', 0) + self.zero_redshift = getattr(input_ds, 'current_redshift', 0) # temperature field required to calculate voigt profile widths if ('temperature' not in input_ds.derived_field_list) and \