Puma plotting tutorial

Introduction

In this tutorial you will learn how to use puma, the Plotting UMami Api. The idea behind puma is to provide a plotting API that is easy to use but at the same time highly configurable. This means that the user has full control over the plot while things like uncertainties, labels, ratio panels can be added easily.

You can find the puma documentation here.

puma is based on matplotlib and helps you to produce most of the types of plots that are commonly used in flavour tagging like the ones shown below:

In this tutorial you will learn how to:

  1. A small introduction to the different metrics used in flavour tagging.

  2. Plot histograms with puma, where you will produce plots of both jet- and track-variables.

  3. Plot ROC curves of two taggers, with ratio panels that compare the curves.

  4. Plot the efficiency/rejection of a tagger as a function of pt.

The tutorial is meant to be followed in a self-guided manner. You will be prompted to do certain tasks by telling you what the desired outcome will be, without telling you how to do it. In case you are stuck, you can click on the "hint" toggle box to get a hint. If you tried for more than 10 min at a problem, feel free to toggle also the solution with a worked example.

Setting Up Everything You Need

A pleasant way to work through the tutorial is using a jupyter notebook environment.

Jupyter Lab on DESY NAF: http://naf-jhub.desy.de

Documentation: https://confluence.desy.de/display/IS/Jupyter+on+NAF

Display images in jupyter notebook

The scripts in the tutorial save the images as png files. You can display them in the notebook with this piece of code in a python cell:

from IPython.display import Image

Image("path_to_image")

Alternatively, you can use markdown syntax in a markdown cell:

![](path_to_image)

For the tutorial, you will need puma. The puma package can be easily installed via the command

pip3 install puma-hep

If you are using jupyterlab on DESY NAF, then using the ftag Kernel will provide you already with puma installed, so you don't need to install it yourself.

For this tutorial, two .h5 files were prepared, one sample of top quark pairs and one Z' file, providing high-pt jets originating from a hypothetical heavy spin-1 particle.

They are located here at the DESY NAF computing infrastructure:

/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5
/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/zpext.h5

Tutorial tasks

The tasks are divided in several sub-tasks. You don't have to do all of them in case you are more interested in the other tasks. However, the sub-tasks depend on each other, so you should finish a subtask before proceeding to the next one (also the solutions assume that you already have the previous subtasks completed).

Task 1: Flavour tagging metrics

To get started with the plotting, we will first have a quick look into different metrics used in flavour tagging to evaluate the performance.

Task 1.1: Generating dummy data

The typical output of our ML-based taggers, like DIPS or DL1d, are 3 scores indicating the probabilities of being a light-flavour jet, a c-jet and a b-jet. For example the scores [0.1, 0.3, 0.6] would indicate that we have most probably a b-jet while [0.7, 0.2, 0.1] would indicate a light-flavour jet.

Even though we always have MC simulation, it is sometimes useful to have dummy data, for instance if we want to test certain plotting features etc. (and to understand the actual underlying distributions).

Now, it is up to you. Generate a dummy multi-class output of a neural network.

Hint: Where can I find such a function?

You can have a look at the puma documentation and search in the API reference.

Hint: Which exact function?

the puma.utils.generate module contains the desired functions

Solution
from puma.utils.generate import get_dummy_multiclass_scores

# Generating 10_000 jets
dummy_jets, dummy_labels = get_dummy_multiclass_scores()
print(dummy_jets)
print(dummy_labels)

Task 1.2: Defining Working points - Likelihood ratio

Since we are not (yet) able to calibrate the entire spectrum of the different multi-class outputs, we need to define so-called working points (or operating points). In the case of ATLAS, we have four different b-tagging working points (WPs) which are defined covering various needs of the physics analyses. The efficiency of a specific flavour j (b, c or light) is defined as

The final output score is calculated from the multi-class output and results for the b-tagging discriminant into the log-likelihood

The advantage of the multi-class output is that this tuning is possible after the training and the c-jet fraction in the training sample does not have to be adapted. Another advantage of the multi-class output is that one can by changing the log-likelihood to

Hint 1:

You can either use a python function def or a lambda function.

Hint 2

In the puma examples you might find something similar.

Solution

You can find the solution in the histogram example of the puma documentation.

def disc_fct(arr: np.ndarray, f_c: float = 0.018) -> np.ndarray:
   """Tagger discriminant
    Parameters
    ----------
    arr : numpy.ndarray
        array with with shape (, 3)
    f_c : float, optional
        f_c value in the discriminant (weight for c-jets rejection)

    Returns
    -------
    np.ndarray
        Array with the discriminant values inside.
    """
    # you can adapt this for your needs
    return np.log(arr[2] / (f_c * arr[1] + (1 - f_c) * arr[0]))

# you can also use a lambda function
# fc = 0.018
# lambda a: np.log(a[2] / (fc * a[1] + (1 - fc) * a[0]))
Hint: Where to get the labels from?

The labels from task 0.1 have the same values as the HadronConeExclTruthLabelID.

The standard labelling is provided via the HadronConeExclTruthLabelID variable, which is defined as follows:

For matching all weakly-decaying b-/c-hadrons and tau-leptons with a transverse momentum larger than 5 GeV and all calorimeter (track) jets with an uncalibrated transverse momentum of at least 0 (5) GeV are found. A hadron/tau-lepton is matched with a jet if the angular distance DeltaR is smaller than 0.3. In case of multiple jets laying in this cone the closest one is chosen. Afterwards all hadrons/tau-leptons that are daughter particles of another hadron/tau-lepton are removed. The remaining ones define the label for the jet:

  • light jets: 0

  • c-jets: 4

  • b-jets: 5

  • tau-jets: 15

Hint: Which function to use?

You can have a look at the percentile function from numpy. Be aware from which site we need to integrate! And the apply_along_axis function to evaluate an entire array.

Solution
import numpy as np

bjets = dummy_labels == 5
scores = np.apply_along_axis(disc_fct, axis=1, arr=dummy_jets)
target_eff = 0.7
cutvalue = np.percentile(scores[bjets], 100.0 * (1.0 - target_eff))
print("cut value for 70% b-jet efficiency:", cutvalue) 

You can also have a look at the metrics function in puma , where this code is also being used.

Task 1.3: Performance metrics - efficiency and rejection

Calculate the light-flavour jet and c-jet rejection for the 70% working point from task 0.2.

Solution
ljets = dummy_labels == 0
cjets = dummy_labels == 4

ljets_eff = ((scores > cutvalue) & ljets).sum() / ljets.sum()
print("light-flavour jets efficiency:", ljets_eff)
print("light-flavour jets rejection:", 1 / ljets_eff)

cjets_eff = ((scores > cutvalue) & cjets).sum() / cjets.sum()
print("c-flavour jets efficiency:", cjets_eff)
print("c-flavour jets rejection:", 1 / cjets_eff)

Alternatively, all this functionality is also provided by puma.metrics. In that case this would simplify to

from puma.metrics import calc_rej
ljets = dummy_labels == 0
cjets = dummy_labels == 4
rej = calc_rej(scores[bjets], scores[ljets], target_eff=0.7)
print("light-flavour jets rejection:", rej)

Starting from these metrics, we can plot for instance:

  • ROC curves: which show the background rejection as function of the b-jet efficency

Task 2: Histogram plots

Task 2.1: Loading the h5 file

Before starting with the different plotting exercises, you have to load the h5 file that was prepared for this tutorial. The expected outcome of this is that you have access to the jet variables as well as to the track variables. You can put the jet variables in a pandas.DataFrame in case you feel more comfortable with that, but this will not be possible for the tracks, since the tracks_loose dataset in the h5 file has an extra dimension for the tracks (for each jet we store the information of up to 40 tracks).

  1. Write a little python script that loads the jet and track variables.

  2. Have a look at how large the dataset is, and what shape the loaded arrays have.

For the following tasks you can re-use the code that loads the h5 file or just extend your python script from this task.

Remember, that the ttbar h5 file is located here on NAF:

/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5
Hint: how can I load a h5 file with python?

You can find the documentation of h5py here.

Solution
import h5py

ttbar_filepath = "/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5"

# load the "jets" and "tracks_loose" dataset from the h5 file
with h5py.File(ttbar_filepath, "r") as h5file:
    jets = h5file["jets"][:]
    tracks = h5file["tracks_loose"][:]

# print the shape and the field names of the datasets
print(jets.shape)
print(jets.dtype.names)
print(tracks.shape)
print(tracks.dtype.names)
Hint: How do I create a histogram plot with puma?

You can find the examples of histogram plots here and the documentation for histogram plots with puma here.

Solution
import h5py
from puma import Histogram, HistogramPlot

ttbar_filepath = "/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5"

# load the jets dataset from the h5 file
with h5py.File(ttbar_filepath, "r") as h5file:
    jets = h5file["jets"][:]

# defining boolean arrays to select the different flavour classes
is_light = jets["HadronConeExclTruthLabelID"] == 0
is_c = jets["HadronConeExclTruthLabelID"] == 4
is_b = jets["HadronConeExclTruthLabelID"] == 5

# initialise the plot
pt_plot = HistogramPlot(
    bins_range=(0, 250_000),
    xlabel="$p_T$ [MeV]",
    ylabel="Normalised number of jets",
)

# add the histograms
pt_plot.add(Histogram(jets[is_light]["pt_btagJes"], flavour="ujets"))
pt_plot.add(Histogram(jets[is_c]["pt_btagJes"], flavour="cjets"))
pt_plot.add(Histogram(jets[is_b]["pt_btagJes"], flavour="bjets"))

pt_plot.draw()
pt_plot.savefig("tutorial_histogram_pT.png")

Task 2.3: Plot the b-jets probability output of two different taggers

In this task you will plot the b-jets probability of two different taggers - RNNIP and DIPS.

  1. Create the histogram plot (similar to the one from the previous task) and the different histograms. If you plot this for light-flavour jets, c-jets and b-jets, you should have 6 histograms.

  2. Make sure that you use a different line-style for the histograms of you second tagger.

  3. Add a ratio panel to the plot

  4. Make your plot look pretty. Have a look at the arguments that are supported by puma.PlotObject.

Hint 1: Histogram and HistogramPlot objects

After you defined your HistogramPlot object, you can start adding lines to it. This lines are the Histogram objects you need to define.

Hint 2: Linestyle

The linestyle can be set when the different Histogram lines are initalised.

Hint 3: Ratio Panel

The ratio for the ratio panel is calculated in this case between the same flavours. But you need to tell the plot which of the Histogram objects is the reference. Try to look up the reference option in the add() function.

Solution
tagger_output_plot = HistogramPlot(
    n_ratio_panels=1,
    xlabel="$b$-jets probability",
    ylabel="Normalised number of jets",
    # optional:
    # figsize=(6, 4.5),
    # leg_ncol=2,
    # atlas_second_tag="$t\\bar{t}$ R22 sample",
    # logy=True,
)

# add the histograms
tagger_output_plot.add(
    Histogram(jets[is_light]["rnnip_pb"], flavour="ujets"),
    reference=True,
)
tagger_output_plot.add(
    Histogram(jets[is_c]["rnnip_pb"], flavour="cjets"),
    reference=True,
)
tagger_output_plot.add(
    Histogram(jets[is_b]["rnnip_pb"], flavour="bjets"),
    reference=True,
)

# add the histograms
tagger_output_plot.add(
    Histogram(jets[is_light]["dipsLoose20220314v2_pb"], flavour="ujets", linestyle="--")
)
tagger_output_plot.add(
    Histogram(jets[is_c]["dipsLoose20220314v2_pb"], flavour="cjets", linestyle="--")
)
tagger_output_plot.add(
    Histogram(jets[is_b]["dipsLoose20220314v2_pb"], flavour="bjets", linestyle="--")
)

tagger_output_plot.draw()
tagger_output_plot.savefig("tutorial_histogram_tagger_pb_comparison.png")

Task 2.4: Plot a track variable of your choice

In this task you are asked to make a histogram plot of a track variable. This is slightly more tricky, since the array that you load from the h5 file has a different shape compared to the array storing the jet information. In addition to that, many entries might be filled with nan values, which is challenging here and there.

  1. Choose a track variable that you want to plot.

  2. Create a histogram plot (maybe again for multiple flavours, but that is up to you).

Hint 1: NaN-Values in binning

If you encounter an issue with NaN values in the binning, you need to set the bins_range correctly, because with NaN values it cannot be calculated automatically.

Hint 2: Difference in Shape

Due to the dimensionality of tracks, you need to get rid of one of the dimensions. Try the .flatten() option of numpy.ndarray.

Solution
ttbar_filepath = "/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5"
with h5py.File(ttbar_filepath, "r") as h5file:
    tracks = h5file["/tracks_loose"][:, :]
    print(tracks.shape)

d0_plot = HistogramPlot(
    bins_range=(-3, 3),
    xlabel="$d_0$ significance",
    ylabel="Normalised number of tracks",
    figsize=(6, 4.5),
)

d0_plot.add(
    Histogram(
        tracks["IP3D_signed_d0_significance"][is_light, :].flatten(), flavour="ujets"
    )
)
d0_plot.add(
    Histogram(tracks["IP3D_signed_d0_significance"][is_c, :].flatten(), flavour="cjets")
)
d0_plot.add(
    Histogram(tracks["IP3D_signed_d0_significance"][is_b, :].flatten(), flavour="bjets")
)

d0_plot.draw()
d0_plot.savefig("tutorial_histogram_track_variable.png")

Task 3: ROC plots

In this task, you will plot a ROC comparison for the two taggers RNNIP and DIPS.

Task 3.1: Calculate the rejections as a function of the b-jets efficiency

Before you can actually plot the ROC curves, you have to calculate the light-flavour and c-jets rejection for a range of b-jets efficiencies.

  1. Define a function that calculates the b-jets discriminant from the tagger output.

  2. Calculate the light-flavour jets rejection as a function of the b-jets efficiency.

Solution
import numpy as np
import pandas as pd
import h5py

from puma import Roc, RocPlot
from puma.metrics import calc_rej

ttbar_filepath = "/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5"

# load the jets dataset from the h5 file

with h5py.File(ttbar_filepath, "r") as h5file:
    jets = pd.DataFrame(h5file["jets"][:])

# defining boolean arrays to select the different flavour classes
is_light = jets["HadronConeExclTruthLabelID"] == 0
is_c = jets["HadronConeExclTruthLabelID"] == 4
is_b = jets["HadronConeExclTruthLabelID"] == 5

# define a small function to calculate discriminant
def disc_fct(arr: np.ndarray, f_c: float = 0.018) -> np.ndarray:
    """Tagger discriminant

    Parameters
    ----------
    arr : numpy.ndarray
        array with with shape (, 3)
    f_c : float, optional
        f_c value in the discriminant (weight for c-jets rejection)

    Returns
    -------
    np.ndarray
        Array with the discriminant values inside.
    """
    # you can adapt this for your needs
    return np.log(arr[2] / (f_c * arr[1] + (1 - f_c) * arr[0]))


# calculate discriminant
discs_rnnip = np.apply_along_axis(
    disc_fct, 1, jets[["rnnip_pu", "rnnip_pc", "rnnip_pb"]].values
)
discs_dips = np.apply_along_axis(
    disc_fct,
    1,
    jets[
        ["dipsLoose20220314v2_pu", "dipsLoose20220314v2_pc", "dipsLoose20220314v2_pb"]
    ].values,
)
# defining target efficiency
sig_eff = np.linspace(0.49, 1, 20)
# defining boolean arrays to select the different flavour classes
is_light = jets["HadronConeExclTruthLabelID"] == 0
is_c = jets["HadronConeExclTruthLabelID"] == 4
is_b = jets["HadronConeExclTruthLabelID"] == 5

n_jets_light = sum(is_light)
n_jets_c = sum(is_c)

rnnip_ujets_rej = calc_rej(discs_rnnip[is_b], discs_rnnip[is_light], sig_eff)
dips_ujets_rej = calc_rej(discs_dips[is_b], discs_dips[is_light], sig_eff)

Task 3.2:

  1. Plot the light-flavour jets rejection as a function of the $b$-jets efficiency. Use n_ratio_panels=1 to also get the ratio of the two rejection curves.

Hint 1: How do I initialise a ROC curve plot?

Plotting ROC curves with puma is similar to plotting histograms. The main difference is that you are using the puma.RocPlot and puma.Roc classes. Search the puma docs for "roc" to have a look at an example and the API reference.

Hint 2: I initialised the plot and added the ROC curves - is there anything else to do?

For ROC curves you also have to define the class which is drawn in the ratio panel. The method you need to use here is RocPlot.set_ratio_class().

Solution
# here the plotting of the roc starts
roc_plot = RocPlot(
    n_ratio_panels=1,
    ylabel="Background rejection",
    xlabel="$b$-jets efficiency",
    atlas_second_tag="$\\sqrt{s}=13$ TeV, $t\\bar{t}$ Release 22, \n$f_c=0.018$",
)
roc_plot.add_roc(
    Roc(
        sig_eff,
        rnnip_ujets_rej,
        n_test=n_jets_light,
        rej_class="ujets",
        signal_class="bjets",
        label="RNNIP",
    ),
    reference=True,
)
roc_plot.add_roc(
    Roc(
        sig_eff,
        dips_ujets_rej,
        n_test=n_jets_light,
        rej_class="ujets",
        signal_class="bjets",
        label="DIPS",
    ),
)
roc_plot.set_ratio_class(1, "ujets", label="Light-flavour jets ratio")
roc_plot.set_leg_rej_labels("ujets", "Light-flavour jets rejection")
roc_plot.draw()
roc_plot.savefig("tutorial_roc.png", transparent=False)

Task 3.3: Add the c-rejection to your plot

  1. Repeat the calculation of the rejection for c-jets

  2. Add the corresponding ROC curves to the plot. Don't forget to increase n_ratio_panels of your puma.RocPlot.

Hint 1: How can I modify the legend that states which linestyle corresponds to the different rejection classes

You can add labels for the different rejection classes using the RocPlot.set_leg_rej_labels() method.

Solution
rnnip_cjets_rej = calc_rej(discs_rnnip[is_b], discs_rnnip[is_c], sig_eff)
dips_cjets_rej = calc_rej(discs_dips[is_b], discs_dips[is_c], sig_eff)

# add this to the code from the previous task (has to be before the RocPlot.draw()
# method is called)
roc_plot.add_roc(
    Roc(
        sig_eff,
        rnnip_cjets_rej,
        n_test=n_jets_c,
        rej_class="cjets",
        signal_class="bjets",
        label="RNNIP",
    ),
    reference=True,
)
roc_plot.add_roc(
    Roc(
        sig_eff,
        dips_cjets_rej,
        n_test=n_jets_c,
        rej_class="cjets",
        signal_class="bjets",
        label="DIPS",
    ),
)
roc_plot.set_ratio_class(2, "cjets", label="$c$-jets ratio")
roc_plot.set_leg_rej_labels("cjets", "$c$-jets rejection")

Task 4.1: Calculate the discriminant values

Just like you did in Task 3.1, calculate the discriminant scores for RNNIP and DIPS. You can reuse the code from task 3.1. If you are putting everything in one python script you can just reuse the values that are already calculated.

Solution
import numpy as np
import pandas as pd
import h5py

from puma import VarVsEff, VarVsEffPlot

ttbar_filepath = "/nfs/dust/atlas/user/pgadow/summie2022/data/tutorial/ttbar.h5"

# load the jets dataset from the h5 file
with h5py.File(ttbar_filepath, "r") as h5file:
    jets = pd.DataFrame(h5file["jets"][:])

# define a small function to calculate discriminant
def disc_fct(arr: np.ndarray, f_c: float = 0.018) -> np.ndarray:
    """Tagger discriminant

    Parameters
    ----------
    arr : numpy.ndarray
        array with with shape (, 3)
    f_c : float, optional
        f_c value in the discriminant (weight for c-jets rejection)

    Returns
    -------
    np.ndarray
        Array with the discriminant values inside.
    """
    # you can adapt this for your needs
    return np.log(arr[2] / (f_c * arr[1] + (1 - f_c) * arr[0]))


# calculate discriminant
discs_rnnip = np.apply_along_axis(
    disc_fct, 1, jets[["rnnip_pu", "rnnip_pc", "rnnip_pb"]].values
)
discs_dips = np.apply_along_axis(
    disc_fct,
    1,
    jets[
        ["dipsLoose20220314v2_pu", "dipsLoose20220314v2_pc", "dipsLoose20220314v2_pb"]
    ].values,
)

# Getting jet pt in GeV
pt = jets["pt"].values / 1e3
# defining target efficiency
sig_eff = np.linspace(0.49, 1, 20)
# defining boolean arrays to select the different flavour classes
is_light = jets["HadronConeExclTruthLabelID"] == 0
is_c = jets["HadronConeExclTruthLabelID"] == 4
is_b = jets["HadronConeExclTruthLabelID"] == 5

# here the plotting starts

# define the curves
rnnip_light = VarVsEff(
    x_var_sig=pt[is_b],
    disc_sig=discs_rnnip[is_b],
    x_var_bkg=pt[is_light],
    disc_bkg=discs_rnnip[is_light],
    bins=[20, 30, 40, 60, 85, 110, 140, 175, 250],
    working_point=0.7,
    disc_cut=None,
    fixed_eff_bin=False,
    label="RNNIP",
)
dips_light = VarVsEff(
    x_var_sig=pt[is_b],
    disc_sig=discs_dips[is_b],
    x_var_bkg=pt[is_light],
    disc_bkg=discs_dips[is_light],
    bins=[20, 30, 40, 60, 85, 110, 140, 175, 250],
    working_point=0.7,
    disc_cut=None,
    fixed_eff_bin=False,
    label="DIPS",
)


# You can choose between different modes: "sig_eff", "bkg_eff", "sig_rej", "bkg_rej"
plot_sig_eff = VarVsEffPlot(
    mode="sig_eff",
    ylabel="$b$-jets efficiency",
    xlabel=r"$p_{T}$ [GeV]",
    logy=False,
    atlas_second_tag="$\\sqrt{s}=13$ TeV, PFlow jets, \n$t\\bar{t}$ sample, $f_{c}=0.018$",
    figsize=(6, 4.5),
    n_ratio_panels=1,
)
plot_sig_eff.add(rnnip_light, reference=True)
plot_sig_eff.add(dips_light)

plot_sig_eff.atlas_second_tag += "\nInclusive $\\epsilon_b=70%%$"

# If you want to inverse the discriminant cut you can enable it via
# plot_sig_eff.set_inverse_cut()
plot_sig_eff.draw()
# Drawing a hline indicating inclusive efficiency
plot_sig_eff.draw_hline(0.7)
plot_sig_eff.savefig("tutorial_pt_b_eff.png", transparent=False)

Solution
# reuse the VarVsEff objects that were defined for the previous exercise
plot_bkg_rej = VarVsEffPlot(
    mode="bkg_rej",
    ylabel="Light-flavour jets rejection",
    xlabel=r"$p_{T}$ [GeV]",
    logy=False,
    atlas_second_tag="$\\sqrt{s}=13$ TeV, PFlow jets \n$t\\bar$ sample, $f_{c}=0.018$",
    figsize=(6, 4.5),
    n_ratio_panels=1,
)
plot_sig_eff.atlas_second_tag += "\nInclusive $\\epsilon_b=70%%$"
plot_bkg_rej.add(rnnip_light, reference=True)
plot_bkg_rej.add(dips_light)

plot_bkg_rej.draw()
plot_bkg_rej.savefig("tutorial_pt_light_rej.png")

Last updated