Background Modeling

When fitting a spectrum with a background, it is invalid to simply subtract off the background if the background is part of the data’s generative model van Dyk et al. (2001). Therefore, we are often left with the task of modeling the statistical process of the background along with our source.

In typical spectral modeling, we find a few common cases when background is involved. If we have total counts (\(S_i\)) in \(i^{\rm th}\) on \(N\) bins observed for an exposure of \(t_{\rm s}\) and also a measurement of \(B_i\) background counts from looking off source for \(t_{\rm b}\) seconds, we can then suppose a model for the source rate (\(m_i\)) and background rate (\(b_i\)).

Poisson source with Poisson background

This is described by a likelihood of the following form:

\[L = \prod^N_{i=1} \frac{(t_{\rm s}(m_i+b_i))^{S_i} e^{-t_{\rm s}(m_i+b_i)}}{S_i!} \times \frac{(t_{\rm b} b_i)^{B_i} e^{-t_{\rm b}b_i}}{B_i!}\]

which is a Poisson likelihood for the total model (\(m_i +b_i\)) conditional on the Poisson distributed background observation. This is the typical case for e.g. aperture x-ray instruments that observe a source region and then a background region. Both observations are Poisson distributed.

Poisson source with Gaussian background

This likelihood is similar, but the conditonal background distribution is described by Gaussian:

\[L = \prod^N_{i=1} \frac{(t_{\rm s}(m_i+b_i))^{S_i} e^{-t_{\rm s}(m_i+b_i)}}{S_i!} \times \frac{1}{\sigma_{b,i}\sqrt{2 \pi}} \exp \left[ \frac{({B_i} - t_{\rm b} b_i)^2} {2 \sigma_{b,i}^2} \right]\]

where the \(\sigma_{b,i}\) are the measured errors on \(B_i\). This situation occurs e.g. when the background counts are estimated from a fitted model such as time-domain instruments that estimate the background counts from temporal fits to the lightcurve.

In 3ML, we can fit a background model along with the the source model which allows for arbitrarily low background counts (in fact zero) in channels. The alternative is to use profile likelihoods where we first differentiate the likelihood with respect to the background model

\[\frac{ \partial L}{{\partial b_i}} = 0\]

and solve for the \(b_i\) that maximize the likelihood. Both the Poisson and Gaussian background profile likelihoods are described in the XSPEC statistics guide. This implicitly yields \(N\) parameters to the model thus requiring at least one background count per channel. These profile likelihoods are the default Poisson likelihoods in 3ML when a background model is not used with a SpectrumLike (and its children, DispersionSpectrumLike and OGIPLike) plugin.

Let’s examine how to handle both cases.

[1]:
import warnings

warnings.simplefilter("ignore")
import numpy as np

np.seterr(all="ignore")
[1]:
{'divide': 'warn', 'over': 'warn', 'under': 'ignore', 'invalid': 'warn'}
[2]:
%%capture
from threeML import *
[3]:
from jupyterthemes import jtplot

%matplotlib inline
jtplot.style(context="talk", fscale=1, ticks=True, grid=False)
set_threeML_style()
silence_warnings()
import astropy.units as u

First we will create an observation where we have a simulated broken power law source spectrum along with an observed background spectrum. The background is a powerl law continuum with a Gaussian line.

[4]:

# create the simulated observation energies = np.logspace(1, 4, 151) low_edge = energies[:-1] high_edge = energies[1:] # get a BPL source function source_function = Broken_powerlaw(K=2, xb=300, piv=300, alpha=0.0, beta=-3.0) # power law background function background_function = Powerlaw(K=0.5, index=-1.5, piv=100.0) + Gaussian( F=50, mu=511, sigma=20 ) spectrum_generator = SpectrumLike.from_function( "fake", source_function=source_function, background_function=background_function, energy_min=low_edge, energy_max=high_edge, ) spectrum_generator.view_count_spectrum()
18:11:15 INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: None                                                           SpectrumLike.py:492
18:11:18 INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: None                                                           SpectrumLike.py:492
         INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: poisson                                                        SpectrumLike.py:492
         INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: poisson                                                        SpectrumLike.py:492
[4]:
../_images/notebooks_Background_modeling_5_12.png
../_images/notebooks_Background_modeling_5_13.png

Using a profile likelihood

We have very few counts counts in some channels (in fact sometimes zero), but let’s assume we do not know the model for the background. In this case, we will use the profile Poisson likelihood.

[5]:
# instance our source spectrum
bpl = Broken_powerlaw(piv=300, xb=500)

# instance a point source
ra, dec = 0, 0
ps_src = PointSource("source", ra, dec, spectral_shape=bpl)

# instance the likelihood model
src_model = Model(ps_src)

# pass everything to a joint likelihood object
jl_profile = JointLikelihood(src_model, DataList(spectrum_generator))


# fit the model
_ = jl_profile.fit()

# plot the fit in count space
_ = spectrum_generator.display_model(step=False)
18:11:19 INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 1.99 -0.14 +0.15 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (3.05 +/- 0.11) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (7 +/- 8) x 10^-2
source.spectrum.main.Broken_powerlaw.beta -3.33 +/- 0.19
Correlation matrix:

1.00-0.620.760.02
-0.621.00-0.48-0.57
0.76-0.481.000.01
0.02-0.570.011.00
Values of -log(likelihood) at the minimum:

-log(likelihood)
fake 393.752231
total 393.752231
Values of statistical measures:

statistical measures
AIC 795.780323
BIC 807.547002
../_images/notebooks_Background_modeling_7_9.png

Our fit recovers the simulated parameters. However, we should have binned the spectrum up such that there is at least one background count per spectral bin for the profile to be valid.

[6]:
spectrum_generator.rebin_on_background(1)

spectrum_generator.view_count_spectrum()

_ = jl_profile.fit()

_ = spectrum_generator.display_model(step=False)
18:11:24 INFO      Now using 83 bins                                                           SpectrumLike.py:1739
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 2.03 -0.15 +0.16 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (2.98 +/- 0.11) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (1.2 +/- 0.9) x 10^-1
source.spectrum.main.Broken_powerlaw.beta -3.18 +/- 0.17
Correlation matrix:

1.00-0.630.760.02
-0.631.00-0.48-0.57
0.76-0.481.000.01
0.02-0.570.011.00
Values of -log(likelihood) at the minimum:

-log(likelihood)
fake 293.282481
total 293.282481
Values of statistical measures:

statistical measures
AIC 594.840824
BIC 606.607503
../_images/notebooks_Background_modeling_9_9.png
../_images/notebooks_Background_modeling_9_10.png

Modeling the background

Now let’s try to model the background assuming we know that the background is a power law with a Gaussian line. We can extract a background plugin from the data by passing the original plugin to a classmethod of spectrum like.

[7]:
# extract the background from the spectrum plugin.
# This works for OGIPLike plugins as well, though we could easily also just read
# in a bakcground PHA
background_plugin = SpectrumLike.from_background("bkg", spectrum_generator)
18:11:26 INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: None                                                           SpectrumLike.py:492

This constructs a new plugin with only the observed background so that we can first model it.

[8]:
background_plugin.view_count_spectrum()
[8]:
../_images/notebooks_Background_modeling_13_0.png
../_images/notebooks_Background_modeling_13_1.png

We now construct our background model and fit it to the data. Let’s assume we know that the line occurs at 511 keV, but we are unsure of its strength an width. We do not need to bin the data up because we are using a simple Poisson likelihood which is valid even when we have zero counts Cash (1979).

[9]:
# instance the spectrum setting the line's location to 511
bkg_spectrum = Powerlaw(piv=100) + Gaussian(F=50, mu=511)

# setup model parameters
# fix the line's location
bkg_spectrum.mu_2.fix = True

# nice parameter bounds
bkg_spectrum.K_1.bounds = (1e-4, 10)
bkg_spectrum.F_2.bounds = (0.0, 1000)
bkg_spectrum.sigma_2.bounds = (2, 30)

ps_bkg = PointSource("bkg", 0, 0, spectral_shape=bkg_spectrum)

bkg_model = Model(ps_bkg)


jl_bkg = JointLikelihood(bkg_model, DataList(background_plugin))


_ = jl_bkg.fit()

_ = background_plugin.display_model(
    step=False, data_color="#1A68F0", model_color="#FF9700"
)
         INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
bkg.spectrum.main.composite.K_1 (3.26 -0.23 +0.25) x 10^-1 1 / (keV s cm2)
bkg.spectrum.main.composite.index_1 -1.39 +/- 0.04
bkg.spectrum.main.composite.F_2 (2.3 +/- 0.5) x 10 1 / (s cm2)
bkg.spectrum.main.composite.sigma_2 (2.5 +/- 0.6) x 10 keV
Correlation matrix:

1.000.17-0.10-0.11
0.171.00-0.09-0.10
-0.10-0.091.000.26
-0.11-0.100.261.00
Values of -log(likelihood) at the minimum:

-log(likelihood)
bkg 220.041326
total 220.041326
Values of statistical measures:

statistical measures
AIC 448.358513
BIC 460.125192
../_images/notebooks_Background_modeling_15_9.png

We now have a model and estimate for the background which we can use when fitting with the source spectrum. We now create a new plugin with just the total observation and pass our background plugin as the background argument.

[10]:
modeled_background_plugin = SpectrumLike(
    "full",
    # here we use the original observation
    observation=spectrum_generator.observed_spectrum,
    # we pass the background plugin as the background!
    background=background_plugin,
)
18:11:28 INFO      Background modeled from plugin: bkg                                          SpectrumLike.py:479
         INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: poisson                                                        SpectrumLike.py:492

When we look at out count spectrum now, we will see the predicted background, rather than the measured one:

[11]:
modeled_background_plugin.view_count_spectrum()
[11]:
../_images/notebooks_Background_modeling_19_0.png
../_images/notebooks_Background_modeling_19_1.png

Now we simply fit the spectrum as we did in the profiled case. The background plugin’s parameters are stored in our new plugin as nuissance parameters:

[12]:
modeled_background_plugin.nuisance_parameters
[12]:
OrderedDict([('cons_full',
              Parameter cons_full = 1.0 []
              (min_value = 0.8, max_value = 1.2, delta = 0.05, free = False)),
             ('bkg_bkg_position_ra_full',
              Parameter ra = 0.0 [deg]
              (min_value = 0.0, max_value = 360.0, delta = 0.1, free = False)),
             ('bkg_bkg_position_dec_full',
              Parameter dec = 0.0 [deg]
              (min_value = -90.0, max_value = 90.0, delta = 0.1, free = False)),
             ('bkg_bkg_spectrum_main_composite_K_1_full',
              Parameter K_1 = 0.32648975531648045 [1 / (keV s cm2)]
              (min_value = 0.0001, max_value = 10.0, delta = 0.1, free = True)),
             ('bkg_bkg_spectrum_main_composite_piv_1_full',
              Parameter piv_1 = 100.0 [keV]
              (min_value = None, max_value = None, delta = 0.1, free = False)),
             ('bkg_bkg_spectrum_main_composite_index_1_full',
              Parameter index_1 = -1.3851376936691941 []
              (min_value = -10.0, max_value = 10.0, delta = 0.20099999999999998, free = True)),
             ('bkg_bkg_spectrum_main_composite_F_2_full',
              Parameter F_2 = 22.63390398744746 [1 / (s cm2)]
              (min_value = 0.0, max_value = 1000.0, delta = 0.1, free = True)),
             ('bkg_bkg_spectrum_main_composite_mu_2_full',
              Parameter mu_2 = 511.0 [keV]
              (min_value = None, max_value = None, delta = 0.1, free = False)),
             ('bkg_bkg_spectrum_main_composite_sigma_2_full',
              Parameter sigma_2 = 25.019609226472898 [keV]
              (min_value = 2.0, max_value = 30.0, delta = 0.1, free = True)),
             ('bkg_cons_bkg_full',
              Parameter cons_bkg = 1.0 []
              (min_value = 0.8, max_value = 1.2, delta = 0.05, free = False))])

and the fitting engine will use them in the fit. The parameters will still be connected to the background plugin and its model and thus we can free/fix them there as well as set priors on them.

[13]:
# instance the source model... the background plugin has it's model already specified
bpl = Broken_powerlaw(piv=300, xb=500)

bpl.K.bounds = (1e-5, 1e1)
bpl.xb.bounds = (1e1, 1e4)

ps_src = PointSource("source", 0, 0, bpl)

src_model = Model(ps_src)


jl_src = JointLikelihood(src_model, DataList(modeled_background_plugin))

_ = jl_src.fit()
18:11:29 INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 2.03 -0.15 +0.16 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (2.99 +/- 0.11) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (1.4 +/- 0.9) x 10^-1
source.spectrum.main.Broken_powerlaw.beta -3.29 +/- 0.20
K_1 (3.46 +/- 0.29) x 10^-1 1 / (keV s cm2)
index_1 -1.381 +/- 0.035
F_2 (2.2 +/- 0.4) x 10 1 / (s cm2)
sigma_2 (1.9 +/- 0.5) x 10 keV
Correlation matrix:

1.00-0.620.760.040.12-0.170.000.00
-0.621.00-0.47-0.59-0.020.20-0.05-0.03
0.76-0.471.000.020.34-0.22-0.01-0.01
0.04-0.590.021.00-0.19-0.27-0.050.01
0.12-0.020.34-0.191.000.16-0.06-0.10
-0.170.20-0.22-0.270.161.00-0.04-0.08
0.00-0.05-0.01-0.05-0.06-0.041.000.31
0.00-0.03-0.010.01-0.10-0.080.311.00
Values of -log(likelihood) at the minimum:

-log(likelihood)
full 517.729162
total 517.729162
Values of statistical measures:

statistical measures
AIC 1052.479600
BIC 1075.543405
[14]:

# over plot the joint background and source fits fig = modeled_background_plugin.display_model(step=False) _ = background_plugin.display_model( data_color="#1A68F0", model_color="#FF9700", model_subplot=fig.axes, step=False )
../_images/notebooks_Background_modeling_24_0.png
[ ]: