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()
22:13:34 INFO      Auto-probed noise models:                                                    SpectrumLike.py:490
         INFO      - observation: poisson                                                       SpectrumLike.py:491
         INFO      - background: None                                                           SpectrumLike.py:492
22:13:36 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
22:13:37 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)
22:13:38 INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 2.10 -0.14 +0.15 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (3.14 +/- 0.11) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (8 +/- 8) x 10^-2
source.spectrum.main.Broken_powerlaw.beta -3.37 +/- 0.20
Correlation matrix:

1.00-0.610.730.02
-0.611.00-0.46-0.56
0.73-0.461.000.01
0.02-0.560.011.00
Values of -log(likelihood) at the minimum:

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

statistical measures
AIC 862.415665
BIC 874.182344
../_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)
22:13:43 INFO      Now using 86 bins                                                           SpectrumLike.py:1739
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 2.13 -0.14 +0.15 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (3.12 +/- 0.11) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (1.1 +/- 0.8) x 10^-1
source.spectrum.main.Broken_powerlaw.beta -3.29 +/- 0.17
Correlation matrix:

1.00-0.620.730.02
-0.621.00-0.46-0.58
0.73-0.461.000.01
0.02-0.580.011.00
Values of -log(likelihood) at the minimum:

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

statistical measures
AIC 630.959049
BIC 642.725728
../_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)
22:13:44 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"
)
22:13:45 INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
bkg.spectrum.main.composite.K_1 (3.41 -0.24 +0.25) x 10^-1 1 / (keV s cm2)
bkg.spectrum.main.composite.index_1 -1.38 +/- 0.04
bkg.spectrum.main.composite.F_2 (1.5 +/- 0.4) x 10 1 / (s cm2)
bkg.spectrum.main.composite.sigma_2 (1.11 +/- 0.32) x 10 keV
Correlation matrix:

1.000.13-0.05-0.05
0.131.00-0.05-0.05
-0.05-0.051.000.21
-0.05-0.050.211.00
Values of -log(likelihood) at the minimum:

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

statistical measures
AIC 441.185188
BIC 452.951867
../_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,
)
22:13:47 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.34088453650240036 [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.3782592097027342 []
              (min_value = -10.0, max_value = 10.0, delta = 0.20099999999999998, free = True)),
             ('bkg_bkg_spectrum_main_composite_F_2_full',
              Parameter F_2 = 15.324862264713293 [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 = 11.07546445357054 [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()
22:13:48 INFO      set the minimizer to minuit                                             joint_likelihood.py:1045
Best fit values:

result unit
parameter
source.spectrum.main.Broken_powerlaw.K 2.02 -0.13 +0.14 1 / (keV s cm2)
source.spectrum.main.Broken_powerlaw.xb (3.14 -0.11 +0.12) x 10^2 keV
source.spectrum.main.Broken_powerlaw.alpha (2 +/- 8) x 10^-2
source.spectrum.main.Broken_powerlaw.beta -3.32 +/- 0.19
K_1 (3.57 +/- 0.29) x 10^-1 1 / (keV s cm2)
index_1 -1.379 +/- 0.035
F_2 (1.5 +/- 0.4) x 10 1 / (s cm2)
sigma_2 (1.13 +/- 0.28) x 10 keV
Correlation matrix:

1.00-0.610.740.040.10-0.170.000.00
-0.611.00-0.46-0.60-0.020.19-0.05-0.03
0.74-0.461.000.020.34-0.25-0.00-0.00
0.04-0.600.021.00-0.18-0.26-0.02-0.00
0.10-0.020.34-0.181.000.12-0.04-0.04
-0.170.19-0.25-0.260.121.00-0.03-0.03
0.00-0.05-0.00-0.02-0.04-0.031.000.31
0.00-0.03-0.00-0.00-0.04-0.030.311.00
Values of -log(likelihood) at the minimum:

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

statistical measures
AIC 1112.139939
BIC 1135.203745
[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
[ ]: