From e6e4faa475588b61b34bad91482278ca63daa3fc Mon Sep 17 00:00:00 2001
From: Benjamin Audurier <benjamin.audurier@cea.fr>
Date: Fri, 22 Nov 2024 10:02:53 +0100
Subject: [PATCH 01/31] New patch for HLT2 Ion reconstruction

---
 Hlt/Hlt2Conf/options/hlt2_PbPb_PbNe_2024.py   |  35 +++
 .../lines/iftPbPb/SMOG2_JpsiToMuMuTagged.py   |  91 +++++++
 .../lines/iftPbPb/SMOG2_Jpsi_trackeff.py      | 238 ++++++++++++++++++
 .../lines/iftPbPb/SMOG2_Ks_trackeff.py        | 190 ++++++++++++++
 .../Hlt2Conf/lines/iftPbPb/hlt2_iftPbPb.py    |  19 +-
 .../iftPbPb/hlt2_ift_smog2Pb_ChargedPID.py    |  27 +-
 .../lines/iftPbPb/hlt2_ift_smog2Pb_charm.py   | 112 ++++++---
 .../lines/iftPbPb/hlt2_ift_smog2Pb_generic.py |  15 +-
 .../lines/iftPbPb/hlt2_ift_smog2Pb_muons.py   |  31 ++-
 .../lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py  |  21 +-
 .../lines/iftPbPb/hlt2_ift_smog2Pb_xis.py     |  17 +-
 .../Hlt2Conf/lines/luminosity/luminosity.py   |   1 +
 .../Hlt2Conf/settings/hlt2_PbPb_PbNe_2024.py  |  73 ++++++
 .../settings/hlt2_PbPb_default_2024.py        |  18 +-
 .../python/Hlt2Conf/settings/hlt2_binds.py    |  13 +-
 15 files changed, 822 insertions(+), 79 deletions(-)
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_PbPb_PbNe_2024.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_JpsiToMuMuTagged.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_PbNe_2024.py

diff --git a/Hlt/Hlt2Conf/options/hlt2_PbPb_PbNe_2024.py b/Hlt/Hlt2Conf/options/hlt2_PbPb_PbNe_2024.py
new file mode 100644
index 00000000000..6973e522af1
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_PbPb_PbNe_2024.py
@@ -0,0 +1,35 @@
+###############################################################################
+# (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore import options, run_moore
+from RecoConf.reconstruction_objects import reconstruction
+from Hlt2Conf.settings.hlt2_PbPb_PbNe_2024 import make_streams
+from RecoConf.global_tools import stateProvider_with_simplified_geom, trackMasterExtrapolator_with_simplified_geom
+from DDDB.CheckDD4Hep import UseDD4Hep
+
+options.lines_maker = make_streams
+
+if UseDD4Hep:
+    # This needs to happen before the public tools are instantiated,
+    # which means we cannot put it inside make_streams().
+    from PyConf.Tools import TrackMasterExtrapolator, TrackMasterFitter
+    TrackMasterExtrapolator.global_bind(
+        ApplyMultScattCorr=False,
+        ApplyEnergyLossCorr=False,
+        ApplyElectronEnergyLossCorr=False)
+    TrackMasterFitter.global_bind(ApplyMaterialCorrections=False)
+
+public_tools = [
+    trackMasterExtrapolator_with_simplified_geom(),
+    stateProvider_with_simplified_geom()
+]
+
+with reconstruction.bind(from_file=False):
+    config = run_moore(options, public_tools=public_tools)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_JpsiToMuMuTagged.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_JpsiToMuMuTagged.py
new file mode 100644
index 00000000000..6d9f578ae8f
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_JpsiToMuMuTagged.py
@@ -0,0 +1,91 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+"""
+Definition of SMOG2 muon HLT2 lines
+"""
+from PyConf import configurable
+from Moore.config import register_line_builder
+from Moore.lines import Hlt2Line
+from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
+from Hlt2Conf.lines.ift.builders.smog2_muons_builders import make_Jpsi2mumutagged
+from RecoConf.reconstruction_objects import make_pvs
+from GaudiKernel.SystemOfUnits import MeV
+from RecoConf.event_filters import require_gec
+
+PROCESS = "hlt2"
+all_lines = {}
+hlt1_filter = ["Hlt1HeavyIonPbSMOGHadronicDecision"]
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
+
+_MASSWINDOW_PIDJPSI = [2900.0 * MeV, 3300.0 * MeV]
+
+
+#JpsiToMuMumTagged
+@register_line_builder(all_lines)
+@configurable
+def smog2_Jpsi2mumumtagged_line(
+        name='Hlt2PID_SMOG2PIDJpsi2MuMumTagged',
+        prescale=1,
+        persistreco=True,
+        massWind_Jpsi=_MASSWINDOW_PIDJPSI,
+        tagcharge=-1,
+):
+    """
+    SMOG2 J/psi(1S) -> mu mu and Psi(2S) -> mu mu HLT2 trigger line
+    """
+    pvs = make_pvs
+    jpsis = make_Jpsi2mumutagged(
+        process='hlt2',
+        pvs=pvs,
+        massWind_Jpsi=massWind_Jpsi,
+        tagcharge=tagcharge,
+    )
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [jpsis],
+        prescale=prescale,
+        persistreco=persistreco,
+    )
+
+
+#JpsiToMuMupTagged
+@register_line_builder(all_lines)
+@configurable
+def smog2_Jpsi2mumuptagged_line(name='Hlt2PID_SMOG2PIDJpsi2MuMupTagged',
+                                prescale=1,
+                                persistreco=True,
+                                massWind_Jpsi=_MASSWINDOW_PIDJPSI,
+                                tagcharge=+1):
+    """
+    SMOG2 J/psi(1S) -> mu mu and Psi(2S) -> mu mu HLT2 trigger line
+    """
+    pvs = make_pvs
+    jpsis = make_Jpsi2mumutagged(
+        process='hlt2',
+        pvs=pvs,
+        tagcharge=tagcharge,
+        massWind_Jpsi=massWind_Jpsi,
+    )
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [jpsis],
+        prescale=prescale,
+        persistreco=persistreco,
+    )
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
new file mode 100644
index 00000000000..c7395c4a24a
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
@@ -0,0 +1,238 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+"""
+Definition of SMOG2 tracking efficiency HLT2 lines - following pp tracking efficiency method: 
+ - Combination of long 'tag' track and partially reconstructed 'probe' track
+ - Matching of probe with long track
+ - running without UT: VeloMuon and SeedMuon lines
+"""
+from PyConf import configurable
+from Moore.config import register_line_builder
+from Moore.lines import Hlt2Line
+from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
+from RecoConf.reconstruction_objects import make_pvs
+from GaudiKernel.SystemOfUnits import MeV, GeV, mm
+from Hlt2Conf.standard_particles import make_ismuon_long_muon
+from Hlt2Conf.probe_muons import make_velomuon_muons, make_seed_muons
+from PyConf.Algorithms import MuonProbeToLongMatcher
+import Functors as F
+from Functors.math import in_range
+from Hlt2Conf.algorithms_thor import ParticleFilter, ParticleCombiner
+from Hlt2Conf.lines.ift.builders.smog2_builders import sv_in_smog2, bpv_in_smog2
+from Hlt2Conf.lines.trackeff.DiMuonTrackEfficiency import make_LongFilter
+from RecoConf.event_filters import require_gec
+
+all_lines = {}
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
+
+hlt1_filter = ["Hlt1HeavyIonPbSMOGHadronicDecision"]
+
+#use Velo+Muon track for efficiency of SciFi(+UT)
+VeloMuon_cuts = {
+    'max_ProbeTrChi2': 5,
+    'min_ProbeP': 2 * GeV,
+    'min_ProbePT': 0.2 * GeV,
+    'max_TagTrChi2': 5,
+    'min_TagP': 2 * GeV,
+    'min_TagPT': 0 * GeV,
+    'min_TagMuonID': -1,
+    'max_TagGhostProb': 1,
+    'max_JPsiDOCA': 3 * mm,
+    'max_JPsiVtxChi2': 32,
+    'min_JPsiPT': 0 * GeV,
+    'min_JPsimass': 2600 * MeV,
+    'max_JPsimass': 3600 * MeV,
+    'checkVP': True,
+    'checkFT': False,
+    'checkUT': False,
+    'checkMuon': True,
+    'require_ismuon': False,
+}
+
+#use SciFi+Muon track for efficiency of Velo(+UT)
+SeedMuon_cuts = {
+    'max_ProbeTrChi2': 5,
+    'min_ProbeP': 2 * GeV,
+    'min_ProbePT': 0.2 * GeV,
+    'max_TagTrChi2': 5,
+    'min_TagP': 2 * GeV,
+    'min_TagPT': 0 * GeV,
+    'min_TagMuonID': -1,
+    'max_TagGhostProb': 1,
+    'max_JPsiDOCA': 3 * mm,
+    'max_JPsiVtxChi2': 32,
+    'min_JPsiPT': 0 * GeV,
+    'min_JPsimass': 2600 * MeV,
+    'max_JPsimass': 3600 * MeV,
+    'checkVP': False,
+    'checkFT': True,
+    'checkUT': False,
+    'checkMuon': True,
+    'require_ismuon': False,
+}
+
+
+@configurable
+# Combination of Tag and Probe to make the JPsi candidate
+def make_JPsiCombiner(particles,
+                      pvs,
+                      probe_charge,
+                      get_cuts,
+                      name='Hlt2TrackEff_SMOG2Jpsi_{hash}'):
+    #upper JPsi DOCA
+    combination_cut = F.require_all(
+        in_range(get_cuts['min_JPsimass'], F.MASS, get_cuts['max_JPsimass']),
+        F.SUM(F.PT) > get_cuts['min_JPsiPT'],
+    )
+    if get_cuts['max_JPsiDOCA'] is not None:
+        combination_cut = F.require_all(
+            combination_cut, F.MAXSDOCACUT(get_cuts['max_JPsiDOCA']))
+    #additional cuts
+    mother_cut = F.require_all(
+        in_range(get_cuts['min_JPsimass'], F.MASS, get_cuts['max_JPsimass']),
+        F.PT > get_cuts['min_JPsiPT'],
+    )
+    if get_cuts['max_JPsiVtxChi2'] is not None:
+        mother_cut = F.require_all(mother_cut,
+                                   F.CHI2DOF < get_cuts['max_JPsiVtxChi2'],
+                                   sv_in_smog2(), bpv_in_smog2(pvs))
+
+    decay_descriptor = "J/psi(1S) -> mu- mu+" if probe_charge == 1 else "J/psi(1S) -> mu+ mu-"
+    return ParticleCombiner(
+        Inputs=particles,
+        DecayDescriptor=decay_descriptor,
+        CombinationCut=combination_cut,
+        CompositeCut=mother_cut,
+        name=name)
+
+
+@configurable
+# Tag filter
+def make_TagFilter(particles,
+                   pvs,
+                   probe_charge,
+                   get_cuts,
+                   name='Hlt2TrackEff_SMOG2TagTrack_{hash}'):
+    code = F.require_all(
+        (F.CHARGE < 0) if probe_charge == 1 else (F.CHARGE > 0),
+        F.CHI2DOF < get_cuts['max_TagTrChi2'],
+        F.P > get_cuts['min_TagP'],
+        F.PT > get_cuts['min_TagPT'],
+        F.ISMUON(),
+        F.PID_MU > get_cuts['min_TagMuonID'],
+        F.GHOSTPROB() < get_cuts['max_TagGhostProb'],
+    )
+    return ParticleFilter(particles, F.FILTER(code), name=name)
+
+
+@configurable
+# Probe filter
+def make_ProbeFilter(particles,
+                     pvs,
+                     probe_charge,
+                     get_cuts,
+                     name='Hlt2TrackEff_SMOG2ProbeTrack_{hash}'):
+    code = F.require_all(
+        (F.CHARGE > 0) if probe_charge == 1 else (F.CHARGE < 0),
+        F.CHI2DOF < get_cuts['max_ProbeTrChi2'],
+        F.P > get_cuts['min_ProbeP'],
+        F.PT > get_cuts['min_ProbePT'],
+    )
+    if get_cuts['require_ismuon']:
+        code = F.require_all(code, F.ISMUON())
+    return ParticleFilter(particles, F.FILTER(code), name=name)
+
+
+@configurable
+def create_TagLine(name, prescale, persistreco, probe_charge, get_cuts,
+                   particles):
+    pvs = make_pvs
+    probe_muons = make_ProbeFilter(particles, pvs, probe_charge, get_cuts)
+    tag_muons = make_TagFilter(make_ismuon_long_muon(), pvs, probe_charge,
+                               get_cuts)
+    JPsi = make_JPsiCombiner([tag_muons, probe_muons], pvs, probe_charge,
+                             get_cuts)
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [JPsi],
+        prescale=prescale,
+        raw_banks=["VP", "UT", "FT", "Muon"],
+        persistreco=persistreco)
+
+
+@configurable
+def create_MatchLine(name, prescale, persistreco, probe_charge, get_cuts,
+                     particles):
+    pvs = make_pvs
+    probe_muons = make_ProbeFilter(particles, pvs, probe_charge, get_cuts)
+    tag_muons = make_TagFilter(make_ismuon_long_muon(), pvs, probe_charge,
+                               get_cuts)
+    long_track = make_LongFilter(make_ismuon_long_muon(), probe_charge)
+    JPsi = make_JPsiCombiner([tag_muons, probe_muons], pvs, probe_charge,
+                             get_cuts)
+
+    matcher = MuonProbeToLongMatcher(
+        TwoBodyComposites=JPsi,
+        LongTracks=long_track,
+        checkVP=get_cuts['checkVP'],
+        checkFT=get_cuts['checkFT'],
+        checkUT=get_cuts['checkUT'],
+        checkMuon=get_cuts['checkMuon'])
+    JPsi_matched = matcher.MatchedComposites
+    long_matched = matcher.MatchedLongTracks
+    long_save = make_LongFilter(long_matched, probe_charge)
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [JPsi, JPsi_matched],
+        extra_outputs=[("LongMatched", long_save)],
+        prescale=prescale,
+        raw_banks=["VP", "UT", "FT", "Muon"],
+        persistreco=persistreco)
+
+
+for line, get_cuts, myparticles in zip(['VeloMuon', 'SeedMuon'],
+                                       [VeloMuon_cuts, SeedMuon_cuts],
+                                       [make_velomuon_muons, make_seed_muons]):
+    for charge, mu in zip([1, 0], ['mup', 'mum']):
+
+        @register_line_builder(all_lines)
+        @configurable
+        def LineWithTagging(
+                name="Hlt2TrackEff_SMOG2DiMuon_" + line + "_" + mu + "_Tag",
+                prescale=1,
+                persistreco=True,
+                probe_charge=charge,
+                get_cuts=get_cuts,
+                get_particles=myparticles):
+            return create_TagLine(name, prescale, persistreco, probe_charge,
+                                  get_cuts, get_particles())
+
+        @register_line_builder(all_lines)
+        @configurable
+        def LineWithMatching(
+                name="Hlt2TrackEff_SMOG2DiMuon_" + line + "_" + mu + "_Match",
+                prescale=1,
+                persistreco=True,
+                probe_charge=charge,
+                get_cuts=get_cuts,
+                get_particles=myparticles):
+            return create_MatchLine(name, prescale, persistreco, probe_charge,
+                                    get_cuts, get_particles())
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
new file mode 100644
index 00000000000..d73e64796e8
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
@@ -0,0 +1,190 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+
+from PyConf import configurable
+from Moore.config import register_line_builder
+from Moore.lines import Hlt2Line
+from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
+from RecoConf.reconstruction_objects import make_pvs
+from GaudiKernel.SystemOfUnits import MeV, GeV, mm
+import Functors as F
+from Functors.math import in_range
+from Hlt2Conf.algorithms_thor import ParticleFilter, ParticleCombiner
+from Hlt2Conf.lines.ift.builders.smog2_builders import bpv_in_smog2
+from Hlt2Conf.standard_particles import make_long_pions
+from Hlt2Conf.probe_muons import make_velo_muons
+from RecoConf.event_filters import require_gec
+
+all_lines = {}
+
+hlt1_filter = ["Hlt1HeavyIonPbSMOGHadronicDecision"]
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
+
+@configurable
+def filter_pions(particles, pvs=None, pt_min=0.3 * GeV):
+    cut = F.require_all(
+        F.P > 2000,
+        F.PT > pt_min,
+        F.ETA < 5.0,
+        F.ETA > 1.5,
+        F.BPVIPCHI2(pvs()) >= 25,
+    )
+    return ParticleFilter(particles, F.FILTER(cut))
+
+
+@configurable
+def filter_particles_velo(particles, pvs):
+    cut = F.require_all(
+        F.ETA < 4.5,
+        F.ETA > 1.5,
+        F.BPVIPCHI2(pvs()) >= 20,
+    )
+    return ParticleFilter(particles, F.FILTER(cut))
+
+
+@configurable
+def make_kshort_pi_muplus_specific_charge(pions,
+                                          muons,
+                                          pvs,
+                                          decay_descriptor,
+                                          comb_m_min=0 * MeV,
+                                          comb_m_max=2650 * MeV,
+                                          comb_maxdoca=0.15 * mm,
+                                          name="KShortMuPiCombiner_{hash}"):
+    combination_code = F.require_all(
+        in_range(comb_m_min, F.MASS, comb_m_max),
+        F.MAXDOCACUT(comb_maxdoca),
+    )
+    vertex_code = F.require_all(
+        F.END_VRHO < 100 * mm,
+        F.END_VZ < 2200 * mm,
+        bpv_in_smog2(pvs),
+    )
+    return ParticleCombiner(
+        [pions, muons],
+        name=name,
+        DecayDescriptor=decay_descriptor,
+        CombinationCut=combination_code,
+        CompositeCut=vertex_code,
+    )
+
+
+from Hlt2Conf.algorithms_thor import ParticleContainersMerger
+
+
+def make_kshort_pi_muplus(pions, muons, pvs, **kwargs):
+    ks_particle_combinations = [
+        make_kshort_pi_muplus_specific_charge(
+            pions,
+            muons,
+            pvs,
+            "KS0 -> pi+ mu+",
+            name="KShortMuPiCombiner_{hash}",
+            **kwargs),
+        make_kshort_pi_muplus_specific_charge(
+            pions,
+            muons,
+            pvs,
+            "KS0 -> pi+ mu-",
+            name="KShortMuPiCombiner_{hash}",
+            **kwargs),
+        make_kshort_pi_muplus_specific_charge(
+            pions,
+            muons,
+            pvs,
+            "KS0 -> pi- mu-",
+            name="KShortMuPiCombiner_{hash}",
+            **kwargs),
+        make_kshort_pi_muplus_specific_charge(
+            pions,
+            muons,
+            pvs,
+            "KS0 -> pi- mu+",
+            name="KShortMuPiCombiner_{hash}",
+            **kwargs),
+    ]
+
+    return ParticleContainersMerger(
+        ks_particle_combinations, name="KS_combinations_{hash}")
+
+
+from PyConf.Algorithms import KSLongVeloFilter
+
+
+@register_line_builder(all_lines)
+@configurable
+def kshort_velo_long_line_high(name="Hlt2TrackEff_SMOG2KshortVeloLong_HighPT",
+                               prescale=0.2,
+                               persistreco=True):
+    pions = filter_pions(make_long_pions(), make_pvs, pt_min=0.5 * GeV)
+    muonsVelo = filter_particles_velo(make_velo_muons(), make_pvs)
+    kshorts = make_kshort_pi_muplus(
+        pions, muonsVelo, make_pvs, comb_m_max=1500,
+        comb_m_min=0)  # probe should be on index 1
+
+    filtered_kshorts = KSLongVeloFilter(
+        InputParticle=kshorts,
+        InputPVs=make_pvs(),
+        PVConstrainedMassMin=350.,
+        PVConstrainedMassMax=625.,
+        PVConstrainedProbePtMin=1500.,
+        PVConstrainedProbePtMax=4000.,
+        IPperpendicularMax=0.007,
+        IPMax=0.8,
+        name="TrackEffFilter_{hash}",
+    ).OutputParticles
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=make_pvs) +
+        [filtered_kshorts],
+        prescale=prescale,
+        raw_banks=["VP", "UT", "FT", "Muon"],
+        persistreco=persistreco)
+
+
+@register_line_builder(all_lines)
+@configurable
+def kshort_velo_long_line_veryhigh(
+        name="Hlt2TrackEff_SMOG2KshortVeloLong_VeryHighPT",
+        prescale=1,
+        persistreco=True):
+    pions = filter_pions(make_long_pions(), make_pvs, pt_min=0.5 * GeV)
+    muonsVelo = filter_particles_velo(make_velo_muons(), make_pvs)
+    kshorts = make_kshort_pi_muplus(
+        pions, muonsVelo, make_pvs, comb_m_max=1500,
+        comb_m_min=0)  # probe should be on index 1
+
+    filtered_kshorts = KSLongVeloFilter(
+        InputParticle=kshorts,
+        InputPVs=make_pvs(),
+        PVConstrainedMassMin=350.,
+        PVConstrainedMassMax=625.,
+        PVConstrainedProbePtMin=4000.,
+        IPperpendicularMax=0.007,
+        IPMax=0.8,
+        name="TrackEffFilter_{hash}",
+    ).OutputParticles
+
+    return Hlt2Line(
+        name=name,
+        hlt1_filter_code=hlt1_filter,
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=make_pvs) +
+        [filtered_kshorts],
+        prescale=prescale,
+        raw_banks=["VP", "UT", "FT", "Muon"],
+        persistreco=persistreco)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_iftPbPb.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_iftPbPb.py
index 207cc707d5e..6a37aa28dc8 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_iftPbPb.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_iftPbPb.py
@@ -16,6 +16,7 @@ from RecoConf.event_filters import require_gec
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 ionraw_lines = {}
 ion_lines = {}
+ion_lines_neon = {}
 
 
 def _pbpb_prefilters():
@@ -34,6 +35,7 @@ def hlt2_PbPb_line(name='Hlt2PbPb', prescale=1):
     )
 
 
+@register_line_builder(ion_lines_neon)
 @register_line_builder(ion_lines)
 @configurable
 def hlt2_PbPb_upc_line(name='Hlt2PbPbUPC', prescale=1.):
@@ -51,20 +53,33 @@ def hlt2_PbPb_upc_line(name='Hlt2PbPbUPC', prescale=1.):
 def hlt2_PbSMOG_hadronic_line(name='Hlt2PbSMOG_Hadronic', prescale=0.02):
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(),
+        algs=_pbpb_prefilters() + make_smog2_prefilters(),
         hlt1_filter_code="Hlt1HeavyIonPbSMOGHadronicDecision",
         persistreco=True,
         prescale=prescale,
     )
 
 
+@register_line_builder(ion_lines_neon)
+@configurable
+def hlt2_PbNe_hadronic_line(name='Hlt2PbSMOG_Hadronic', prescale=1):
+    return Hlt2Line(
+        name=name,
+        algs=_pbpb_prefilters() + make_smog2_prefilters(),
+        hlt1_filter_code="Hlt1HeavyIonPbSMOGHadronicDecision",
+        persistreco=True,
+        prescale=prescale,
+    )
+
+
+@register_line_builder(ion_lines_neon)
 @register_line_builder(ion_lines)
 @configurable
 def hlt2_PbSMOG_minbias_line(name='Hlt2PbSMOG_MinBiasPassthrough',
                              prescale=0.1):
     return Hlt2Line(
         name=name,
-        algs=[],
+        algs=_pbpb_prefilters(),
         hlt1_filter_code=[
             "Hlt1HeavyIonPbSMOGMicroBiasDecision",
             "Hlt1HeavyIonPbSMOGMBOneTrackDecision"
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_ChargedPID.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_ChargedPID.py
index 1c539e85bc4..9997974dd3f 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_ChargedPID.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_ChargedPID.py
@@ -21,6 +21,13 @@ from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import make_smog2_L02
 from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import make_smog2_ks2pipi_dd_line, make_smog2_L02ppi_dd_line
 from RecoConf.reconstruction_objects import make_pvs
 from GaudiKernel.SystemOfUnits import MeV, GeV, mm, ns
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 PROCESS = "hlt2"
 all_lines = {}
@@ -86,7 +93,7 @@ def smog2_ks2pipi_ll_lowpt_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [ks2pipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [ks2pipi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -140,7 +147,7 @@ def smog2_ks2pipi_ll_highpt_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [ks2pipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [ks2pipi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -192,7 +199,7 @@ def smog2_ks2pipi_dd_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [ks2pipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [ks2pipi],
         prescale=prescale,
         persistreco=persistreco,
         pv_tracks=True,
@@ -243,7 +250,7 @@ def smog2_L02ppi_ll_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [l02ppi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [l02ppi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -295,7 +302,7 @@ def smog2_L02ppi_ll_highpt_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [l02ppi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [l02ppi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -347,7 +354,7 @@ def smog2_L02ppi_dd_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [l02ppi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [l02ppi],
         prescale=prescale,
         persistreco=persistreco,
         pv_tracks=True)
@@ -396,7 +403,7 @@ def smog2_phi2kk_kmProbe_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [phi2kk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [phi2kk],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -447,7 +454,7 @@ def smog2_phi2kk_kpProbe_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [phi2kk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [phi2kk],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -499,7 +506,7 @@ def smog2_phi2kk_kmProbe_highpt_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [phi2kk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [phi2kk],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -550,7 +557,7 @@ def smog2_phi2kk_kpProbe_highpt_line(
     )
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [phi2kk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [phi2kk],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
index 99b140a4e2f..1c234568392 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
@@ -13,10 +13,18 @@ from Moore.config import register_line_builder
 from PyConf import configurable
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm, picosecond
 from RecoConf.reconstruction_objects import make_pvs
-
+import Functors as F
+from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_charm_builders import make_particle_criteria, make_comb_criteria
 from Hlt2Conf.lines.ift.builders.smog2_charm_builders import make_charm2hadrons, make_charm3hadrons, make_charm4hadrons
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 all_lines = {}
 PROCESS = "hlt2"
@@ -113,9 +121,12 @@ def D02kpiline(name='Hlt2IFTWithReco_SMOG2D02KPi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    D02kpi_filtered = ParticleFilter(D02kpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [D02kpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [D02kpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -159,9 +170,12 @@ def D02kkline(name='Hlt2IFTNoReco_SMOG2D02KK',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    D02kk_filtered = ParticleFilter(D02kk, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [D02kk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [D02kk_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -206,9 +220,13 @@ def D02pipiline(name='Hlt2IFTNoReco_SMOG2D02pipi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    D02pipi_filtered = ParticleFilter(
+        D02pipi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [D02pipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [D02pipi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -251,9 +269,13 @@ def Etac2ppbarline(name='Hlt2IFTNoReco_SMOG2Etac2ppbar',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    etac2ppbar_filtered = ParticleFilter(
+        etac2ppbar, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [etac2ppbar],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [etac2ppbar_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -300,7 +322,7 @@ def Dpm2kpipiline(name='Hlt2IFTWithReco_SMOG2Dpm2kpipi',
         masswin=__MASSWin_DP,
         min_child_pt=800 * MeV,
         max_sdoca=0.5 * mm,
-        vchi2pdof_max=15,
+        vchi2pdof_max=10,
         min_bpvltime=0.5 * picosecond)
 
     Dpm2kpipi = make_charm3hadrons(
@@ -312,9 +334,13 @@ def Dpm2kpipiline(name='Hlt2IFTWithReco_SMOG2Dpm2kpipi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    Dpm2kpipi_filtered = ParticleFilter(
+        Dpm2kpipi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Dpm2kpipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Dpm2kpipi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -354,7 +380,7 @@ def Ds2kkpiline(name='Hlt2IFTWithReco_SMOG2DsToKKPi',
         masswin=__MASSWin_DS,
         min_child_pt=800 * MeV,
         max_sdoca=0.5 * mm,
-        vchi2pdof_max=15,
+        vchi2pdof_max=10,
         min_bpvltime=0.3 * picosecond,
     )
 
@@ -367,9 +393,13 @@ def Ds2kkpiline(name='Hlt2IFTWithReco_SMOG2DsToKKPi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    Ds2kkpi_filtered = ParticleFilter(
+        Ds2kkpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Ds2kkpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Ds2kkpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -389,7 +419,7 @@ def Lc2pkpiline(name='Hlt2IFTWithReco_SMOG2LcTopKPi',
         maxPIDK=None,
         minPIDp=5,
         minPIDpK=3,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaKaon = make_particle_criteria(
@@ -398,16 +428,16 @@ def Lc2pkpiline(name='Hlt2IFTWithReco_SMOG2LcTopKPi',
         maxPIDK=None,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaPion = make_particle_criteria(
-        bpvipchi2=5,
+        bpvipchi2=6,
         minPIDK=None,
         maxPIDK=0,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     Particles = ["proton", "kaon", "pion"]
@@ -430,9 +460,13 @@ def Lc2pkpiline(name='Hlt2IFTWithReco_SMOG2LcTopKPi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    Lc2pkpi_filtered = ParticleFilter(
+        Lc2pkpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Lc2pkpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Lc2pkpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -453,7 +487,7 @@ def Xicp2pkpiline(name='Hlt2IFTNoReco_SMOG2XicpTopKPi',
         maxPIDK=None,
         minPIDp=5,
         minPIDpK=3,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaKaon = make_particle_criteria(
@@ -462,7 +496,7 @@ def Xicp2pkpiline(name='Hlt2IFTNoReco_SMOG2XicpTopKPi',
         maxPIDK=None,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaPion = make_particle_criteria(
@@ -471,7 +505,7 @@ def Xicp2pkpiline(name='Hlt2IFTNoReco_SMOG2XicpTopKPi',
         maxPIDK=0,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     Particles = ["proton", "kaon", "pion"]
@@ -494,9 +528,13 @@ def Xicp2pkpiline(name='Hlt2IFTNoReco_SMOG2XicpTopKPi',
         CriteriaParticle=CriteriaParticles,
         CriteriaCombination=CriteriaCombinations)
 
+    Xicp2pkpi_filtered = ParticleFilter(
+        Xicp2pkpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Xicp2pkpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Xicp2pkpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -523,7 +561,7 @@ def Xic02pkkpiline(name='Hlt2IFTNoReco_SMOG2Xic0TopKKPi',
         maxPIDK=None,
         minPIDp=5,
         minPIDpK=3,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaKaon = make_particle_criteria(
@@ -532,7 +570,7 @@ def Xic02pkkpiline(name='Hlt2IFTNoReco_SMOG2Xic0TopKKPi',
         maxPIDK=5,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaPion = make_particle_criteria(
@@ -541,7 +579,7 @@ def Xic02pkkpiline(name='Hlt2IFTNoReco_SMOG2Xic0TopKKPi',
         maxPIDK=0,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     Particles = ["proton", "kaon", "kaon", "pion"]
@@ -558,15 +596,19 @@ def Xic02pkkpiline(name='Hlt2IFTNoReco_SMOG2Xic0TopKKPi',
         CriteriaParticle=CriteriaParticles,
         mass=__MASS_Xic0,
         masswindow=__MASSWin_Xic0,
-        max_sdoca=0.5 * mm,
-        max_vchi2pdof=20,
+        max_sdoca=0.2 * mm,
+        max_vchi2pdof=15,
         allchild_ptcut=0 * MeV,
         twochild_ptcut=400 * MeV,
         onechild_ptcut=800 * MeV)
 
+    Xic02pkkpi_filtered = ParticleFilter(
+        Xic02pkkpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Xic02pkkpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Xic02pkkpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -588,7 +630,7 @@ def Omegac02pkkpiline(name='Hlt2IFTNoReco_SMOG2Omegac0TopKKPi',
         maxPIDK=None,
         minPIDp=5,
         minPIDpK=3,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaKaon = make_particle_criteria(
@@ -597,7 +639,7 @@ def Omegac02pkkpiline(name='Hlt2IFTNoReco_SMOG2Omegac0TopKKPi',
         maxPIDK=None,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     CriteriaPion = make_particle_criteria(
@@ -606,7 +648,7 @@ def Omegac02pkkpiline(name='Hlt2IFTNoReco_SMOG2Omegac0TopKKPi',
         maxPIDK=0,
         minPIDp=None,
         minPIDpK=None,
-        minpT=250 * MeV,
+        minpT=300 * MeV,
         minp=3 * GeV,
         maxtrchi2dof=3)
     Particles = ["proton", "kaon", "kaon", "pion"]
@@ -623,15 +665,19 @@ def Omegac02pkkpiline(name='Hlt2IFTNoReco_SMOG2Omegac0TopKKPi',
         CriteriaParticle=CriteriaParticles,
         mass=__MASS_Omegac0,
         masswindow=__MASSWin_Omegac0,
-        max_sdoca=0.5 * mm,
-        max_vchi2pdof=20,
+        max_sdoca=0.2 * mm,
+        max_vchi2pdof=15,
         allchild_ptcut=0 * MeV,
         twochild_ptcut=400 * MeV,
         onechild_ptcut=800 * MeV)
 
+    Omegac02pkkpi_filtered = ParticleFilter(
+        Omegac02pkkpi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [Omegac02pkkpi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [Omegac02pkkpi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -680,7 +726,7 @@ def Hiddencharm4piline(name='Hlt2IFTNoReco_SMOG2ccTo4Pi',
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [cc2pipipipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [cc2pipipipi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -735,7 +781,7 @@ def Hiddencharm2pi2k_line(name="Hlt2IFTNoReco_SMOG2ccTo2Pi2K",
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [cc2kkpipi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [cc2kkpipi],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -781,7 +827,7 @@ def Hiddencharm4k_line(name="Hlt2IFTNoReco_SMOG2ccTo4K",
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [cc2kkkk],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [cc2kkkk],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_generic.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_generic.py
index 49a9421bb29..847f58656aa 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_generic.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_generic.py
@@ -22,6 +22,13 @@ from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_common_particl
 from Hlt2Conf.lines.ift.builders.smog2_generic_builders import make_smog2_generic_2body, make_smog2_generic_3body
 from RecoConf.reconstruction_objects import make_pvs
 from GaudiKernel.SystemOfUnits import MeV, GeV, mm, picosecond
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 PROCESS = "hlt2"
 all_lines = {}
@@ -67,7 +74,8 @@ def smog2_generic2bodydetached_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [generic_2body],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [generic_2body],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -114,7 +122,8 @@ def smog2_generic3bodydetached_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [generic_3body],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [generic_3body],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -151,7 +160,7 @@ def smog2_singletrack_highpt_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [highp_track],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [highp_track],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_muons.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_muons.py
index fd412e30083..bd76de35ec7 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_muons.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_muons.py
@@ -18,6 +18,13 @@ from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_muons_builders import make_Jpsi2mumu, make_low_dimumu, make_DY2mumu, make_DY2mumu_ExcludeCCBar, make_Ups2mumu
 from RecoConf.reconstruction_objects import make_pvs
 from GaudiKernel.SystemOfUnits import MeV
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 PROCESS = "hlt2"
 all_lines = {}
@@ -53,7 +60,7 @@ def smog2_lowdimuon_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [low_dimuons],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [low_dimuons],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -78,7 +85,8 @@ def smog2_lowdimuon_SS_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [low_dimuons_SS],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [low_dimuons_SS],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -106,7 +114,7 @@ def smog2_Jpsi2mumu_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [jpsis],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [jpsis],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
@@ -135,7 +143,7 @@ def smog2_Jpsi2mumu_SS_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [jpsis_SS],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [jpsis_SS],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -159,7 +167,7 @@ def smog2_Ups2mumu_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [ups],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [ups],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -187,7 +195,7 @@ def smog2_Ups2mumu_SS_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [ups_SS],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [ups_SS],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -213,7 +221,7 @@ def smog2_DY2mumu_line(name="Hlt2IFTWithReco_SMOG2DY2MuMu",
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -239,7 +247,8 @@ def smog2_DY2mumu_SS_line(name="Hlt2IFTWithReco_SMOG2DY2MuMuSS",
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [DY_dimuons_SS],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [DY_dimuons_SS],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -267,7 +276,7 @@ def smog2_DY2mumuExcludeCCBarLow_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -295,7 +304,7 @@ def smog2_DY2mumuExcludeCCBarIntermediate_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
@@ -323,7 +332,7 @@ def smog2_DY2mumuExcludeCCBarHigh_line(
 
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) + [DY_dimuons],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
index de2dc5be67e..d56f8928c84 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
@@ -17,13 +17,21 @@ from __future__ import absolute_import
 from PyConf import configurable
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
-
+import Functors as F
+from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
     make_smog2_omega2L0K_lll_line)
 
 from RecoConf.reconstruction_objects import make_pvs
 from GaudiKernel.SystemOfUnits import MeV, GeV, mm, ns
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 PROCESS = "hlt2"
 all_lines = {}
@@ -48,7 +56,7 @@ def smog2_omega2lambdak_lll_line(
         persistreco=False,
         min_p=2 * GeV,
         min_pt=100 * MeV,
-        max_trchi2dof=5,
+        max_trchi2dof=3,
         min_bpvipchi2=25,
         mmin_Omega=_MASSWINDOW_OMEGA[0],
         mmax_Omega=_MASSWINDOW_OMEGA[1],
@@ -85,10 +93,15 @@ def smog2_omega2lambdak_lll_line(
         bpvltime_min=bpvltime_min,
         parent_bpvipchi2_max=parent_bpvipchi2_max,
         ks_veto_window=ks_veto_window,
-    )
+        name_L0="smog2_lambda2ppi_ll_loose_no_ks_veto" + "_{hash}")
+
+    omega2Lambda0Ks_filtered = ParticleFilter(
+        omega2Lambda0Ks, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [omega2Lambda0Ks],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [omega2Lambda0Ks_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
index c8531bb63be..c27cb06c166 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
@@ -16,13 +16,21 @@ from __future__ import absolute_import
 from PyConf import configurable
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
-
+import Functors as F
+from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
     make_smog2_xi2L0pi_lll_line)
 
 from RecoConf.reconstruction_objects import make_pvs
 from GaudiKernel.SystemOfUnits import MeV, GeV, mm, ns
+from RecoConf.event_filters import require_gec
+
+
+@configurable
+def ion_prefilters(with_gec=True):
+    return [require_gec(cut=30_000, skipUT=True)] if with_gec else []
+
 
 PROCESS = "hlt2"
 all_lines = {}
@@ -85,9 +93,14 @@ def smog2_xi2lambda0pi_lll_line(
         parent_bpvipchi2_max=parent_bpvipchi2_max,
         ks_veto_window=ks_veto_window,
         name_L0="smog2_lambda2ppi_ll_loose_no_ks_veto" + "_{hash}")
+
+    xi2Lambda0pi_filtered = ParticleFilter(
+        xi2Lambda0pi, Cut=F.FILTER(F.OWNPVDIRA > 0.999))
+
     return Hlt2Line(
         name=name,
-        algs=make_smog2_prefilters(pvs=pvs) + [xi2Lambda0pi],
+        algs=ion_prefilters() + make_smog2_prefilters(pvs=pvs) +
+        [xi2Lambda0pi_filtered],
         hlt1_filter_code=hlt1_filter,
         prescale=prescale,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/luminosity/luminosity.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/luminosity/luminosity.py
index 414ff15d47d..e086db8592a 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/luminosity/luminosity.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/luminosity/luminosity.py
@@ -187,6 +187,7 @@ def _hlt2_lumi_default_raw_banks_line(name='Hlt2LumiDefaultRawBanks',
         name=name,
         algs=[],
         hlt1_filter_code="Hlt1ODINLumiDecision",
+        raw_banks=["VP"],
         prescale=prescale,
     )
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_PbNe_2024.py b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_PbNe_2024.py
new file mode 100644
index 00000000000..8a8ad258e0c
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_PbNe_2024.py
@@ -0,0 +1,73 @@
+###############################################################################
+# (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore.streams import Stream, Streams, DETECTORS
+from Hlt2Conf.settings.hlt2_binds import config_PbPb_2024
+from .hlt2_pp_2024 import _make_lines
+
+from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ionraw_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ion_lines_neon
+
+#DQ monitoring lines
+from Hlt2Conf.lines.monitoring.data_quality_PbPb import all_lines as monitoring_lines
+
+#hlt2calib
+from Hlt2Conf.lines.calibration import all_lines as hlt2_calibration_lines
+from Hlt2Conf.lines.luminosity import (
+    lumi_nanofy_line,
+    calibration_lines as lumi_calibration_lines,
+)
+from Hlt2Conf.lines.nobias.nobias_PbPb import all_lines as hlt2_no_bias_lines
+from Hlt2Conf.settings.hlt2_PbPb_default import _make_lines_and_require_gec
+
+all_lines_ionraw = {}
+all_lines_ionraw.update(ionraw_lines)
+
+all_lines_ion = {}
+all_lines_ion.update(ion_lines_neon)
+
+
+def _make_streams():
+    ion_lines = _make_lines_and_require_gec(
+        all_lines_ion) + _make_lines_and_require_gec(monitoring_lines)
+
+    ionraw_lines = _make_lines(all_lines_ionraw)
+
+    lumi_nano_line = lumi_nanofy_line()
+
+    hlt2calib_lines = _make_lines(hlt2_calibration_lines) + [
+        lumi_nano_line,
+    ]
+
+    lumi_lines = _make_lines(lumi_calibration_lines)
+
+    no_bias_lines = _make_lines(hlt2_no_bias_lines) + [
+        lumi_nano_line,
+        next((l for l in lumi_lines if l.name == "Hlt2LumiCounters")),
+    ]
+
+    return Streams(streams=[
+        Stream("ion", lines=[lumi_nano_line] + ion_lines, detectors=[]),
+        Stream(
+            "ionraw",
+            lines=[lumi_nano_line] + ionraw_lines,
+            detectors=DETECTORS),
+        Stream("hlt2calib", lines=hlt2calib_lines, detectors=[]),
+        Stream("lumi", lines=lumi_lines, detectors=[]),
+        Stream("no_bias", lines=no_bias_lines, detectors=[]),
+    ])
+
+
+from typing import Callable
+
+
+def make_streams(real_make_streams: Callable = _make_streams) -> Streams:
+    with config_PbPb_2024():
+        return real_make_streams()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_default_2024.py b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_default_2024.py
index dde3df522ef..97f89df433a 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_default_2024.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_default_2024.py
@@ -21,12 +21,12 @@ from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ionraw_lines
 from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ion_lines
 
 #Tracking line PbAr (PbPb is done offline)
-from Hlt2Conf.lines.trackeff.SMOG2_Jpsi_trackeff import all_lines as trackingeff_lines
-from Hlt2Conf.lines.trackeff.SMOG2_Ks_trackeff import all_lines as trackingeff_lines_Ks
+from Hlt2Conf.lines.iftPbPb.SMOG2_Jpsi_trackeff import all_lines as trackingeff_lines
+from Hlt2Conf.lines.iftPbPb.SMOG2_Ks_trackeff import all_lines as trackingeff_lines_Ks
 
 #pidline PbAr (PbPb is done offline)
 from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_ChargedPID import all_lines as chargedPid
-from Hlt2Conf.lines.pid.SMOG2_JpsiToMuMuTagged import all_lines as jpsiPID
+from Hlt2Conf.lines.iftPbPb.SMOG2_JpsiToMuMuTagged import all_lines as jpsiPID
 
 #DQ monitoring lines
 from Hlt2Conf.lines.monitoring.data_quality_PbPb import all_lines as monitoring_lines
@@ -38,6 +38,7 @@ from Hlt2Conf.lines.luminosity import (
     calibration_lines as lumi_calibration_lines,
 )
 from Hlt2Conf.lines.nobias.nobias_PbPb import all_lines as hlt2_no_bias_lines
+from Hlt2Conf.settings.hlt2_PbPb_default import _make_lines_and_require_gec
 
 all_lines_ionraw = {}
 all_lines_ionraw.update(ionraw_lines)
@@ -57,7 +58,9 @@ all_lines_ion.update(jpsiPID)
 
 
 def _make_streams():
-    ion_lines = _make_lines(all_lines_ion) + _make_lines(monitoring_lines)
+    ion_lines = _make_lines_and_require_gec(
+        all_lines_ion) + _make_lines_and_require_gec(monitoring_lines)
+
     ionraw_lines = _make_lines(all_lines_ionraw)
 
     lumi_nano_line = lumi_nanofy_line()
@@ -74,8 +77,11 @@ def _make_streams():
     ]
 
     return Streams(streams=[
-        Stream("ion", lines=ion_lines, detectors=[]),
-        Stream("ionraw", lines=ionraw_lines, detectors=DETECTORS),
+        Stream("ion", lines=[lumi_nano_line] + ion_lines, detectors=[]),
+        Stream(
+            "ionraw",
+            lines=[lumi_nano_line] + ionraw_lines,
+            detectors=DETECTORS),
         Stream("hlt2calib", lines=hlt2calib_lines, detectors=[]),
         Stream("lumi", lines=lumi_lines, detectors=[]),
         Stream("no_bias", lines=no_bias_lines, detectors=[]),
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_binds.py b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_binds.py
index aabf59ebae9..4e21fa14229 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_binds.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_binds.py
@@ -145,7 +145,7 @@ def config_PbPb_retina_2024():
      default_VeloCluster_source.bind(bank_type="VPRetinaCluster"),\
      require_gec.bind(skipUT=True),\
      get_GhostProbabilityTools.bind(collisiontype = "PbPb"),\
-     make_TrackBestTrackCreator_tracks.bind(max_ghost_prob=0.4, max_chi2ndof=sys.float_info.max),\
+     make_TrackBestTrackCreator_tracks.bind(max_ghost_prob=0.25, max_chi2ndof=sys.float_info.max),\
      make_PrKalmanFilter_Velo_tracks.bind(max_chi2ndof=5.),\
      make_PrKalmanFilter_tracks.bind(max_chi2ndof=4.),\
      make_PrKalmanFilter_Downstream_tracks.bind(max_chi2ndof=6.),\
@@ -179,13 +179,13 @@ def config_PbPb_2024():
     # https://indico.cern.ch/event/1370628/contributions/5810158/attachments/2799786/4884138/Reco_Config_Expected2024.pdf
 
     from PyConf.packing import persistreco_writing_version
-    from Hlt2Conf.lines.trackeff.SMOG2_Ks_trackeff import kshort_velo_long_line_low, kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
+    from Hlt2Conf.lines.iftPbPb.SMOG2_Ks_trackeff import kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
 
     with reconstruction.bind(make_reconstruction=make_light_reco_pr_kf),\
      default_VeloCluster_source.bind(bank_type="VP"),\
      require_gec.bind(skipUT=True),\
      get_GhostProbabilityTools.bind(collisiontype = "PbPb"),\
-     make_TrackBestTrackCreator_tracks.bind(max_ghost_prob=0.4, max_chi2ndof=sys.float_info.max),\
+     make_TrackBestTrackCreator_tracks.bind(max_ghost_prob=0.25, max_chi2ndof=sys.float_info.max),\
      make_PrKalmanFilter_Velo_tracks.bind(max_chi2ndof=5.),\
      make_PrKalmanFilter_tracks.bind(max_chi2ndof=4.),\
      make_PrKalmanFilter_Downstream_tracks.bind(max_chi2ndof=6.),\
@@ -194,7 +194,6 @@ def config_PbPb_2024():
      optimize_controlflow.bind(optimization="default"),\
      persistreco_writing_version.bind(version=1.1),\
      make_PrHybridSeeding_tracks.bind(FasterCloneRemoval=True),\
-     kshort_velo_long_line_low.bind(persistreco=False),\
      kshort_velo_long_line_high.bind(persistreco=False),\
      kshort_velo_long_line_veryhigh.bind(persistreco=False):
         yield
@@ -219,7 +218,7 @@ def config_PbPb_2024_without_UT():
     # https://indico.cern.ch/event/1370628/contributions/5810158/attachments/2799786/4884138/Reco_Config_Expected2024.pdf
 
     from PyConf.packing import persistreco_writing_version
-    from Hlt2Conf.lines.trackeff.SMOG2_Ks_trackeff import kshort_velo_long_line_low, kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
+    from Hlt2Conf.lines.iftPbPb.SMOG2_Ks_trackeff import kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
 
     with reconstruction.bind(make_reconstruction=make_light_reco_pr_kf_without_UT),\
      default_VeloCluster_source.bind(bank_type="VP"),\
@@ -232,7 +231,6 @@ def config_PbPb_2024_without_UT():
      optimize_controlflow.bind(optimization="default"),\
      persistreco_writing_version.bind(version=1.1),\
      make_PrHybridSeeding_tracks.bind(FasterCloneRemoval=True),\
-     kshort_velo_long_line_low.bind(persistreco=False),\
      kshort_velo_long_line_high.bind(persistreco=False),\
      kshort_velo_long_line_veryhigh.bind(persistreco=False):
         yield
@@ -257,7 +255,7 @@ def config_PbPb_2024_without_UT_fastreco():
     # https://indico.cern.ch/event/1370628/contributions/5810158/attachments/2799786/4884138/Reco_Config_Expected2024.pdf
 
     from PyConf.packing import persistreco_writing_version
-    from Hlt2Conf.lines.trackeff.SMOG2_Ks_trackeff import kshort_velo_long_line_low, kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
+    from Hlt2Conf.lines.iftPbPb.SMOG2_Ks_trackeff import kshort_velo_long_line_high, kshort_velo_long_line_veryhigh
 
     with reconstruction.bind(make_reconstruction=make_fastest_reconstruction),\
      make_fastest_reconstruction.bind(skipUT=True),\
@@ -270,7 +268,6 @@ def config_PbPb_2024_without_UT_fastreco():
      optimize_controlflow.bind(optimization="default"),\
      persistreco_writing_version.bind(version=1.1),\
      make_PrHybridSeeding_tracks.bind(FasterCloneRemoval=True),\
-     kshort_velo_long_line_low.bind(persistreco=False),\
      kshort_velo_long_line_high.bind(persistreco=False),\
      kshort_velo_long_line_veryhigh.bind(persistreco=False):
         yield
-- 
GitLab


From a5a28c0067b435b27a9c4c0dd2faf155660af937 Mon Sep 17 00:00:00 2001
From: Luke Grazette <l.grazette@warwick.ac.uk>
Date: Fri, 6 Dec 2024 04:26:57 +0100
Subject: [PATCH 02/31] [RTADPA BW Tests] 2024-patches version of !4073

---
 .../hlt1_bandwidth_streamless_streams.py      |   2 +-
 .../tests/bandwidth/bandwidth_helpers.py      | 329 +++++++
 .../bandwidth/calculate_stream_overlap.py     | 143 +++
 .../tests/bandwidth/combine_rate_output.py    | 278 ++++++
 .../tests/bandwidth/extract_filesizes.py      |  72 ++
 .../generate_spruce_input_configs.py          | 111 +++
 .../bandwidth/generate_tistos_option_file.py  |  67 ++
 .../tests/bandwidth/line_and_stream_rates.py  | 446 +++++++++
 .../tests/bandwidth/line_descriptives.py      |  85 ++
 .../bandwidth/make_bandwidth_test_page.py     | 931 ++++++++++++++++++
 .../tests/bandwidth/read_event_numbers.py     | 196 ++++
 .../bandwidth/run_bandwidth_test_jobs.py      | 267 +++++
 .../hlt2_bandwidth_production_streams.py      |   2 +-
 .../spruce_bandwidth_full_streams.py          |   2 +-
 .../spruce_bandwidth_hlt2calib_streams.py     |   2 +-
 .../spruce_bandwidth_lumi_streams.py          |   2 +-
 .../spruce_bandwidth_no_bias_streams.py       |   2 +-
 .../spruce_bandwidth_turbo_streams.py         |   2 +-
 .../spruce_bandwidth_turcal_streams.py        |   2 +-
 19 files changed, 2933 insertions(+), 8 deletions(-)
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/bandwidth_helpers.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/calculate_stream_overlap.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/combine_rate_output.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/extract_filesizes.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_spruce_input_configs.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_tistos_option_file.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_and_stream_rates.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_descriptives.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/make_bandwidth_test_page.py
 create mode 100755 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/read_event_numbers.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/run_bandwidth_test_jobs.py

diff --git a/Hlt/Hlt1Conf/tests/options/bandwidth/hlt1_bandwidth_streamless_streams.py b/Hlt/Hlt1Conf/tests/options/bandwidth/hlt1_bandwidth_streamless_streams.py
index 364ed43cf51..37724928a42 100644
--- a/Hlt/Hlt1Conf/tests/options/bandwidth/hlt1_bandwidth_streamless_streams.py
+++ b/Hlt/Hlt1Conf/tests/options/bandwidth/hlt1_bandwidth_streamless_streams.py
@@ -23,7 +23,7 @@ from RecoConf.hlt1_allen import allen_gaudi_config
 from AllenConf.persistency import line_names as hlt1_line_names
 from AllenCore.gaudi_allen_generator import allen_runtime_options
 from PyConf.application import configure_input, configure
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 from DDDB.CheckDD4Hep import UseDD4Hep
 from Configurables import DDDBConf
 import json
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/bandwidth_helpers.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/bandwidth_helpers.py
new file mode 100644
index 00000000000..0e91cdf8eac
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/bandwidth_helpers.py
@@ -0,0 +1,329 @@
+#!/usr/bin/env python
+###############################################################################
+# (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+import os
+import yaml
+
+KNOWN_WORKING_GROUPS = [
+    "B2CC", "B2OC", "BandQ", "BnoC", "Calib", "Calo", "Charm", "DPA", "HLT",
+    "IFT", "Luminosity", "PID", "QCD", "QEE", "RD", "RTA", "SLB", "Topo",
+    "Tagging", "TrackEff", "Monitoring", "CutBasedDiLep", "InclDetDiLep",
+    "TurCalPID"
+]
+
+CUSTOM_WGS = {
+    "Topo": ["Hlt2Topo"],
+    "CutBasedDiLep": ["Hlt2CutBasedIncl"],
+    "InclDetDiLep": ["Hlt2_InclDet"],
+    "BandQ": [
+        "Hlt2_DiMuonJPsiTight", "Hlt2_DiMuonPsi2STight", "Hlt2_JpsiToMuMu",
+        "Hlt2_Psi2SToMuMu"
+    ],
+    "Charm": ["Hlt2HadInt"],
+    "TrackEff": [
+        "Hlt2TurboVelo2Long_Kshort", "Hlt2TurCalVelo2Long_Kshort",
+        "Hlt2Tracking", "Hlt2TrackEff", "Hlt2TurCalTrackEff"
+    ],
+    "IFT": ["Hlt2IFTFull", "Hlt2IFTTurbo"]
+}
+
+FULL_STREAM_LINES_KEY = "full_stream_lines"
+
+KNOWN_STREAM_CONFIGS_BY_STAGE = {
+    "hlt1": ["streamless"],
+    "hlt2": ["production"],
+    "spruce": ['full', 'turbo', 'turcal', 'no_bias', 'hlt2calib', 'lumi']
+}
+KNOWN_STREAM_CONFIGS = [
+    sc for sc_list in KNOWN_STREAM_CONFIGS_BY_STAGE.values() for sc in sc_list
+]
+
+
+def guess_wg(line_name, process):
+    # First, expect it follows naming convention e.g. <Hlt2,Spruce><WG>_MyLine
+    line_prefix = line_name.split("_")[0].removeprefix(process.capitalize())
+    if line_prefix in KNOWN_WORKING_GROUPS:
+        return line_prefix
+
+    for custom_wg, guesses in CUSTOM_WGS.items():
+        for guess in guesses:
+            if line_name.startswith(guess):
+                return custom_wg
+
+    return "Other"  # If you made it here, all guesses failed
+
+
+def parse_yaml(file_path):
+    with open(os.path.expandvars(file_path), 'r') as f:
+        return yaml.safe_load(f)
+
+
+class FileNameHelper(object):
+    # See: Moore_bandwidth_tests.sh in PRConfig for an explanation of the environment variables needed to use this class
+    base_dir = os.getenv('BASEDIR', default='tmp')
+    mdf_subdir = 'MDF'
+    output_subdir = 'Output'
+    inter_subsubdir = 'Inter'
+    to_eos_subdir = 'to_eos'
+    gitlab_config_webdir = "https://gitlab.cern.ch/lhcb/Moore/-/blob/master/Hlt/Hlt2Conf/tests/options/bandwidth"
+    current_hlt2_output_dir = "root://eoslhcb.cern.ch//eos/lhcb/storage/lhcbpr/www/UpgradeRateTest/current_hlt2_output"
+
+    def __init__(self, process, stream_config):
+        self.process = process
+        self.stream_config = stream_config
+
+    @staticmethod
+    def _join(*bits):
+        return "__".join(bits)
+
+    def _file_pfx(self):
+        return f"{self.process}_bw_testing"
+
+    def _incomplete_mdfdst_fname(self, ext=".mdf", full_path=True):
+        fname = self._join(self._file_pfx(), self.stream_config,
+                           "{stream_bit}") + ext
+        return os.path.join(self.base_dir, self.mdf_subdir,
+                            fname) if full_path else fname
+
+    def _prwww_path(self, fname, starts_mdf):
+        baseurl = f"mdf:{self.current_hlt2_output_dir}" if starts_mdf else self.current_hlt2_output_dir
+        return os.path.join(baseurl, fname)
+
+    @staticmethod
+    def input_type_to_file_ext(input_type):
+        return {"ROOT": ".dst", "MDF": ".mdf"}[input_type]
+
+    def make_tmp_dirs(self):
+        mdf_dir = os.path.join(self.base_dir, self.mdf_subdir)
+        output_dir = os.path.join(self.base_dir, self.output_subdir)
+        for diro in (mdf_dir, output_dir):
+            if not os.path.exists(diro): os.system(f'mkdir -p {diro}')
+
+    def mdfdst_fname_for_Moore(self, ext=".mdf"):
+        return self._incomplete_mdfdst_fname(ext).format(stream_bit="{stream}")
+
+    def mdfdst_fname_for_reading(self,
+                                 stream,
+                                 ext=".mdf",
+                                 on_eos=False,
+                                 full_path=True):
+        basic_path = self._incomplete_mdfdst_fname(
+            ext, full_path=full_path).format(stream_bit=stream)
+        if on_eos:
+            return self._prwww_path(basic_path, starts_mdf=("mdf" in ext))
+        else:
+            return basic_path
+
+    def get_stream_from_bw_path(self, bw_file_path):
+        # useful for globbing
+        # all the BW files share the same separator, so should work for all
+        stream_and_ext_bit = bw_file_path.split("__")[-1]
+        return stream_and_ext_bit.split('.')[0]
+
+    def tck(self, on_eos=False, full_path=True):
+        fname = self._join(self._file_pfx(), self.stream_config) + ".tck.json"
+        basic_path = os.path.join(self.base_dir, self.mdf_subdir,
+                                  fname) if full_path else fname
+        if on_eos:
+            assert not full_path, "File paths on eos dont have directory structure"
+            return self._prwww_path(basic_path, starts_mdf=False)
+        else:
+            return basic_path
+
+    def stream_config_json_path(self, full_path=True):
+        fname = self._join(self._file_pfx(), "streaming",
+                           self.stream_config) + ".json"
+        return os.path.join(self.base_dir, self.mdf_subdir,
+                            fname) if full_path else fname
+
+    def line_descriptor_json_path(self, full_path=True):
+        fname = self._join(self._file_pfx(), self.stream_config,
+                           "line_descriptives") + ".json"
+        return os.path.join(self.base_dir, self.mdf_subdir,
+                            fname) if full_path else fname
+
+    def config_file_path(self, stream: str, send_to_eos: bool):
+        assert self.process == "hlt2"
+        fname = f"spruce_bandwidth_latest_input__{stream}.yaml"
+        if send_to_eos:
+            return os.path.join(self.base_dir, self.to_eos_subdir, fname)
+        else:
+            return os.path.join(self.base_dir, fname)
+
+    def tistos_option_file(self, full_path=True):
+        fname = self._join(self.process, "tistos_option_file",
+                           self.stream_config) + ".py"
+        return os.path.join(self.base_dir, self.mdf_subdir,
+                            fname) if full_path else fname
+
+    def input_info_json(self):
+        return os.path.join(
+            self.base_dir, self.mdf_subdir,
+            self._join(self._file_pfx(), self.stream_config,
+                       "input_info")) + ".json"
+
+    def filesize_path(self):
+        fname = self._join(self.process, self.stream_config,
+                           "filesizes") + ".json"
+        return os.path.join(self.base_dir, self.output_subdir, fname)
+
+    def line_descr_path(self, full_path=True):
+        fname = self._join(self.process, self.stream_config,
+                           "line_descriptives") + ".html"
+        return os.path.join(self.base_dir, self.output_subdir,
+                            fname) if full_path else fname
+
+    def jaccard_similarities_path(self):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, self.stream_config,
+                       "jaccard_similarity_matrix") + ".html")
+
+    def overlap_matrix_path(self):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, self.stream_config, "overlap_matrix") +
+            ".html")
+
+    def intra_stream_jaccard_similarities_path(self, stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, self.stream_config, stream,
+                       "jaccard_similarity_matrix") + ".html")
+
+    def intra_stream_overlap_matrix_path(self, stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, self.stream_config, stream,
+                       "overlap_matrix") + ".html")
+
+    def event_no_fname(self, stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, "event_numbers", self.stream_config,
+                       stream) + ".json")
+
+    def intra_stream_event_no_fname(self, stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir,
+            self._join(self.process, "event_numbers_intra_stream",
+                       self.stream_config, stream) + ".json")
+
+    def _tmp_rate_table_path(self, stream, line_or_stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir, self.inter_subsubdir,
+            self._join(self.process, f"rates_per_{line_or_stream}",
+                       self.stream_config, stream) + ".csv")
+
+    def tmp_rate_table_per_line_path(self, stream):
+        return self._tmp_rate_table_path(stream, "line")
+
+    def tmp_rate_table_per_stream_path(self, stream):
+        return self._tmp_rate_table_path(stream, "stream")
+
+    def tmp_rate_table_intra_stream_path(self, stream):
+        return os.path.join(
+            self.base_dir, self.output_subdir, self.inter_subsubdir,
+            self._join(self.process, f"rates_wgs_within_{stream}",
+                       self.stream_config, stream) + ".csv")
+
+    def final_rate_table_all_lines_path(self, ext="html", full_path=True):
+        fname = self._join(self.process, self.stream_config,
+                           "rates_for_all_lines") + f".{ext}"
+        return os.path.join(self.base_dir, self.output_subdir,
+                            fname) if full_path else fname
+
+    def final_rate_table_all_lines_split_by_stream_path(self, full_path=True):
+        fname = self._join(
+            self.process,
+            self.stream_config,
+            "rates_for_all_lines_split_by_stream",
+        ) + ".html"
+        return os.path.join(self.base_dir, self.output_subdir,
+                            fname) if full_path else fname
+
+    def final_rate_table_all_streams_path(self, ext="html", full_path=True):
+        fname = self._join(self.process, self.stream_config,
+                           "rates_for_all_streams") + f".{ext}"
+        return os.path.join(self.base_dir, self.output_subdir,
+                            fname) if full_path else fname
+
+    def final_rate_table_all_lines_split_by_stream_by_wg_path(
+            self, full_path=True):
+        fname = self._join(
+            self.process, self.stream_config,
+            "rates_for_all_lines_split_by_stream_by_wg") + ".html"
+        return os.path.join(self.base_dir, self.output_subdir,
+                            fname) if full_path else fname
+
+    ### Below helpers only used in make_bandwidth_test_page.py
+    @staticmethod
+    def base_html_path(running_locally: bool):
+        return "." if running_locally else "https://cern.ch/lhcbpr-hlt/UpgradeRateTest/$$dirname$$"
+
+    @classmethod
+    def _full_path(cls, fname):
+        return os.path.join(cls.base_dir, cls.output_subdir, fname)
+
+    def _plot_path(self, fname, ext="png", full_path=False):
+        fname = self._join(self.process, self.stream_config, fname) + f".{ext}"
+        return self._full_path(fname) if full_path else fname
+
+    def pie_chart_path(self, full_path=False):
+        return self._plot_path("lines_per_wg", full_path=full_path)
+
+    def hist_path(self, hist_suffix, full_path=False):
+        return self._plot_path(f"hist__{hist_suffix}", full_path=full_path)
+
+    def bar_chart_path(self, stream, metric, full_path=False):
+        return self._plot_path(
+            f"{stream}__bar_chart__{metric}", full_path=full_path)
+
+    def headline_bar_chart_path(self, full_path=False):
+        return self.bar_chart_path("all", "bandwidth", full_path=full_path)
+
+    def to_disk_bar_chart_path(self, full_path=False):
+        return self.bar_chart_path(
+            "all_to_disk", "bandwidth", full_path=full_path)
+
+    def _extra_html_page_path(self, page_name, full_path):
+        fname = self._join(self.process, self.stream_config,
+                           page_name) + ".html"
+        return self._full_path(fname) if full_path else fname
+
+    def other_lines_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("other_lines", full_path)
+
+    def all_rates_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("all_rates", full_path)
+
+    def sim_matrices_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("similarity_matrices", full_path)
+
+    def extra_bar_charts_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("extra_bar_charts", full_path)
+
+    def extra_sim_matrices_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("extra_similarity_matrices",
+                                          full_path)
+
+    def comparison_str(self):
+        return self._join(self.process, self.stream_config, "comparison")
+
+    def index_html_page_path(self, full_path=False):
+        return self._extra_html_page_path("index", full_path)
+
+    @classmethod
+    def top_level_index_html_path(cls):
+        return cls._full_path("index.html")
+
+    def message_path(self):
+        return self._full_path("message.json")
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/calculate_stream_overlap.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/calculate_stream_overlap.py
new file mode 100755
index 00000000000..cb9769a6b2e
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/calculate_stream_overlap.py
@@ -0,0 +1,143 @@
+###############################################################################
+# (c) Copyright 2000-2023 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+''' Compare event numbers extracted from mdf outputs of different streams to
+    quantify the overlap between the streams by Jaccard similarity index.
+    Writes similarity matrix to console and out to .html for usage in BW test page.
+'''
+import argparse
+import pandas as pd
+from sklearn.metrics.pairwise import pairwise_distances
+import json
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, KNOWN_STREAM_CONFIGS
+
+
+def get_all_event_numbers(args):
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+    ret = {}
+    for stream in args.streams:
+        with open(fname_helper.event_no_fname(stream), 'r') as f:
+            ret.update(json.load(f))
+    return ret
+
+
+def get_event_number_matrix(event_numbers):
+
+    all_event_numbers = set([
+        event_info for event_info_list in event_numbers.values()
+        for event_info in event_info_list
+    ])
+    print(
+        f"Found {len(all_event_numbers)} unique event numbers across {len(event_numbers.keys())} categories/streams."
+    )
+
+    df = pd.DataFrame(
+        False, index=list(all_event_numbers), columns=event_numbers.keys())
+    for stream, event_info_list in event_numbers.items():
+        for event_info in event_info_list:
+            df[stream][event_info] = True
+
+    return df
+
+
+def calculate_similarity_matrix(df):
+
+    if df.empty:
+        # return a dummy matrix so things dont fail
+        jaccard = [[0 for _ in range(len(df.columns))]
+                   for _ in range(len(df.columns))]
+    else:
+        jaccard = 1 - pairwise_distances(
+            df.T.to_numpy(), metric='jaccard'
+        )  # .T bcuz pairwise_distance must expect the fields to take similarity between to be rows rather than columns
+    jaccard_sim_matrix_df = pd.DataFrame(
+        jaccard, columns=df.columns, index=df.columns)
+
+    return jaccard_sim_matrix_df
+
+
+def calculate_overlap_matrix(df):
+    cond_prob_per_stream = {stream: [] for stream in df.columns}
+    for target_stream in df.columns:
+        for comparison_stream in df.columns:
+            cond_prob_per_stream[target_stream].append(
+                sum(df[comparison_stream] * df[target_stream]) /
+                sum(df[target_stream]) if sum(df[target_stream]) > 0 else 0)
+    overlap_matrix_df = pd.DataFrame(
+        cond_prob_per_stream, columns=df.columns, index=df.columns)
+    return overlap_matrix_df
+
+
+def save(df, htmlpath):
+    # Generate HTML table for similarity matrix
+    html = df.to_html(float_format=lambda x: f"{x:.1%}")
+    with open(htmlpath, 'w') as f:
+        f.write(html)
+
+
+def main():
+
+    parser = argparse.ArgumentParser()
+    subparsers = parser.add_subparsers(help='Mode of execution', dest='mode')
+    inter_stream_parser = subparsers.add_parser("inter_stream")
+    inter_stream_parser.add_argument(
+        '--streams', nargs='+', type=str, required=True)
+
+    intra_stream_parser = subparsers.add_parser("intra_stream")
+    intra_stream_parser.add_argument('--stream', type=str, required=True)
+    for sp in [inter_stream_parser, intra_stream_parser]:
+        sp.add_argument(
+            '-p',
+            '--process',
+            type=str,
+            help='Compute for Hlt2 or Sprucing lines',
+            choices=['hlt2', 'spruce'],
+            required=True)
+        sp.add_argument(
+            '--stream-config',
+            type=str,
+            choices=KNOWN_STREAM_CONFIGS,
+            required=True)
+    args = parser.parse_args()
+
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+
+    if args.mode == "inter_stream":
+        similarities_path = fname_helper.jaccard_similarities_path()
+        overlaps_path = fname_helper.overlap_matrix_path()
+        event_numbers = get_all_event_numbers(args)
+    elif args.mode == "intra_stream":
+        similarities_path = fname_helper.intra_stream_jaccard_similarities_path(
+            args.stream)
+        overlaps_path = fname_helper.intra_stream_overlap_matrix_path(
+            args.stream)
+        with open(fname_helper.intra_stream_event_no_fname(args.stream),
+                  'r') as f:
+            event_numbers = json.load(f)
+
+    df = get_event_number_matrix(event_numbers)
+
+    sim_matrix = calculate_similarity_matrix(df)
+    print(
+        f"Calculated similarity matrix. Printing and saving to html at {similarities_path}."
+    )
+    print(sim_matrix)
+    save(sim_matrix, similarities_path)
+
+    overlap_matrix = calculate_overlap_matrix(df)
+    print(
+        f"Calculated overlap matrix. Printing and saving to html at {overlaps_path}."
+    )
+    print(overlap_matrix)
+    save(overlap_matrix, overlaps_path)
+
+
+if __name__ == "__main__":
+    main()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/combine_rate_output.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/combine_rate_output.py
new file mode 100755
index 00000000000..32da55be741
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/combine_rate_output.py
@@ -0,0 +1,278 @@
+###############################################################################
+# (c) Copyright 2000-2023 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+'''
+    Each method works the same: reads in all relevant CSV files
+    and combines into single dataframe.
+    It writes out CSV and HTML for each dataframe.
+'''
+import pandas as pd
+import glob
+import argparse
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, guess_wg, KNOWN_STREAM_CONFIGS
+
+COLUMNS_PER_STREAM = [
+    'Stream', 'Total Retention (%)', 'Rate (kHz)', 'Avg Total Event Size (kB)',
+    'Total Bandwidth (GB/s)', 'Avg DstData Size (kB)',
+    'DstData Bandwidth (GB/s)'
+]
+
+
+def _columns_per_line(process):
+    tols = {
+        # Tolerances per process.
+        'hlt1': (1e3, None, 150, 0, 0),
+        'hlt2': (1, 1e3, 0.2, 1e3, 0.2),
+        'spruce': (1, 1e3, 0.2, 1e3, 0.2),
+    }[process]
+    return {
+        # col_name, threshold for turning it red to catch the reader's eye
+        'Line': None,
+        'Total Retention (%)': None,
+        'Rate (kHz)': tols[0],
+        'Exclusive Retention(%)': None,
+        'Exclusive Rate (kHz)': None,
+        'Avg Total Event Size (kB)': tols[1],
+        'Total Bandwidth (GB/s)': tols[2],
+        'Avg DstData Size (kB)': tols[3],
+        'DstData Bandwidth (GB/s)': tols[4]
+    }
+
+
+def _sorted_df_by_bandwidth(df):
+    return df.sort_values(
+        by=['Total Bandwidth (GB/s)'], ascending=False).reset_index(drop=True)
+
+
+def _read_csv(file):
+    try:
+        return pd.read_csv(file, header=None)
+    except pd.errors.EmptyDataError:
+        print(f"Empty file: {file} - likely no triggers.")
+        return pd.DataFrame()
+
+
+def table_per_line(fname_helper: FileNameHelper):
+    """Make 1 enormous table with rate/bw info per line for all lines in all streams (i.e. n_rows = n_lines).
+       Saves to .csv and .html.
+    """
+
+    frames = []
+
+    for file in glob.glob(fname_helper.tmp_rate_table_per_line_path("*")):
+        df = _read_csv(file)
+        if not df.empty:
+            frames.append(df)
+
+    try:
+        df = pd.concat(frames)
+        df.columns = _columns_per_line(fname_helper.process).keys()
+        df = _sorted_df_by_bandwidth(df)
+    except ValueError:
+        print("No triggers found for any lines. Saving empty .csv and .html.")
+        df = pd.DataFrame(
+            columns=_columns_per_line(fname_helper.process).keys())
+
+    df.to_csv(fname_helper.final_rate_table_all_lines_path("csv"))
+
+    def highlight_vals(val, threshold, color='red'):
+        return f'background-color: {color}' if val > threshold else ''
+
+    styler = None
+    for column, threshold in _columns_per_line(fname_helper.process).items():
+        # Make cell red if column value greater than threshold
+        if threshold:
+            if styler:
+                styler = styler.applymap(
+                    highlight_vals, subset=[column], threshold=threshold)
+            else:
+                styler = df.style.applymap(
+                    highlight_vals, subset=[column], threshold=threshold)
+
+    html = styler.format(
+        '{:.3g}', subset=df.columns[
+            df.columns != 'Line']).set_table_attributes("border=1").to_html()
+    with open(fname_helper.final_rate_table_all_lines_path("html"), 'w') as f:
+        f.write(html)
+
+    return
+
+
+def table_per_line_per_stream(fname_helper: FileNameHelper):
+    """ Makes (1 table with rate/bw info per line in the streamed mdf) for all <stream_config> streams (i.e. n_tables = n_streams).
+        Puts them all on 1 html page, adds hyperlinks to jump to the different streams on the page.
+        Saves to .html page only.
+    """
+
+    with open(fname_helper.final_rate_table_all_lines_split_by_stream_path(),
+              'w') as f:
+        files = glob.glob(fname_helper.tmp_rate_table_per_line_path("*"))
+        files_by_stream = {
+            fname_helper.get_stream_from_bw_path(file): file
+            for file in files
+        }
+        f.write('<head></head>\n<body>\n')
+        f.write("""
+        <p>
+            Rates, event sizes and bandwidths of all lines in each stream, listed descending in bandwidth. <br>
+            Exclusive retentions/rates are calculated by counting those events in which only that line fired. <br>
+            Bandwidths are inclusive: they are calculated by summing raw bank sizes for those events in which the trigger line fired. <br>
+        </p>
+        """)
+        f.write('<p>Jump to:\n<ul>')
+        for stream in files_by_stream.keys():
+            f.write(
+                f'<li><a href="#{stream}_label"> {stream.upper()}</a></li>')
+        f.write('</ul>\n</p>')
+
+        for stream, file in files_by_stream.items():
+            f.write(f'<head>{stream.upper()}</head>')
+            f.write(f'<a id="{stream}_label">')
+            df = _read_csv(file)
+            if not df.empty:
+                df.columns = _columns_per_line(fname_helper.process).keys()
+                df = _sorted_df_by_bandwidth(df)
+                f.write(
+                    df.style.format(
+                        '{:.3g}', subset=df.columns[df.columns != 'Line']).
+                    set_table_attributes("border=1").to_html())
+            f.write('</a>')
+            f.write('<br/><br/>')
+
+    return
+
+
+def table_per_stream(fname_helper: FileNameHelper):
+    """ Makes 1 table with rate/bw info integrated over the whole streamed mdf for all <fname_helper.stream_config> streams (i.e. a table with n_rows = n_streams).
+        Saves to .html and .csv.
+    """
+
+    frames = []
+    for file in glob.glob(fname_helper.tmp_rate_table_per_stream_path("*")):
+        df = _read_csv(file)
+        frames.append(df)
+
+    try:
+        df = pd.concat(frames)
+        df.columns = COLUMNS_PER_STREAM
+        df = _sorted_df_by_bandwidth(df)
+    except ValueError:
+        print(
+            "No triggers found for any streams. Saving empty .csv and .html.")
+        df = pd.DataFrame(columns=COLUMNS_PER_STREAM)
+
+    df.to_csv(fname_helper.final_rate_table_all_streams_path(ext="csv"))
+
+    html = df.style.format(
+        '{:.3g}',
+        subset=df.columns[df.columns != 'Stream']).set_table_attributes(
+            "border=1").to_html()
+    with open(fname_helper.final_rate_table_all_streams_path(ext="html"),
+              'w') as f:
+        f.write(html)
+
+    return
+
+
+def table_per_line_per_wg_per_stream(fname_helper: FileNameHelper):
+    """ Makes html page with 1 table per stream and per WG, with rows being per line within that WG and stream giving rate/bw,
+        Saves to .html.
+    """
+
+    files = glob.glob(fname_helper.tmp_rate_table_per_line_path("*"))
+    files_by_stream = {
+        fname_helper.get_stream_from_bw_path(file): file
+        for file in files
+    }
+    htmls_per_stream_and_per_wg = {
+        stream: {}
+        for stream in files_by_stream.keys()
+    }
+    for stream, file in files_by_stream.items():
+        stream_df = _read_csv(file)
+        if stream_df.empty: continue
+        stream_df.columns = _columns_per_line(fname_helper.process)
+        stream_df["WG"] = stream_df.apply(
+            lambda row: guess_wg(row["Line"], fname_helper.process), axis=1)
+        for wg in sorted(stream_df["WG"].unique()):
+            wg_df = stream_df.loc[stream_df["WG"] == wg]
+            wg_df = _sorted_df_by_bandwidth(wg_df)
+            wg_df = wg_df.drop(columns='WG')
+
+            htmls_per_stream_and_per_wg[stream][wg] = wg_df.style.format(
+                '{:.3g}',
+                subset=wg_df.columns[~wg_df.columns.isin(['Line', 'WG'])]
+            ).set_table_attributes("border=1").to_html()
+
+    with open(
+            fname_helper.
+            final_rate_table_all_lines_split_by_stream_by_wg_path(), 'w') as f:
+        f.write('<head></head>\n<body>\n')
+        f.write("""
+        <p>
+            Rates, event sizes and bandwidths of all lines in each stream, split also by WG, listed descending in bandwidth. <br>
+            Exclusive retentions/rates are calculated by counting those events in which only that line fired. <br>
+            Bandwidths are inclusive: they are calculated by summing raw bank sizes for those events in which the trigger line fired. <br>
+        </p>
+        """)
+        f.write('<p>Jump to:\n<ul>')
+        for stream, htmls in htmls_per_stream_and_per_wg.items():
+            f.write(
+                f'<li><a href="#{stream}_label"> {stream.upper()}</a></li>')
+            f.write('<ul>')
+            for wg in htmls.keys():
+                f.write(f'<li><a href="#{stream}_{wg}_label"> {wg}</a></li>')
+            f.write('</ul>')
+        f.write('</ul>\n</p>')
+
+        for stream, htmls in htmls_per_stream_and_per_wg.items():
+            f.write('<p>')
+            f.write(f'<head>{stream.upper()}</head>')
+            f.write(f'<a id="{stream}_label">')
+            f.write('<p/>')
+
+            for wg, html in htmls.items():
+                f.write(f'<head>{wg}</head>')
+                f.write(f'<a id="{stream}_{wg}_label">')
+                f.write(html)
+                f.write('</a>')
+                f.write('<br/><br/>')
+
+            f.write('</a>')
+            f.write('<br/><br/>')
+
+    return
+
+
+if __name__ == "__main__":
+    parser = argparse.ArgumentParser(
+        description=
+        "Combine output to make final rate tables per line, per stream, per stream and WG etc."
+    )
+    parser.add_argument(
+        '-p',
+        '--process',
+        type=str,
+        help='Compute for Hlt1, Hlt2 or Sprucing lines',
+        choices=['hlt1', 'hlt2', 'spruce'],
+        required=True)
+    parser.add_argument(
+        '--stream-config',
+        type=str,
+        choices=KNOWN_STREAM_CONFIGS,
+        required=True)
+    args = parser.parse_args()
+
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+    for func in [
+            table_per_line, table_per_stream, table_per_line_per_stream,
+            table_per_line_per_wg_per_stream
+    ]:
+        func(fname_helper)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/extract_filesizes.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/extract_filesizes.py
new file mode 100755
index 00000000000..d0b82cb60e1
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/extract_filesizes.py
@@ -0,0 +1,72 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+import argparse
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, KNOWN_STREAM_CONFIGS
+import os
+import subprocess
+import json
+
+
+def extract_filesizes(process, stream_config, streams):
+    """
+        Extracts the compression scale factor per output mdf file.
+            scale_factor range: [0, 1]
+            scale_factor = compressed_size / uncompressed_size
+    """
+    fname_helper = FileNameHelper(process, stream_config)
+    filesizes = {}
+    compression_cmd = 'zstd -f {fpath}'
+    fsize = lambda fpath: os.stat(fpath).st_size  # in Bytes
+    for stream in streams:
+        fpath = fname_helper.mdfdst_fname_for_reading(
+            stream=stream,
+            full_path=True,
+            ext=".mdf" if process in ['hlt1', 'hlt2'] else ".dst")
+        filesizes[stream] = {"default": fsize(fpath)}
+
+        # Unsure if Hlt1 is compressed by data movers so for now we do nothing.
+        # This doesn't affect Rate anyway which is the important parameter at Hlt1 in this test.
+        if process == 'hlt2':
+            #.mdf requires compression by data movers
+            sp_compress = subprocess.run(
+                compression_cmd.format(fpath=fpath), shell=True)
+            if sp_compress.returncode != 0:
+                raise RuntimeError(
+                    f"Returned {sp_compress.returncode} during compressing {fpath}."
+                )
+            filesizes[stream]["compressed"] = fsize(fpath + '.zst')
+
+    with open(fname_helper.filesize_path(), 'w') as ofile:
+        json.dump(filesizes, ofile, indent=2)
+
+
+if __name__ == "__main__":
+    parser = argparse.ArgumentParser()
+    parser.add_argument(
+        '-p',
+        '--process',
+        type=str,
+        help='Compute for Hlt1, Hlt2 or Sprucing output',
+        choices=['hlt1', 'hlt2', 'spruce'],
+        required=True)
+    parser.add_argument(
+        '--stream-config',
+        type=str,
+        choices=KNOWN_STREAM_CONFIGS,
+        required=True)
+    parser.add_argument('--streams', nargs='+', type=str, required=True)
+
+    args = parser.parse_args()
+
+    extract_filesizes(
+        process=args.process,
+        stream_config=args.stream_config,
+        streams=args.streams)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_spruce_input_configs.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_spruce_input_configs.py
new file mode 100755
index 00000000000..19635a80c52
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_spruce_input_configs.py
@@ -0,0 +1,111 @@
+###############################################################################
+# (c) Copyright 2023-2024 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+'''
+    Takes the config file describing the Hlt2 job's input file.
+    Generates a metadata yaml about the FULL stream output of the Hlt2 job.
+    This metadata can then be used as a config file for a Spruce job's input file.
+'''
+import argparse
+import json
+import yaml
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, parse_yaml, FULL_STREAM_LINES_KEY
+from PRConfig.TestFileDB import test_file_db
+
+
+def main():
+    parser = argparse.ArgumentParser()
+    parser.add_argument(
+        '-c',
+        '--config',
+        type=str,
+        required=True,
+        help='Path to yaml config file defining the input.')
+    parser.add_argument('--stream-config', type=str, required=True)
+    parser.add_argument('--stream', type=str, required=True)
+    args = parser.parse_args()
+    fname_helper = FileNameHelper(
+        process="hlt2", stream_config=args.stream_config)
+    config = parse_yaml(args.config)
+
+    opts = {'input_raw_format': config['input_raw_format']}
+    for optional in ['velo_radial_opening', 'nu', 'mu']:
+        if optional in config.keys():
+            opts[optional] = config[optional]
+    opts['filtering_info_links'] = [
+        FileNameHelper.gitlab_config_webdir + "/" + args.config.split('/')[-1]
+    ]
+    opts['input_type'] = "MDF"  # We always write MDF out of HLT2
+
+    try:
+        conds = test_file_db[config['testfiledb_key']].qualifiers
+        opts["dddb_tag"] = conds['DDDB']
+        opts["conddb_tag"] = conds['CondDB']
+        opts["simulation"] = conds['Simulation']
+        opts["geometry_version"] = conds['GeometryVersion']
+        opts["conditions_version"] = conds['ConditionsVersion']
+        opts["data_type"] = conds['DataType']
+    except KeyError:
+        # input wasn't in testfileDB
+        for k in [
+                'geometry_version', 'dddb_tag', 'conddb_tag',
+                'conditions_version', 'simulation', 'data_type'
+        ]:
+            if k in config.keys():
+                opts[k] = config[k]
+
+    ifile = fname_helper.event_no_fname(stream=args.stream)
+    with open(ifile, 'r') as f:
+        # json = {stream: [evt_numbers]}
+        n_triggered = len(json.load(f)[args.stream])
+
+    n_hlt2_input = int(parse_yaml(fname_helper.input_info_json())['n_evts'])
+    input_rate = config['input_rate']
+    opts["input_rate"] = round((input_rate * n_triggered / n_hlt2_input), 4)
+
+    # Load up the streaming configuration and therefore get the list of full-stream lines
+    # Needed for TISTOS
+    if args.stream == 'full':
+        with open(fname_helper.stream_config_json_path(full_path=True),
+                  'r') as f:
+            opts[FULL_STREAM_LINES_KEY] = json.load(f)["full"]
+
+    # Now split into outputs for two files - one to allow reading of HLT2 output that lives on eos, and one for reading from local disk
+    # Metadata with 'eos' file paths.
+    # Use local path for manifest file and download it in spruce_latest jobs
+    # Can be reverted once TurboPass sprucing can access non-local input_manifests
+    opts["input_files"] = [
+        fname_helper.mdfdst_fname_for_reading(
+            stream=args.stream, ext=".mdf", on_eos=True, full_path=False)
+    ]
+    opts["input_manifest_file"] = fname_helper.tck(
+        on_eos=False, full_path=True)  # will be downloaded to here
+    spruce_config_to_put_on_eos = fname_helper.config_file_path(
+        stream=args.stream, send_to_eos=True)
+    with open(spruce_config_to_put_on_eos, 'w') as f:
+        yaml.dump(opts, f, default_flow_style=False)
+
+    # Metadata with 'local' file paths.
+    local_opts = opts
+    local_opts["input_files"] = [
+        fname_helper.mdfdst_fname_for_reading(
+            stream=args.stream, ext='.mdf', on_eos=False, full_path=True)
+    ]
+    local_opts["input_manifest_file"] = fname_helper.tck(
+        on_eos=False, full_path=True)
+    spruce_config_for_local_use = fname_helper.config_file_path(
+        stream=args.stream, send_to_eos=False)
+
+    with open(spruce_config_for_local_use, 'w') as f:
+        yaml.dump(local_opts, f, default_flow_style=False)
+
+
+if __name__ == "__main__":
+    main()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_tistos_option_file.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_tistos_option_file.py
new file mode 100644
index 00000000000..01766b0e851
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/generate_tistos_option_file.py
@@ -0,0 +1,67 @@
+###############################################################################
+# (c) Copyright 2000-2024 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+import argparse
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, parse_yaml, FULL_STREAM_LINES_KEY
+
+
+def full_stream_content(config):
+    # get list of lines from yaml config
+    tistos_content = ''
+    if "fixed_list_of_full_stream_lines" in config.keys():
+        tistos_content += f'from Hlt2Conf.sprucing_settings.fixed_line_configs import {config["fixed_list_of_full_stream_lines"]} as lines_for_TISTOS'
+    elif FULL_STREAM_LINES_KEY in config.keys():
+        tistos_content += f'lines_for_TISTOS = {config[FULL_STREAM_LINES_KEY]}'
+    else:
+        raise ValueError(
+            f"Expected either fixed_list_of_full_stream_lines or {FULL_STREAM_LINES_KEY} in the config file."
+        )
+
+    return [
+        tistos_content,
+        'from Moore.persistence.hlt2_tistos import list_of_full_stream_lines',
+        'list_of_full_stream_lines.global_bind(lines=lines_for_TISTOS)',
+    ]
+
+
+def main():
+    """
+    Generate the option file for TISTOS for the Spruce job.
+    Read input config: either get a fixed key for a list of lines
+    stored in Moore, or we get a list of lines in the file.
+    """
+    parser = argparse.ArgumentParser(description=main.__doc__)
+    parser.add_argument(
+        '-c',
+        '--config',
+        type=str,
+        required=True,
+        help='Path to yaml config file defining the input.')
+    parser.add_argument('--stream-config', type=str, required=True)
+    args = parser.parse_args()
+    config = parse_yaml(args.config)
+
+    if args.stream_config == "full":
+        print("Setting list of full stream lines as stream-config == full.")
+        content = full_stream_content(config)
+    else:
+        print(
+            "Not setting a list of full stream lines as stream-config != full."
+        )
+        content = []
+
+    output_fname_helper = FileNameHelper("spruce", args.stream_config)
+    ofile = output_fname_helper.tistos_option_file()
+    with open(ofile, "w") as f:
+        f.write('\n'.join(content))
+
+
+if __name__ == "__main__":
+    main()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_and_stream_rates.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_and_stream_rates.py
new file mode 100755
index 00000000000..4947ca9c806
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_and_stream_rates.py
@@ -0,0 +1,446 @@
+###############################################################################
+# (c) Copyright 2000-2022 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+
+import GaudiPython as GP
+from GaudiConf.reading import do_unpacking
+from Configurables import (ApplicationMgr, LHCbApp, IODataManager,
+                           EventSelector, LHCb__UnpackRawEvent,
+                           HltDecReportsDecoder, createODIN)
+from GaudiConf import IOHelper
+from PyConf.application import configured_ann_svc
+from Moore.streams import (bank_types_for_detectors,
+                           HLT1_REPORT_RAW_BANK_TYPES,
+                           HLT2_REPORT_RAW_BANK_TYPES)
+import json
+import argparse
+import csv
+from pprint import pprint
+from dataclasses import dataclass, field
+from typing import List, Dict
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import (
+    FileNameHelper, parse_yaml, guess_wg, KNOWN_WORKING_GROUPS,
+    KNOWN_STREAM_CONFIGS)
+'''
+    Run over MDF or DST file to compute:
+
+        Per line (in form of single .csv table):
+            1. Inclusive retention
+            2. Inclusive rate
+            3. Exclusive retention
+            4. Exclusive rate
+            5. Average event size (all banks in particular stream)
+            6. Bandwidth
+            7. Average DstData bank size
+            8. DstData bandwidth
+
+        Per stream (i.e. the whole file)
+            1. Inclusive retention
+            2. Inclusive rate
+            3. Average event size (all banks in particular stream)
+            4. Bandwidth
+            5. Average DstData bank size
+            6. DstData bandwidth
+'''
+
+LHCb = GP.gbl.LHCb
+RAW_BANK_TYPES = [(i, LHCb.RawBank.typeName(i))
+                  for i in range(LHCb.RawBank.LastType)]
+# If this inversion isn't possible (repeated keys) the dictionary construction will throw errors.
+# However this should never be the case, {Enum: Name} should be a bijective mapping.
+_raw_bank_types_mapping = {
+    rb_name: rb_enum
+    for (rb_enum, rb_name) in RAW_BANK_TYPES
+}
+B_to_kB = 1e-3
+MBps_to_GBps = 1e-3
+
+# Mirroring Moore.streams - passthrough sprucing drops all banks except these
+_passthrough_bank_names = set(
+    bank_types_for_detectors() + ["ODIN", "DstData"] +
+    HLT1_REPORT_RAW_BANK_TYPES + HLT2_REPORT_RAW_BANK_TYPES)
+PASSTHROUGH_BANK_TYPES = [(_raw_bank_types_mapping[rb_name], rb_name)
+                          for rb_name in _passthrough_bank_names]
+
+
+@dataclass
+class LineBW:
+    triggered: List[int] = field(
+        default_factory=lambda: [])  # list of ~event numbers
+    raw: float = 0  # Stores whole event size for every event that fires this line (inclusive)
+    dst: float = 0  # Just DstData raw bank size, as above
+
+
+@dataclass
+class FileBW:
+    triggered: Dict[int, int] = field(
+        default_factory=lambda: dict())  # {event_no: n_times_triggered}
+    raw: float = 0
+    dst: float = 0
+
+
+@dataclass
+class WGBW:
+    n_triggered: int = 0
+    raw: float = 0
+    dst: float = 0
+
+
+def rawbank_sizes(rawevent, lst):
+    """Return (name, size) for each raw bank type."""
+    if rawevent:
+
+        def size(i):
+            return sum(bank.totalSize() for bank in rawevent.banks(i))
+    else:
+
+        def size(i):
+            return 0
+
+    return [(name, size(i)) for i, name in lst]
+
+
+def _compression_factor(process, filesize_path, file_totals, stream):
+    with open(filesize_path, 'r') as ifile:
+        fsizes = json.load(ifile)[stream]
+
+    # Output of Hlt2 is uncompressed by default and then compressed by data movers
+    # Output of Spruce is compresed by default and we estimate the uncompressed size by sum(all rawbanks in file)
+    # We chose not to scale Hlt1.
+    if process == 'hlt2':
+        if fsizes['default'] > 0:
+            return fsizes['compressed'] / fsizes['default']
+        else:
+            # If the file is empty, we assume the compression factor is 1
+            if file_totals.triggered:
+                raise RuntimeError(
+                    "File size is 0 but we appear to have some triggered events. Should not happen."
+                )
+            return 1.
+    elif process == 'spruce':
+        return fsizes['default'] / file_totals.raw if file_totals.raw else 1.
+    else:
+        return 1.
+
+
+def rate_info_from_file(evt_max, lines, process, stream):
+    '''Loop through the file to work out per-line and per-stream triggers and
+    event sizes. Outputs used by functions below to compute rates and bandwidths.
+    '''
+    decisions = [line + 'Decision' for line in list(lines)]
+
+    totals = FileBW()  # Per file (stream) information
+    line_totals = {dec: LineBW() for dec in decisions}  # per line
+
+    # This block only used for hlt2
+    event_info = {wg: set() for wg in KNOWN_WORKING_GROUPS}
+    event_info['Other'] = set()
+    event_info['TotalInclusive'] = set()
+    unknown_lines = set()
+
+    # Loop over all events
+    analysed = 0
+    while analysed < evt_max:
+        analysed += 1
+
+        # Run an event
+        appMgr.run(1)
+        report = evt[f'/Event/{process.capitalize()}/DecReports']
+        # Sprucing has stream-dependent raw event locations - different to HLT1/2
+        rawevent = evt[
+            f'/Event/{stream if process == "spruce" else "DAQ"}/RawEvent']
+        header = evt["/Event/myODIN"]
+
+        evtsize = sum(
+            bank[1] for bank in rawbank_sizes(rawevent, RAW_BANK_TYPES))
+        dstsize = sum(
+            bank[1] for bank in rawbank_sizes(rawevent, [(60, 'DstData')]))
+        spruce_passthrough_evt_size = sum(
+            bank[1]
+            for bank in rawbank_sizes(rawevent, PASSTHROUGH_BANK_TYPES))
+
+        # Will quit running if there are no more events in the input file
+        if report:
+            # Info per file/stream
+            totals.triggered.update({analysed: 0})
+            totals.raw += evtsize
+            totals.dst += dstsize
+            for dec in line_totals.keys():
+                # Info per line
+                if report.decReport(dec) and report.decReport(
+                        dec).decision() == 1:
+                    totals.triggered[analysed] += 1
+                    line_totals[dec].triggered.append(analysed)
+                    line_totals[dec].raw += evtsize
+                    line_totals[dec].dst += dstsize
+
+                    # Info per WG within the stream
+                    if process == "hlt2":
+                        info = (header.eventNumber(),
+                                spruce_passthrough_evt_size, dstsize)
+                        event_info['TotalInclusive'].add(info)
+                        wg = guess_wg(dec, process)
+                        event_info[wg].add(info)
+                        if wg == "Other":
+                            unknown_lines.add(dec)
+        if not header:
+            # Ran out of events. Cant do "else" as some events dont have reports
+            break
+
+    if len(unknown_lines):
+        print(f"Found {len(unknown_lines)} unknown lines. They are...")
+        pprint(unknown_lines)
+
+    # Remove trigger-less WGs, and transform out of tuple for easier & more-robust lookups later
+    wg_event_numbers = {}
+    wg_bws = {}
+    if process == "hlt2":
+        for wg, event_info_set in event_info.items():
+            event_numbers = [info[0] for info in event_info_set]
+            if len(event_numbers) == 0: continue
+
+            wg_event_numbers[wg] = event_numbers
+            wg_bws[wg] = WGBW(
+                n_triggered=len(event_numbers),
+                raw=sum([info[1] for info in event_info_set]),
+                dst=sum([info[2] for info in event_info_set]))
+
+    return totals, line_totals, wg_bws, wg_event_numbers
+
+
+def _write_to_csv(output_path, rows):
+    with open(output_path, 'w') as f:
+        csv_out = csv.writer(f)
+        for row in rows:
+            csv_out.writerow(row)
+
+
+def rates_per_line(line_totals: dict[str, LineBW], file_totals: FileBW,
+                   input_rate: float, output_file_path: str,
+                   compression_factor: float, n_events: int) -> None:
+
+    rows = []
+    if not n_events:
+        print("No denominator for rates, writing empty .csv of rates.")
+        _write_to_csv(output_file_path, [])
+        return
+
+    for line, bw_info in line_totals.items():
+
+        n_fired = len(bw_info.triggered)
+        retention = n_fired / n_events
+        rate = retention * input_rate  # kHz, inclusive
+
+        n_fired_excl = len([
+            evt for evt in bw_info.triggered if file_totals.triggered[evt] == 1
+        ])
+        excl_retention = n_fired_excl / n_events
+        excl_rate = excl_retention * input_rate  # kHz
+
+        avg_evt_size = compression_factor * bw_info.raw * B_to_kB / n_fired if n_fired else 0  # kB
+        avg_dst_size = compression_factor * bw_info.dst * B_to_kB / n_fired if n_fired else 0  # kB
+
+        bw = rate * avg_evt_size * MBps_to_GBps  # GB/s
+        dst_bw = rate * avg_dst_size * MBps_to_GBps  # GB/s
+
+        rows.append([
+            line, retention * 100, rate, excl_retention * 100, excl_rate,
+            avg_evt_size, bw, avg_dst_size, dst_bw
+        ])
+
+    _write_to_csv(output_file_path, rows)
+    return
+
+
+def rates_per_stream(file_totals: FileBW, stream: str, input_rate: float,
+                     output_file_path: str, compression_factor: float,
+                     n_events: int) -> None:
+
+    if not n_events:
+        print("No denominator for rates, writing empty .csv of rates.")
+        _write_to_csv(output_file_path, [])
+        return
+
+    n_fired = len(file_totals.triggered)
+    retention = n_fired / n_events
+    rate = retention * input_rate
+
+    avg_evt_size = compression_factor * file_totals.raw * B_to_kB / n_fired if n_fired else 0
+    avg_dst_size = compression_factor * file_totals.dst * B_to_kB / n_fired if n_fired else 0
+
+    bw = rate * avg_evt_size * MBps_to_GBps  # GB/s
+    dst_bw = rate * avg_dst_size * MBps_to_GBps  # GB/s
+
+    row = (stream, retention * 100, rate, avg_evt_size, bw, avg_dst_size,
+           dst_bw)
+
+    _write_to_csv(output_file_path, [row])
+    return
+
+
+def rates_per_wg_intra_stream(wg_bws: dict[str, WGBW], input_rate: float,
+                              output_file_path: str, compression_factor: float,
+                              n_events: int) -> None:
+    # Get inclusive rates/bandwidths of each WG within this stream
+    if not n_events:
+        print("No denominator for rates, writing empty .csv of rates.")
+        _write_to_csv(output_file_path, [])
+        return
+
+    wg_bw_infos = dict()
+    for wg, bw_info in wg_bws.items():
+        rate = bw_info.n_triggered * input_rate / n_events  # kHz
+        wg_bw_infos[wg] = [
+            rate,
+            compression_factor * input_rate * (bw_info.raw * B_to_kB) *
+            MBps_to_GBps / n_events,  # bandwidth, GBs
+            compression_factor * input_rate * (bw_info.dst * B_to_kB) *
+            MBps_to_GBps / n_events,  # dst bandwidth GB/s
+        ]
+
+    if wg_bw_infos:
+        # Will be fals-y if no triggers for any WG
+        n_metrics = len(wg_bw_infos['TotalInclusive'])
+        wg_bw_infos['SumWGs'] = [
+            sum(bw_info[i] for wg, bw_info in wg_bw_infos.items()
+                if wg != "TotalInclusive") for i in range(n_metrics)
+        ]
+    rows = [[wg] + bw_info for wg, bw_info in wg_bw_infos.items()]
+
+    _write_to_csv(output_file_path, rows)
+    return
+
+
+if __name__ == '__main__':
+
+    parser = argparse.ArgumentParser(description='Inspect Moore output')
+    parser.add_argument(
+        '-c',
+        '--config',
+        type=str,
+        required=True,
+        help='Path to yaml config file defining the input.')
+    parser.add_argument('-s', '--stream', type=str, required=True)
+    parser.add_argument(
+        '-p',
+        '--process',
+        type=str,
+        help='Compute for Hlt1, Hlt2 or Sprucing lines',
+        choices=['hlt1', 'hlt2', 'spruce'],
+        required=True)
+    parser.add_argument(
+        '--stream-config',
+        type=str,
+        choices=KNOWN_STREAM_CONFIGS,
+        required=True)
+    parser.add_argument(
+        '--file-type',
+        choices=("ROOT", "MDF"),
+        required=True,
+        help=
+        "File type of incoming Moore output - ROOT for .dst or MDF for .mdf")
+    args = parser.parse_args()
+
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+
+    n_events = int(parse_yaml(fname_helper.input_info_json())['n_evts'])
+
+    input_config = parse_yaml(args.config)
+
+    LHCbApp(
+        DataType="Upgrade",
+        Simulation=input_config['simulation'],
+        EvtMax=n_events)
+    EventSelector().PrintFreq = 10000
+    IODataManager(DisablePFNWarning=True)
+
+    with open(fname_helper.stream_config_json_path()) as f:
+        lines = json.load(f)[args.stream]
+
+    file_ext = fname_helper.input_type_to_file_ext(args.file_type)
+    IOHelper(args.file_type).inputFiles(
+        [fname_helper.mdfdst_fname_for_reading(args.stream, file_ext)])
+
+    # we have to configure the algorithms manually instead of `do_unpacking`
+    # because we need to set `input_process='Hlt2'` in `unpack_rawevent`
+    # to read MDF/DST output from Sprucing
+    # Hlt1 requires different unpacking than hlt2/sprucing.
+    # TODO might be able to absorb into do_unpacking now
+    if args.stream_config == "turbo":
+        input_process = "Turbo"
+    else:
+        input_process = args.process.capitalize()
+    if args.process == "hlt1":
+        unpacker = LHCb__UnpackRawEvent(
+            "UnpackRawEvent",
+            RawBankLocations=["DAQ/RawBanks/HltDecReports"],
+            BankTypes=["HltDecReports"])
+        decDec = HltDecReportsDecoder(
+            "HltDecReportsDecoder/Hlt1DecReportsDecoder",
+            OutputHltDecReportsLocation="/Event/Hlt1/DecReports",
+            SourceID="Hlt1",
+            DecoderMapping="TCKANNSvc",
+            RawBanks=unpacker.RawBankLocations[0])
+        appMgr = ApplicationMgr(TopAlg=[unpacker, decDec])
+        appMgr.ExtSvc += [configured_ann_svc(name='TCKANNSvc')]
+    else:
+        raw_event_unpacker_kwargs = dict(
+            input_process=input_process, simulation=input_config['simulation'])
+        if args.process == "spruce":
+            raw_event_unpacker_kwargs["stream"] = args.stream
+        # TODO do_unpacking will try to unpack HLT2 dec banks if spruce
+        # leads to annoying ERROR messages that do nothing.
+        algs = do_unpacking(**raw_event_unpacker_kwargs)
+        algs += [
+            LHCb__UnpackRawEvent(
+                RawEventLocation=
+                f"{args.stream if args.process == 'spruce' else 'DAQ'}/RawEvent",
+                BankTypes=['ODIN'],
+                RawBankLocations=["DAQ/RawBanks/ODIN"]),
+            createODIN(ODIN="myODIN"),
+        ]
+
+        appMgr = ApplicationMgr(TopAlg=algs)
+        appMgr.ExtSvc += [configured_ann_svc(json_file=fname_helper.tck())]
+    appMgr = GP.AppMgr()
+    evt = appMgr.evtsvc()
+    input_rate = float(input_config['input_rate'])
+
+    file_totals, line_totals, wg_bws_for_hlt2, wg_event_numbers_for_hlt2 = rate_info_from_file(
+        LHCbApp().EvtMax, lines, args.process, args.stream)
+
+    compression_factor = _compression_factor(
+        process=args.process,
+        filesize_path=fname_helper.filesize_path(),
+        file_totals=file_totals,
+        stream=args.stream)
+
+    n_evts = LHCbApp().EvtMax
+    # Calculate key quantities per stream
+    rates_per_stream(file_totals, args.stream, input_rate,
+                     fname_helper.tmp_rate_table_per_stream_path(args.stream),
+                     compression_factor, n_evts)
+    # Calculate key quantities per line
+    rates_per_line(line_totals, file_totals, input_rate,
+                   fname_helper.tmp_rate_table_per_line_path(args.stream),
+                   compression_factor, n_evts)
+
+    if args.process == "hlt2":
+        # Save the event numbers for WG-by-WG overlaps
+        event_number_file = fname_helper.intra_stream_event_no_fname(
+            args.stream)
+        with open(event_number_file, 'w') as f:
+            json.dump(wg_event_numbers_for_hlt2, f)
+
+        # Calculate rates/bws within a stream
+        rates_per_wg_intra_stream(
+            wg_bws_for_hlt2, input_rate,
+            fname_helper.tmp_rate_table_intra_stream_path(args.stream),
+            compression_factor, n_evts)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_descriptives.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_descriptives.py
new file mode 100644
index 00000000000..6c83a84bb70
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/line_descriptives.py
@@ -0,0 +1,85 @@
+###############################################################################
+# (c) Copyright 2000-2024 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+'''
+    Simple script that returns if a line has persist reco
+    and/or extra output flag enabled. Saves to .html.
+    Relies upon this information being saved to JSON during the Moore job.
+'''
+
+import json
+import pandas as pd
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, KNOWN_STREAM_CONFIGS
+import argparse
+
+
+def main():
+
+    parser = argparse.ArgumentParser(description=__doc__)
+    parser.add_argument(
+        '-p',
+        '--process',
+        type=str,
+        help='Compute for Hlt2 or Sprucing lines. Not applicable to HLT1',
+        choices=['hlt2', 'spruce'],
+        required=True)
+    parser.add_argument(
+        '--stream-config',
+        type=str,
+        choices=KNOWN_STREAM_CONFIGS,
+        required=True)
+    parser.add_argument('--streams', type=str, nargs='+', required=True)
+    args = parser.parse_args()
+
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+    with open(fname_helper.line_descriptor_json_path(), 'r') as f:
+        line_descriptives = json.load(f)
+
+    dfs = {}
+    for stream in args.streams:
+        print(f"Tabulating line descriptives for \"{stream}\" stream.")
+        df = pd.DataFrame(
+            index=line_descriptives[stream].keys(),
+            columns=['PersistReco', 'ExtraOutputs'])
+        for line in df.index.to_list():
+            for descr in ['PersistReco', 'ExtraOutputs']:
+                df[descr][line] = line_descriptives[stream][line][descr]
+        dfs[stream] = df
+
+    html_page = """
+    <html>
+    <head>
+    <body>
+    <p> Persist reco and extra outputs for each line in each stream </p>
+    <p>Jump to:\n<ul>
+    """
+    for stream in args.streams:
+        html_page += f'<li><a href="#{stream}_label">{stream.upper()}</a></li>'
+    html_page += "</ul>\n</p>"
+
+    for stream in args.streams:
+        html_page += f'<head>{stream.upper()}</head>'
+        html_page += f'<a id="{stream}_label">'
+        html_page += dfs[stream].to_html(justify='left')
+        html_page += '</a>'
+        html_page += '<br/><br/>'
+
+    html_page += """
+    </body>
+    </html>
+    """
+
+    with open(fname_helper.line_descr_path(), 'w') as f:
+        f.write(html_page)
+    print(f"Written line descriptives to {fname_helper.line_descr_path()}.")
+
+
+if __name__ == '__main__':
+    main()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/make_bandwidth_test_page.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/make_bandwidth_test_page.py
new file mode 100644
index 00000000000..ee68a63eabf
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/make_bandwidth_test_page.py
@@ -0,0 +1,931 @@
+###############################################################################
+# (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+import argparse
+import jinja2
+import matplotlib.pyplot as plt
+import pandas as pd
+import os
+import json
+from math import log10
+from dataclasses import dataclass, field
+from typing import List
+from collections import namedtuple
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import (
+    FileNameHelper, parse_yaml, guess_wg, KNOWN_WORKING_GROUPS,
+    KNOWN_STREAM_CONFIGS_BY_STAGE)
+
+plt.ioff()
+
+MAIN_HISTOGRAMS = ["rate", "total_size", "tot_bandwidth"]
+EXTRA_HISTOGRAMS = ["dst_data_size", "dst_bandwidth"]
+MAIN_BAR_CHARTS = {
+    "rate": 'Rate (kHz)',
+    "bandwidth": 'Bandwidth (GB/s)',
+}
+EXTRA_BAR_CHARTS = {"dstbandwidth": 'DstData Bandwidth (GB/s)'}
+TDR_BANDWIDTHS = {
+    "hlt2": {
+        "production": {
+            "full": 5.90,
+            "turbo": 2.50,
+            "turcal": 1.60,
+            "total": 10.00,
+        },
+    },
+    "spruce": {
+        "full": {
+            "total": 0.80
+        },
+        "turbo": {
+            "total": 2.50
+        },
+        "turcal": {
+            "total": 0.2
+        },
+        "no_bias": {
+            "total": 0.0
+        },
+        "hlt2calib": {
+            "total": 0.0
+        },
+        "lumi": {
+            "total": 0.0
+        }
+    }
+}
+PRETTY_STREAM_NAMES = {
+    "slepton": "SL",
+    "sl": "SL",
+    "qee": "QEE",
+    "rd": "RD",
+    "bandq": "B&Q",
+    "b_to_open_charm": "B2OC",
+    "b2oc": "B2OC",
+    "bnoc": "BnoC",
+    "b_to_charmonia": "B2CC",
+    "b2cc": "B2CC",
+    "charm": "Charm",
+    "ift": "IFT",
+    "full": "Full",
+    "turbo": "Turbo",
+    "turcal": "TurCal",
+    "Turcal_mDST": "MDST",
+    "Turcal_persistreco": "PersistReco",
+    "Turcal_rawbanks": "RawBanks",
+    "Turcal_persistrecorawbanks": "PRRawBanks",
+    "no_bias": "NoBias",
+    "lumi": "Lumi",
+    "hlt2calib": "Calib"
+}
+
+
+def render_top_level_page(script_path: str,
+                          base_path: str,
+                          test_configs: List[tuple[str, str]],
+                          to_disk_bar_chart=False):
+    html_str = f"""
+    <html>
+    <head></head>
+    <body>
+    <p>
+        slot.build_id: $$version$$<br>
+        start time: $$start_time$$<br>
+        end time: $$end_time$$<br>
+        platform: $$platform$$<br>
+        hostname: $$hostname$$<br>
+        cpu_info: $$cpu_info$$<br>
+        testing script path: {script_path}
+    </p>
+    <ul>
+        <li><a href="{base_path}/run.log">Logs</a></li>
+    </ul>
+    <p>
+        The bandwidth test ran the following sub-tests (process, streaming configuration): {test_configs}<br>
+        The appropriate webpages can be found below for each test below. Scroll down for a report of the test's memory consumption.
+    <ul>
+    """
+    for process, stream_config in test_configs:
+        fname_helper = FileNameHelper(process, stream_config)
+        html_str += f"""
+        <li><a href="{base_path}/{fname_helper.index_html_page_path()}">{process.capitalize()} ({stream_config}) results</a></li>
+        """
+    html_str += """</ul></p>"""
+
+    if to_disk_bar_chart:
+        html_str += f"""
+        <p>
+            Summary of bandwidth of all streams to disk (only available for those tests that run all sprucing stages):<br>
+        </p>
+        <object type="image/png" data="{FileNameHelper(process="spruce", stream_config="").to_disk_bar_chart_path(full_path=False)}"></object>
+        """
+
+    html_str += """
+    <p>
+        <b> Memory consumption of this test: </b>
+    </p>
+    <object type="image/png" data="memory_consumption.png"></object>
+    <p>
+        Memory consumption as functions of Wall-time. <br>
+        The virtual memory size is the total amount of memory the process may hypothetically access. <br>
+        The resident set size (RSS) is the portion of memory occupied by the run that is held in main memory (RAM). <br>
+        The proportional set size (PSS) is the private memory occupied by the run itself plus the proportion of shared memory with one or more other processes. <br>
+        As we only launch one test at the same time, PSS should be close to RSS in this case, and PSS gives the real memory that is used by this test. <br>
+        Swap memory is used when RAM is full. <br>
+        The maximum resident set size usage is $$max_rss$$ GB. <br>
+        The maximum proportional set size usage is $$max_pss$$ GB. <br>
+    </p>
+    </body>
+    </html>"""
+    return _render(html_str)
+
+
+def render_single_test_page(process: str, stream_config: str,
+                            input_config_path: str, streams: List[str],
+                            args: argparse.Namespace):
+
+    fname_helper = FileNameHelper(process, stream_config)
+    base_path = fname_helper.base_html_path(args.building_locally)
+    input_info = parse_yaml(input_config_path)
+
+    exit_code = 1  # Assume failure
+    with open(fname_helper.message_path(), "r") as f:
+        exit_code = int(json.load(f)[process][stream_config]["code"])
+
+    if exit_code == 0:
+        exit_code_sentence = "All sub-jobs in this test exited successfully."
+    else:
+        exit_code_sentence = "There were errors in some of the sub-jobs of this test; please see the logs."
+
+    headline_bar_chart_path = ""
+    if process != "hlt1":
+        headline_bar_chart_path = fname_helper.headline_bar_chart_path(
+            full_path=False)
+
+    html_str = f"""
+    <html>
+    <head></head>
+    <body>
+    <p style="color:{'green' if exit_code == 0 else 'red'}">
+        <b>{exit_code_sentence}</b>
+    </p>
+    <p>
+        This page contains the results of the {process} bandwidth test with the {stream_config} streaming configuration. Scroll down to see:
+    <ul>
+        <li> Summary of main results, </li>
+        <li> Details of the streaming configuration, </li>
+        <li> Links to other html pages produced by this test, </li>
+        <li> Bar charts of rate and bandwidth for each WG within each stream (HLT2 only), </li>
+        <li> A pie chart of all lines split by WGs (HLT2 and sprucing only), </li>
+        <li> Information about the input sample, </li>
+        <li> Stacked histograms of all lines, split by WG, of rate/bandwidth metrics. </li>
+    </ul>
+    <b>Main results:</b> <br>
+    <object type="image/png" data="{headline_bar_chart_path}"></object>
+    </p>
+    """
+    with open(fname_helper.final_rate_table_all_streams_path(),
+              "r") as rate_html:
+        html_str += rate_html.read()
+    total_rate, total_bw = total_rate_and_bw(fname_helper)
+    html_str += f"""
+    <p>
+        <b>The total bandwidth (rate) was measured to be {total_bw:.2f} GB/s ({total_rate:.2f} kHz).</b><br>
+    </p>
+    """
+
+    stream_config_json_path = fname_helper.stream_config_json_path(
+        full_path=False)
+    html_str += f"""
+    <p>
+        The streaming configuration (i.e. which lines went to each stream) can be found in JSON format
+        <a href="{base_path}/{stream_config_json_path}">here</a>. <br>
+        This streaming configuration is our current set of lines to be used in the next data-taking period. <br>
+        "DstData" is the raw bank to which reconstructed information (candidates, other reconstructed tracks etc.) are saved. <br>
+        The "DstData bandwidth" is therefore the bandwidth counting only that raw bank. <br>
+        The total event size (and total bandwidth) count all raw banks (incl. DstData, and detector raw banks if present) in the file. <br>
+    """
+    if process != "hlt1":
+        html_str += """
+            <b>NB:
+            In real data-taking, raw banks are now left uncompressed when writing, and then the whole file is compressed afterwards.
+            We account for this compression by multiplying event sizes and bandwidths by a scaling factor to give accurate per-stream bandwidths.
+            The scaling factor is calculated for each file in the test as: '(size of the compressed file) / (size of the uncompressed file)'.
+            </b>
+            <br>
+            </p>
+        """
+    else:
+        html_str += """</p>"""
+
+    html_str += f"""
+    <p>
+        Further results can be found in the links below:
+    </p>
+    <ul>
+        {list_of_links_html(fname_helper, args.building_locally)}
+        $${fname_helper.comparison_str()}$$
+        </b></b>
+    </ul>
+    <p> See: <a href="https://lbfence.cern.ch/alcm/public/figure/details/32">RTA & DPA Workflow</a> for reference figures regarding bandwidth.</p>
+    {render_bar_charts(fname_helper, streams)}
+    {render_lines_pie_chart(fname_helper)}
+    <p>
+        <b>Input sample information:</b>
+        <ul>
+        <li>Config file: {os.path.expandvars(input_config_path)}</li>
+        <li>Input rate: {input_info['input_rate']} kHz</li>
+        <li>Number of interactions per bunch crossing (&#957): {input_info['nu']}</li>
+        <li>Radius of VELO opening: {input_info['velo_radial_opening']} mm</li>
+        </ul>
+    </p>
+    <p>
+        <b>Stacked histograms of all lines, split by WG, of rate/bandwidth metrics:</b> <br>
+        The total distributions are shown as a stacked histogram, split into several histograms of WGs. <br>
+        The distributions per WG is attached in the html page linked above. <br>
+        Total event size is calculated from summing all raw banks in the file (including DstData). <br>
+        Where appropriate, the DstData raw bank size and DstData bandwidth are calculated from summing only the DstData raw bank. <br>
+    </p>
+    """
+    for hist_suffix in MAIN_HISTOGRAMS:
+        html_str += f"""
+        <object type="image/png" data="{fname_helper.hist_path(hist_suffix, full_path=False)}"></object>
+        """
+    html_str += f"""
+    {render_dst_data_hists(fname_helper)}
+    </body>
+    </html>
+    """
+    return _render(html_str)
+
+
+@dataclass
+class WGRateBWInfo:
+    nlines: int = 0
+    rate: List[float] = field(default_factory=lambda: [])
+    dst_size: List[float] = field(default_factory=lambda: [])
+    tot_size: List[float] = field(default_factory=lambda: [])
+    dst_bw: List[float] = field(default_factory=lambda: [])
+    tot_bw: List[float] = field(default_factory=lambda: [])
+
+
+LineRateBWInfo = namedtuple(
+    "LineRateBWInfo", ["rate", "dst_size", "tot_size", "dst_bw", "tot_bw"])
+
+
+def histo_maker(entry_list,
+                xlabel,
+                plot_path,
+                nbins=100,
+                range=None,
+                take_log=False,
+                log_th=-4,
+                stacked=False,
+                labels=[],
+                legend=False):
+    title = ""
+    if take_log:
+        safe_log = lambda rate: log10(rate) if rate > float(f'1e{log_th}') else log_th - 1
+        title = f"(all values <= log10(1e{log_th}) are in the first bin)"
+        if stacked:
+            # entry_list is a list of lists
+            entry_list = [[safe_log(rate) for rate in lst]
+                          for lst in entry_list]
+        else:
+            entry_list = [safe_log(rate) for rate in entry_list]
+
+    fig = plt.figure()
+    if range:
+        # If specified, range should be a 2-tuple of floats (low, high)
+        plt.hist(entry_list, nbins, range=range, stacked=stacked, label=labels)
+    else:
+        plt.hist(entry_list, nbins, stacked=stacked, label=labels)
+    plt.xlabel(xlabel)
+    plt.ylabel("Number of lines")
+    if title: plt.title(title)
+    if legend: plt.legend(loc='upper right')
+    plt.yscale('log', nonpositive='clip')
+    plt.savefig(plot_path, format="png")
+    plt.close(fig)
+
+
+def list_of_other_lines(process, all_lines_bw_info):
+    return [
+        line for line in all_lines_bw_info.keys()
+        if guess_wg(line, process) == "Other"
+    ]
+
+
+def make_plots(all_lines_bw_info: dict[str, LineRateBWInfo],
+               fname_helper: FileNameHelper):
+    '''
+    Make plots of rate, bandwidth and event sizes of all lines.
+    It will create 5 stacked histograms containing distributions of all lines
+    grouped by WG, and a pie chart showing the number of lines per WG.
+    '''
+
+    # Count number of lines and rates/evt sizes per WG
+    rate_info_per_wg = {
+        wg: WGRateBWInfo()
+        for wg in KNOWN_WORKING_GROUPS + ["Other"]
+    }
+    for line, bw_info in all_lines_bw_info.items():
+        wg_guess = guess_wg(line, fname_helper.process)
+        rate_info_per_wg[wg_guess].nlines += 1
+        for attrib in ["rate", "dst_size", "tot_size", "dst_bw", "tot_bw"]:
+            getattr(rate_info_per_wg[wg_guess], attrib).append(
+                getattr(bw_info, attrib))
+
+    rate_info_per_wg = {
+        k: info
+        for k, info in rate_info_per_wg.items() if info.nlines != 0
+    }
+
+    # Make a pie chart of lines per WG
+    labels = [f"{k} ({int(v.nlines)})" for k, v in rate_info_per_wg.items()]
+    fig = plt.figure()
+    pie = plt.pie([v.nlines for v in rate_info_per_wg.values()],
+                  radius=1,
+                  wedgeprops=dict(width=0.4, edgecolor="w"))
+    plt.legend(
+        pie[0],
+        labels,
+        loc='center',
+        bbox_to_anchor=(1, 0.5),
+        bbox_transform=plt.gcf().transFigure)
+    plt.title(f"Number of {fname_helper.process.capitalize()} lines per WG")
+    plt.savefig(
+        fname_helper.pie_chart_path(full_path=True),
+        format="png",
+        bbox_inches='tight')
+    plt.close(fig)
+
+    # Stacked histograms
+    for attrib, xtitle, plot_bit, log_th, range in zip(
+        ["rate", "tot_size", "tot_bw", "dst_size", "dst_bw"], [
+            "Log10(Rate [Hz])", "Total Event Size [kB]",
+            "Log10(Bandwidth from Total Event Size [GB/s])",
+            "DstData RawBank Size [kB]",
+            "Log10(Bandwidth from DstData Size [GB/s])"
+        ], MAIN_HISTOGRAMS + EXTRA_HISTOGRAMS, [-1, 0, -4, 0, -4],
+        [(-2, 7),
+         (0, 500 if fname_helper.process == 'hlt2' else 1000), (-5, 2),
+         (0, 500 if fname_helper.process == 'hlt2' else 1000), (-5, 2)]):
+        histo_maker(
+            [getattr(info, attrib) for info in rate_info_per_wg.values()],
+            xtitle,
+            fname_helper.hist_path(plot_bit, full_path=True),
+            range=range,
+            take_log="Log10" in xtitle,
+            log_th=log_th,
+            stacked=True,
+            legend=True,
+            labels=list(rate_info_per_wg.keys()))
+
+    return
+
+
+def _important_bar_chart_maker(bandwidths: dict[str, dict[str, float]],
+                               process: str,
+                               stream_config="",
+                               is_to_total_to_disk_bar_chart=True):
+    fname_helper = FileNameHelper(process, stream_config)
+    colors = {'Current': 'tab:orange', 'TDR': 'tab:grey'}
+    width = 0.4
+
+    fig, ax = plt.subplots()
+    plt.grid(True, axis='y', zorder=0, linestyle='dashed')
+    for i_col, (label, bandwidths_by_stream) in enumerate(bandwidths.items()):
+        offset = width * i_col
+        bars = ax.bar([x + offset for x in range(len(bandwidths_by_stream))],
+                      bandwidths_by_stream.values(),
+                      width=width,
+                      label=label,
+                      zorder=3,
+                      color=colors[label])
+        if process == "spruce" and not is_to_total_to_disk_bar_chart:
+            # Only label the last bar - dont have per-WG expectations
+            ax.bar_label(
+                bars,
+                labels=[''] * (len(bars) - 1) +
+                [round(bandwidths_by_stream['Total'], 2)])
+        else:
+            ax.bar_label(
+                bars,
+                labels=[
+                    round(val, 2) for val in bandwidths_by_stream.values()
+                ])
+    ax.set_ylabel('Bandwidth (GB/s)')
+
+    if is_to_total_to_disk_bar_chart:
+        title = "Sprucing (output to disk)"
+    else:
+        title = {
+            "hlt2": "Hlt2 (output to tape)",
+            "spruce": f"Sprucing of {stream_config} stream to disk"
+        }[process]
+    ax.set_title(title)
+
+    # Have to do weird stuff with ticks for (spruce and not important chart) as only have 1 TDR bar
+    tick_pos_opt = 'weird' if process == 'spruce' and not is_to_total_to_disk_bar_chart else 'default'
+    tick_positions = {
+        'default': [x + width / 2 for x in range(len(bandwidths_by_stream))],
+        'weird': [x for x in range(len(bandwidths_by_stream) - 1)] +
+        [len(bandwidths_by_stream) - 1 + width / 2]
+    }[tick_pos_opt]
+    ax.set_xticks(tick_positions, bandwidths_by_stream.keys())
+
+    ax.legend(loc='upper center', ncols=2)
+    plot_path = fname_helper.to_disk_bar_chart_path(
+        full_path=True
+    ) if is_to_total_to_disk_bar_chart else fname_helper.headline_bar_chart_path(
+        full_path=True)
+    plt.savefig(plot_path, format="png")
+    plt.close(fig)
+
+
+def headline_bar_charts(fname_helper: FileNameHelper):
+    """Headline bar chart of rate/bandwidth per stream c.f. TDR"""
+
+    process = fname_helper.process
+    stream_config = fname_helper.stream_config
+    rates_df = pd.read_csv(
+        fname_helper.final_rate_table_all_streams_path(ext='csv'))
+
+    bandwidths = {
+        "Current":
+        dict(zip(rates_df['Stream'], rates_df['Total Bandwidth (GB/s)'])),
+        "TDR": {
+            stream: TDR_BANDWIDTHS[process][stream_config].get(stream, 0)
+            for stream in rates_df['Stream'].to_list()
+        }
+    }
+    for series in ["Current", "TDR"]:
+        bandwidths[series] = {
+            PRETTY_STREAM_NAMES.get(stream, stream): val
+            for stream, val in bandwidths[series].items()
+        }
+
+    bandwidths['Current']['Total'] = sum(bandwidths['Current'].values())
+    bandwidths['TDR']['Total'] = TDR_BANDWIDTHS[process][stream_config][
+        'total']
+
+    _important_bar_chart_maker(
+        bandwidths,
+        process,
+        stream_config,
+        is_to_total_to_disk_bar_chart=False)
+
+
+def _make_bar_chart(rates_df, column, stream, plot_path):
+    """Bar charts of the WG-by-WG rates within 1 stream"""
+
+    fig = plt.figure()
+    plt.grid(True, axis='y', zorder=0, linestyle='dashed')
+    bars = plt.bar(rates_df['WG'], rates_df[column], zorder=3)
+    plt.bar_label(bars, labels=[round(val, 2) for val in rates_df[column]])
+    plt.ylabel(column)
+    plt.xticks(rates_df['WG'], rates_df['WG'], rotation='vertical')
+    plt.subplots_adjust(bottom=0.25)
+    plt.title(f'{column} for each WG in the {stream.capitalize()} stream')
+    plt.savefig(plot_path, format="png")
+    plt.close(fig)
+
+
+def make_per_wg_bar_charts(fname_helper: FileNameHelper, streams: list[str]):
+    all_bar_charts = {**MAIN_BAR_CHARTS, **EXTRA_BAR_CHARTS}
+    for stream in streams:
+        print(f"Making per-WG bar charts for {stream}")
+        try:
+            intra_stream_rates_df = pd.read_csv(
+                fname_helper.tmp_rate_table_intra_stream_path(stream),
+                header=None)
+
+            # NOTE beware if the ordering of the columns ever changes in line-and-stream-rates.py
+            intra_stream_rates_df.columns = ['WG'] + list(
+                all_bar_charts.values())
+            for metric, column in all_bar_charts.items():
+                _make_bar_chart(
+                    intra_stream_rates_df, column, stream,
+                    fname_helper.bar_chart_path(
+                        stream, metric, full_path=True))
+        except pd.errors.EmptyDataError:
+            print(f"Per-WG bar charts: skipping {stream} as no rates found")
+
+    return
+
+
+def write_html_page(page_path, rendered_html):
+    if rendered_html:
+        with open(page_path, "w") as html_file:
+            html_file.write(rendered_html)
+
+
+def _render(html_str):
+    return jinja2.Template(html_str).render()
+
+
+def render_all_lines_page(fname_helper, building_locally):
+    csv_path = fname_helper.final_rate_table_all_lines_path(
+        "csv", full_path=False)
+    html_str = f"""
+    <p>
+        Rates, event sizes and bandwidths of all lines, listed descending in bandwidth. <br>
+        Exclusive retentions/rates are calculated by counting those events in which only that line fired. <br>
+        Bandwidths are inclusive: they are calculated by summing raw bank sizes for those events in which the trigger line fired. <br>
+        These numbers are also saved in a csv file: <a href="{fname_helper.base_html_path(building_locally)}/{csv_path}">{csv_path}</a>
+    </p>
+    """
+    with open(fname_helper.final_rate_table_all_lines_path("html"),
+              "r") as rate_table:
+        html_str += rate_table.read()
+    return _render(html_str)
+
+
+def render_other_line_table(process, lines):
+    if process == "hlt1":
+        return _render("")
+
+    html_str = """
+        <p>
+        List of line names that categorized to "Others".
+        </p>
+        """
+    html_str += r'''<table border = "1">
+        <tr>
+            <th> Name </th>
+        </tr>'''
+    for line in lines:
+        html_str += f'''
+            <tr>
+                <td> {line} </td>
+            </tr>'''
+    html_str += '\n</table>'
+    return _render(html_str)
+
+
+def render_dst_data_hists(fname_helper: FileNameHelper):
+    if fname_helper.process == "hlt1":
+        return _render("")
+
+    html_str = ''
+    for hist_suffix in EXTRA_HISTOGRAMS:
+        html_str += f"""
+            <object type="image/png" data="{fname_helper.hist_path(hist_suffix, full_path=False)}"></object>
+        """
+    return _render(html_str)
+
+
+def render_lines_pie_chart(fname_helper: FileNameHelper):
+    if fname_helper.process == "hlt1":
+        return _render("")
+    return _render(f"""
+        <p>
+            <b>The number of selection lines per working group:</b> <br>
+        </p>
+        <object type="image/png" data="{fname_helper.pie_chart_path(full_path=False)}"></object>
+        <p>
+            "Other" category contains those lines with a parsed name that doesn't belong to any known WG. <br>
+            To make lines properly categorized, one should follow the naming convention -
+            name of lines should start with `Hlt2/Spruce[WG]_`.
+        </p>
+    """)
+
+
+def render_bar_charts(fname_helper: FileNameHelper,
+                      streams: list[str],
+                      metrics=MAIN_BAR_CHARTS.keys()):
+    if fname_helper.process != "hlt2":
+        return _render("")
+
+    html_str = ''
+    for metric in metrics:
+        html_str += f'''
+        <p>
+            <b>{metric.capitalize()} within each stream:</b>
+        </p>
+        <p>
+            "TotalInclusive" is the physical {metric} of the stream.<br>
+            Each WG-specific {metric} bar is calculated by iterating through the events in the streamed HLT2 output file, and counting {metric} due to that event if one or more lines from that WG fired.<br>
+            These WG-specific {metric}s are therefore not physical (no per-WG streams exist at HLT2) but roughly indicate the proportion of the stream's {metric} due to each WG.<br>
+            "SumWGs" is the simple arithmetic sum of all bars except "TotalInclusive" - the former will be larger than the latter if there is non-negligible WG-by-WG overlap.<br>
+        </p>
+        '''
+        if metric == "bandwidth":
+            html_str += '''
+            <p>
+                In the Turbo stream, the WG categorisation corresponds almost exactly to the output streams of the Sprucing passthrough of Turbo.<br>
+                However, the "SumWGs" bandwidth here will not equal the sum of the sprucing passthrough streams, as the file formats and compression settings are different between HLT2 and sprucing.<br>
+                Nevertheless, significant WG-by-WG overlap in Turbo here is an indicator that the sprucing passthrough streams will be significantly inflated by overlap with other WGs.<br>,
+                (If an event fires Turbo lines from 2 WGs at HLT2, both candidates are streamed to both WG streams by the passthrough sprucing, inflating the bandwidth of both streams).<br>
+            </p>
+            '''
+        for stream in streams:
+            html_str += f'''
+                <object type="image/png" data="{fname_helper.bar_chart_path(stream, metric, full_path=False)}"></object>
+            '''
+    return _render(html_str)
+
+
+SIM_MATRICES_DESCR = """
+    <p>
+        The overlap between two streams, A and B, w.r.t to one of the streams, A, is computed as |A n B| / |A|.
+        It evaluates how many events within stream A are also within stream B. <br>
+        The columns in the overlap matrices are target streams (A) and the rows are comparison streams (B),
+        i.e. the numbers correspond to overlaps w.r.t to the column streams. <br>
+    </p>
+    <p>
+        The Jaccard index between two streams, A and B, is computed as |A n B| / |A u B|.
+        It shows how similar the two streams are and is useful in bandwidth division. <br>
+    </p>
+"""
+
+
+def render_sim_matrices_page(fname_helper: FileNameHelper):
+    if fname_helper.process == "hlt1":
+        return _render("")
+
+    html_str = SIM_MATRICES_DESCR
+    html_str += f"""
+        <p>
+            The overlap matrix of the {fname_helper.stream_config} streams is:
+        </p>
+    """
+    with open(fname_helper.overlap_matrix_path(), "r") as overlap:
+        html_str += overlap.read()
+    html_str += f"""
+        <p>
+            The Jaccard similarity matrix of the {fname_helper.stream_config} streams is:
+        </p>
+    """
+    with open(fname_helper.jaccard_similarities_path(), "r") as jaccard:
+        html_str += jaccard.read()
+    return _render(html_str)
+
+
+def render_extra_sim_matrices(fname_helper: FileNameHelper,
+                              streams: list[str]):
+    if fname_helper.process != "hlt2":
+        return _render("")
+
+    html_str = SIM_MATRICES_DESCR
+    for stream in streams:
+        html_str += f"""
+            <p>
+                The overlap matrix of the {stream.capitalize()} stream is:
+            </p>
+        """
+        with open(fname_helper.intra_stream_overlap_matrix_path(stream),
+                  "r") as overlap:
+            html_str += overlap.read()
+        html_str += f"""
+            <p>
+                The Jaccard similarity matrix of the {stream.capitalize()} stream is:
+            </p>
+        """
+        with open(
+                fname_helper.intra_stream_jaccard_similarities_path(stream),
+                "r") as jaccard:
+            html_str += jaccard.read()
+    return _render(html_str)
+
+
+def list_of_links_html(fname_helper: FileNameHelper, building_locally: bool):
+    base_path = fname_helper.base_html_path(building_locally)
+    _all_rates_path = fname_helper.all_rates_html_page_path(full_path=False)
+    links = [
+        f"""<li><a href="{base_path}/{_all_rates_path}"> A single rate/bandwidth table featuring every trigger line in all streams</a></li>"""
+    ]
+    if fname_helper.process != "hlt1":
+        _rate_table_split_by_stream = fname_helper.final_rate_table_all_lines_split_by_stream_path(
+            full_path=False)
+        _sim_matrices_path = fname_helper.sim_matrices_html_page_path(
+            full_path=False)
+        links += [
+            f"""<li><a href="{base_path}/{_rate_table_split_by_stream}"> Rate/bandwidth tables for each stream, with 1 row per trigger line</a></li>""",
+            f"""<li><a href="{base_path}/{_sim_matrices_path}"> Jaccard similarity and overlap matrices between streams</a></li>"""
+        ]
+
+    if fname_helper.process == "hlt2":
+        _rate_table_by_stream_by_wg = fname_helper.final_rate_table_all_lines_split_by_stream_by_wg_path(
+            full_path=False)
+        _extra_bar_charts_path = fname_helper.extra_bar_charts_html_page_path(
+            full_path=False)
+        _extra_sim_matrices_path = fname_helper.extra_sim_matrices_html_page_path(
+            full_path=False)
+        links += [
+            f"""<li><a href="{base_path}/{_rate_table_by_stream_by_wg}"> Rate/bandwidth tables for each stream, split also by WG, with 1 row per trigger line</a></li>""",
+            f"""<li><a href="{base_path}/{_extra_bar_charts_path}">Bar charts as below for DstData bandwidth</a></li>""",
+            f"""<li><a href="{base_path}/{_extra_sim_matrices_path}">Similarity and overlap matrices between WGs within each stream</a></li>""",
+        ]
+
+    if fname_helper.process != "hlt1":
+        _other_lines_path = fname_helper.other_lines_html_page_path(
+            full_path=False)
+        _line_descr_path = fname_helper.line_descr_path(full_path=False)
+        links += [
+            f"""<li><a href="{base_path}/{_other_lines_path}">List of lines in "Other" category</a></li>""",
+            f"""<li><a href="{base_path}/{_line_descr_path}"> PersistReco and ExtraOutput info for all lines in all streams</a></li>"""
+        ]
+
+    return "\n".join(links)
+
+
+def total_rate_and_bw(fname_helper: FileNameHelper):
+    streams_df = pd.read_csv(
+        fname_helper.final_rate_table_all_streams_path(ext="csv"))
+    return sum(streams_df['Rate (kHz)']), sum(
+        streams_df['Total Bandwidth (GB/s)'])
+
+
+def write_message(fname_helper: FileNameHelper,
+                  bw_info_by_line: dict[str, LineRateBWInfo]):
+    """Append to message.json for the BandwidthTestHandler to send info to Gitlab and Mattermost"""
+
+    high = {
+        'hlt1': 1e6,
+        'hlt2': 1000,
+        'spruce': 500
+    }[fname_helper.process]  # Hz
+    n_low_rate = len(
+        [info for info in bw_info_by_line.values() if info.rate == 0])
+    n_high_rate = len(
+        [info for info in bw_info_by_line.values() if info.rate > high])
+    tot_rate, tot_bandwidth = total_rate_and_bw(fname_helper)
+
+    # load up message.json
+    with open(fname_helper.message_path(), "r") as message:
+        info = json.load(message)
+
+    for k, v in {
+            "total_rate": tot_rate,
+            "total_bandwidth": tot_bandwidth,
+            "n_low_rate": n_low_rate,
+            "n_high_rate": n_high_rate
+    }.items():
+        info[fname_helper.process][fname_helper.stream_config][k] = v
+
+    with open(fname_helper.message_path(), "w") as f:
+        json.dump(info, f, indent=4)
+    return 0
+
+
+def make_html_for_single_test(process: str, stream_config: str,
+                              input_config_path: str,
+                              args: argparse.Namespace):
+    fname_helper = FileNameHelper(process, stream_config)
+
+    with open(fname_helper.stream_config_json_path(),
+              "r") as stream_config_json:
+        streams = list(json.load(stream_config_json).keys())
+
+    ### Make plots & tables
+    # Headline bar charts
+    if stream_config != "streamless":
+        headline_bar_charts(fname_helper)
+
+    if process == 'hlt2':
+        make_per_wg_bar_charts(fname_helper, streams)
+
+    df = pd.read_csv(
+        fname_helper.final_rate_table_all_lines_path("csv"), sep=',')
+    kHz_to_Hz = 1000
+    rate_bw_info_by_line = {
+        df['Line'][i]: LineRateBWInfo(
+            df['Rate (kHz)'][i] * kHz_to_Hz, df["Avg DstData Size (kB)"][i],
+            df["Avg Total Event Size (kB)"][i],
+            df["DstData Bandwidth (GB/s)"][i], df["Total Bandwidth (GB/s)"][i])
+        for i in range(len(df))
+    }
+
+    make_plots(rate_bw_info_by_line, fname_helper=fname_helper)
+
+    # Extra pages
+    write_html_page(
+        fname_helper.other_lines_html_page_path(full_path=True),
+        render_other_line_table(
+            process, list_of_other_lines(process, rate_bw_info_by_line)))
+
+    write_html_page(
+        fname_helper.all_rates_html_page_path(full_path=True),
+        render_all_lines_page(fname_helper, args.building_locally))
+
+    write_html_page(
+        fname_helper.sim_matrices_html_page_path(full_path=True),
+        render_sim_matrices_page(fname_helper))
+
+    write_html_page(
+        fname_helper.extra_bar_charts_html_page_path(full_path=True),
+        render_bar_charts(
+            fname_helper, streams, metrics=EXTRA_BAR_CHARTS.keys()))
+
+    write_html_page(
+        fname_helper.extra_sim_matrices_html_page_path(full_path=True),
+        render_extra_sim_matrices(fname_helper, streams))
+
+    # Main page
+    with open(fname_helper.index_html_page_path(full_path=True),
+              "w") as html_file:
+        html = render_single_test_page(process, stream_config,
+                                       input_config_path, streams, args)
+        html_file.write(html)
+
+    # Prepare messages to GitLab
+    write_message(fname_helper, rate_bw_info_by_line)
+    return
+
+
+def total_bw_to_disk_bar_chart(stream_configs: list[str]):
+
+    disk_process = "spruce"
+    DISK_TDR_BANDWIDTHS = TDR_BANDWIDTHS[disk_process]
+
+    bandwidths = {
+        "Current": {
+            PRETTY_STREAM_NAMES.get(stream_config, stream_config):
+            total_rate_and_bw(FileNameHelper(disk_process, stream_config))[1]
+            for stream_config in stream_configs
+        },
+        "TDR": {
+            PRETTY_STREAM_NAMES.get(stream_config, stream_config):
+            DISK_TDR_BANDWIDTHS[stream_config]['total']
+            for stream_config in stream_configs
+        }
+    }
+
+    bandwidths['Current']['Total'] = sum(bandwidths['Current'].values())
+    bandwidths['TDR']['Total'] = sum(bandwidths['TDR'].values())
+    print("Summary of bandwidths to disk:")
+    print(bandwidths)
+
+    _important_bar_chart_maker(
+        bandwidths, disk_process, is_to_total_to_disk_bar_chart=True)
+
+
+if __name__ == '__main__':
+    parser = argparse.ArgumentParser(description='make_bandwidth_test_page')
+    parser.add_argument(
+        '--per-test-info',
+        type=str,
+        nargs='+',
+        required=True,
+        help=
+        "List of strings, each being a colon-separated list corresponding to <process>:<stream_config>:<input_config_yaml_path>"
+    )
+    parser.add_argument(
+        '-s',
+        '--script-path',
+        type=str,
+        required=True,
+        help=
+        'Path to the top-level testing script that is running/calling this script.'
+    )
+    parser.add_argument(
+        '--building-locally',
+        action='store_true',
+        help=
+        'Makes links between pages work for building the pages locally rather than on the LHCbPR website.'
+    )
+    args = parser.parse_args()
+
+    processes_and_stream_configs = []
+    # Unpack args.per_test_info into process, stream_config, input_config
+    for per_test_info in args.per_test_info:
+        assert len(
+            per_test_info.split(':')
+        ) == 3, "per_test_info must be colon-separated list of <process>:<stream_config>:<input_config_yaml_path>"
+        process, stream_config, input_config = per_test_info.split(':')
+        assert process in ['hlt1', 'hlt2', 'spruce'
+                           ], "process must be one of 'hlt1', 'hlt2', 'spruce'"
+
+        make_html_for_single_test(process, stream_config, input_config, args)
+        processes_and_stream_configs.append((process, stream_config))
+
+    # Bar chart of total bandwidth to disk
+    expected_stream_configs_to_disk = KNOWN_STREAM_CONFIGS_BY_STAGE["spruce"]
+    to_disk_stream_configs = [
+        stream_config
+        for process, stream_config in processes_and_stream_configs
+        if process == 'spruce'
+    ]
+    make_total_bw_to_disk_bar_chart = sorted(
+        expected_stream_configs_to_disk) == sorted(to_disk_stream_configs)
+    if make_total_bw_to_disk_bar_chart:
+        total_bw_to_disk_bar_chart(to_disk_stream_configs)
+
+    # Top-level page
+    base_path = FileNameHelper.base_html_path(args.building_locally)
+    with open(FileNameHelper.top_level_index_html_path(), "w") as html_file:
+        html = render_top_level_page(
+            args.script_path,
+            base_path,
+            processes_and_stream_configs,
+            to_disk_bar_chart=make_total_bw_to_disk_bar_chart)
+        html_file.write(html)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/read_event_numbers.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/read_event_numbers.py
new file mode 100755
index 00000000000..ca1e97bd6f6
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/read_event_numbers.py
@@ -0,0 +1,196 @@
+###############################################################################
+# (c) Copyright 2022-2024 CERN for the benefit of the LHCb Collaboration      #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+import argparse
+import json
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, KNOWN_STREAM_CONFIGS
+from PyConf.control_flow import CompositeNode
+from PyConf.application import ApplicationOptions, configure_input, configure, default_raw_event, make_odin
+from PyConf.components import force_location
+from PyConf.Algorithms import createODIN, LHCb__UnpackRawEvent, EventNumberCollectAlg
+
+
+def _count_evts_mdf(filename):
+    """
+    This method scans an MDF file to count the number of events
+    It uses knowledge of the structure of the MDF to jump from event to event
+    """
+    with open(filename, 'rb') as f:
+        n = 0
+        while True:
+            # try to read event size
+            s = int.from_bytes(f.read(4), byteorder='little')
+            if s == 0: break  # end of file
+            # skip to next event
+            if len(f.read(s - 4)) != s - 4: break  # end of file, event was cut
+            # increase counter, the event was complete
+            n += 1
+    return n
+
+
+def _extract_nevts_root(filename):
+    import ROOT
+    with ROOT.TFile.Open(filename, "READ") as f:
+        tree = f.Get("Event")
+        return tree.GetEntriesFast()
+
+
+def _count_evts(ifiles, file_type, evt_max):
+    """
+        Count all events in a list of MDF/ROOT files
+
+        HACK
+        Dont know how to easily read the number of events in a .raw file,
+        Hack it for now - use evt_max (will only currently be .raw for spruce
+        nominal, which has a capped EVTMAX).
+        Once we can actually count these, remove evt_max as arg here.
+    """
+    if file_type == 'RAW':
+        return evt_max
+
+    if file_type == 'MDF':
+        count_method = _count_evts_mdf
+    else:
+        count_method = _extract_nevts_root
+    count = 0
+    for f in ifiles:
+        count += count_method(f)
+    return count
+
+
+def make_odin_for_spruce(stream):
+    """
+    Copied and adjusted to use stream from make_odin.
+    """
+    bank_type = "ODIN"
+
+    def output_transform(RawBankLocations):
+        return {"RawBankLocations": [RawBankLocations]}
+
+    odin_bank = LHCb__UnpackRawEvent(
+        name=f'UnpackRawEvent_ReadEventNumbers{bank_type}',
+        RawEventLocation=default_raw_event([bank_type], stream=stream),
+        BankTypes=[bank_type],
+        output_transform=output_transform,
+        outputs={
+            'RawBankLocations': force_location(f'/Event/RawBanks/{bank_type}')
+        }).RawBankLocations
+    return createODIN(RawBanks=odin_bank, name='Decode_ODIN').ODIN
+
+
+def _extract_evt_numbers(ifiles, file_type, stream=None, evt_max=-1):
+    """
+        Extract all event numbers saved to a single MDF/DST.
+    """
+    # configure input - the tags are arbitrary in this use case, but must be provided
+    options = ApplicationOptions(_enabled=False)
+    options.simulation = True
+    options.dddb_tag = "dddb-20171126"
+    options.conddb_tag = "sim-20171127-vc-md100"
+    options.geometry_version = "run3/2024.Q1.2-v00.00"
+    options.conditions_version = "master"
+    options.input_type = file_type
+    options.input_files = ifiles
+    options.evt_max = evt_max
+    config = configure_input(options)
+    # configure data flow
+
+    odin = make_odin_for_spruce(stream=stream) if stream else make_odin()
+    collector = EventNumberCollectAlg(
+        name="EventNumberCollectAlg",
+        ODINLocation=odin,
+        JSONFileName="EventNumbers.json")
+    cf_node = CompositeNode('TopAlg', [odin, collector])
+    config.update(configure(options, cf_node))
+    # run the application counting events
+    from Gaudi.Main import gaudimain
+    gaudimain().run(False)
+    # get back the count from the json file
+    data = json.load(open("EventNumbers.json"))
+    return data
+
+
+def main():
+    """
+    For a given stream's MDF/DST output, finds all event_numbers and saves them in a json file for later use.
+    Useful for similarity between streams later.
+    """
+    parser = argparse.ArgumentParser(description=main.__doc__)
+    subparsers = parser.add_subparsers(help='Mode of execution', dest='mode')
+    event_numbers_parser = subparsers.add_parser("store_output_event_numbers")
+    event_numbers_parser.add_argument(
+        '-s', '--stream', type=str, required=True, help='Name of the stream')
+
+    rate_denom_parser = subparsers.add_parser("count_input_events")
+    rate_denom_parser.add_argument(
+        '-n',
+        '--evt-max',
+        required=True,
+        type=lambda x: int(round(float(x))),
+        help='maximum nb of events to process per job')
+    for sp in [event_numbers_parser, rate_denom_parser]:
+        sp.add_argument(
+            '-p',
+            '--process',
+            type=str,
+            required=True,
+            choices=['hlt1', 'hlt2', 'spruce'])
+        sp.add_argument(
+            '-sc',
+            '--stream-config',
+            type=str,
+            required=True,
+            choices=KNOWN_STREAM_CONFIGS,
+            help='Name of the stream config')
+        sp.add_argument(
+            '--file-type', choices=("ROOT", "MDF", "RAW"), required=True)
+
+    args = parser.parse_args()
+
+    fname_helper = FileNameHelper(args.process, args.stream_config)
+    if args.mode == "store_output_event_numbers":
+        file_ext = fname_helper.input_type_to_file_ext(args.file_type)
+        ifile = fname_helper.mdfdst_fname_for_reading(
+            args.stream, ext=file_ext)
+        event_numbers = _extract_evt_numbers(
+            ifiles=[ifile],
+            file_type=args.file_type,
+            stream=args.stream if args.process == "spruce" else None)
+        ofile = fname_helper.event_no_fname(args.stream)
+        with open(ofile, 'w') as f:
+            json.dump({args.stream: event_numbers}, f)
+        print(
+            f"Found {len(event_numbers)} event numbers for {args.stream} stream. Saved list to {ofile}."
+        )
+
+    else:
+        # Load up the filenames
+        with open(fname_helper.input_info_json()) as f:
+            input_info = json.load(f)
+
+        # Wont ever be sprucing output as this is for working out how many events in *input* files
+        n_evts_in_file = _count_evts(
+            input_info["fnames"],
+            file_type=args.file_type,
+            evt_max=args.evt_max)
+        rate_denom = min(n_evts_in_file,
+                         args.evt_max) if args.evt_max > 0 else n_evts_in_file
+
+        output_info = input_info
+        output_info["n_evts"] = rate_denom
+        with open(fname_helper.input_info_json(), 'w') as f:
+            json.dump(output_info, f)
+        print(
+            f"Found {n_evts_in_file} events in input files (max of {args.evt_max}), therefore n_evts in denominator of rates: {rate_denom}"
+        )
+
+
+if __name__ == "__main__":
+    main()
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/run_bandwidth_test_jobs.py b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/run_bandwidth_test_jobs.py
new file mode 100644
index 00000000000..14b7f6a3075
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/tests/bandwidth/run_bandwidth_test_jobs.py
@@ -0,0 +1,267 @@
+#!/usr/bin/env python
+###############################################################################
+# (c) Copyright 2022 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+""" Launch one Moore job to produce MDF/DST output for bandwidth measurement.
+
+    The corresponding option files are under:
+    $HLT2CONFROOT/tests/options/bandwidth/
+
+    Runs exactly one job
+"""
+
+from __future__ import print_function, division
+import argparse
+import logging
+import subprocess
+import os
+import tempfile
+import atexit
+import shutil
+import json
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper, parse_yaml
+from datetime import datetime
+
+# prefer XDG_RUNTIME_DIR which should be on tmpfs
+FALLBACK_CACHE_DIR = os.getenv('XDG_RUNTIME_DIR', tempfile.gettempdir())
+
+# Default cache dir is the current working directory as this is most convenient for the machine
+# that the test runs on periodically. It assumes the working directory is not cleaned up often,
+# and so the files remain available for subsequent jobs.
+DEFAULT_CACHE_DIR = '.'
+
+
+def is_remote(url):
+    return url.startswith('mdf:root:') or url.startswith('root:')
+
+
+def dump_fnames(process, stream_config, filenames):
+    fname_helper = FileNameHelper(process, stream_config)
+    ofile = fname_helper.input_info_json()
+    with open(ofile, 'w') as f:
+        json.dump({"fnames": filenames}, f)
+
+
+def run_gaudi_job(args, config, job_input):
+    # Build command line
+    extra_options = [
+        f"n_threads = {args.threads}", f"n_event_slots = {args.evtSlots}",
+        f"evt_max = {args.evt_max}",
+        f"input_raw_format = {config['input_raw_format']}",
+        f"input_files = {job_input}"
+    ]
+
+    if "testfiledb_key" in config.keys():
+        extra_options += [
+            f"set_conds_from_testfiledb('{config['testfiledb_key']}')",
+            f"input_type = '{config['input_type']}'"
+        ]
+        # The code below allows to overwrite the dddb_tag and conddb_tag from the
+        # test file database when testfiledb_key is used. This option was added to allow
+        # hlt2 lines that rely on a newer particle table version to work with older simulation
+        # used in the bendwidth tests. See PRConfig!435 and Moore!3533 for more details.
+        # This workaround is temporary and can be removed, once newer simulation samples,
+        # based on dddb-20240427 directly, are available for these tests.
+        for opt in ['conddb_tag', 'dddb_tag']:
+            if opt in config.keys():
+                extra_options += [f"{opt} = '{config[opt]}'"]
+    else:
+        extra_options += [f"simulation = {config['simulation']}"] + [
+            f"{opt} = '{config[opt]}'"
+            for opt in filter(lambda x: x in config.keys(), [
+                'input_type', 'data_type', 'conddb_tag', 'dddb_tag',
+                'conditions_version', 'geometry_version'
+            ])
+        ]
+
+    if args.use_manifest:
+        extra_options += [
+            f'input_manifest_file = \'{config["input_manifest_file"]}\''
+        ]
+
+    extra_options = [f"options.{opt_str}" for opt_str in extra_options]
+    extra_options.insert(0, "from Moore import options")
+
+    if args.download_input_files and args.process != "spruce":
+        extra_options += [
+            "options.event_store = 'EvtStoreSvc'; options.use_iosvc = True"
+        ]
+
+    cmd = ['gaudirun.py', '--option', "\n".join(extra_options)
+           ] + [os.path.expandvars(x) for x in args.options]
+    cmd.insert(1, '-T')
+
+    # Log command
+    logging.info("Launching bandwidth job with cmd: {}".format(" ".join(
+        map(repr, cmd))))
+
+    # run the test
+    subprocess.run(cmd)
+
+
+if __name__ == '__main__':
+    parser = argparse.ArgumentParser(description=__doc__.splitlines()[0])
+    parser.add_argument('options', nargs='+', help='Gaudi options files.')
+    parser.add_argument(
+        '-c',
+        '--config',
+        type=str,
+        required=True,
+        help='Path to yaml config file defining the input.')
+    parser.add_argument(
+        '-t',
+        '--threads',
+        type=int,
+        default=1,
+        help='Number of threads per job (defaults to # logical cpus')
+    parser.add_argument(
+        '-e',
+        '--evtSlots',
+        type=int,
+        default=None,
+        help='Number of event slots per job (defaults to max(1.2 * # threads, '
+        '1 + # threads)')
+    parser.add_argument(
+        '-n',
+        '--evt-max',
+        default=100,
+        type=lambda x: int(round(float(x))),
+        help='maximum nb of events to process per job')
+    parser.add_argument(
+        '-a',
+        '--avg_evt_size',
+        type=int,
+        help='average event size in input file in kB',
+        required=True)
+    parser.add_argument(
+        '--debug', action='store_true', help='Debugging output')
+    parser.add_argument(
+        '-d',
+        '--download-input-files',
+        action='store_true',
+        help=
+        "Download files to local disk before running Moore. Achieves big speedup (5x) in Moore, but only worth it if the downloading is fast (probably only true if you're at CERN.)"
+    )
+    parser.add_argument(
+        '--cache-dir',
+        default=DEFAULT_CACHE_DIR,
+        help='Comma separated paths to directories, one per job, where the '
+        'input files will be cached (default is hostname dependent or '
+        '$XDG_RUNTIME_DIR).')
+    parser.add_argument(
+        '--digi',
+        default=False,
+        action='store_true',
+        help='Flag to download digi files as opposed to the default mdf files')
+    parser.add_argument(
+        '-um',
+        '--use-manifest',
+        action='store_true',
+        help=
+        "Flag to access and include config[input_manifest_file] as an extra option in the job."
+    )
+    parser.add_argument(
+        '-p',
+        '--process',
+        type=str,
+        help='Compute for Hlt1, Hlt2 or Sprucing lines',
+        choices=['hlt1', 'hlt2', 'spruce'],
+        required=True)
+    parser.add_argument('-sc', '--stream-config', type=str, required=True)
+    args = parser.parse_args()
+
+    logging.basicConfig(
+        format='%(levelname)-7s %(message)s',
+        level=(logging.DEBUG if args.debug else logging.INFO))
+
+    if args.evtSlots is None:
+        args.evtSlots = max(int(round(1.2 * args.threads)), 1 + args.threads)
+
+    config = parse_yaml(args.config)
+
+    if args.use_manifest and "input_manifest_file" not in config.keys():
+        raise KeyError(
+            f'{args.config} does not provide "input_manifest_file" but --use-manifest is in use.'
+        )
+
+    # Always use config['input_files'] for inputs if available.
+    # use config['testfiledb_key'] if it exists
+    if "testfiledb_key" in config.keys():
+        from PRConfig.TestFileDB import test_file_db
+        tfdb_entry = test_file_db[config['testfiledb_key']]
+        qualifiers = tfdb_entry.qualifiers
+        if "input_files" not in config:
+            config["input_files"] = tfdb_entry.filenames
+        if "input_type" not in config:
+            file_format = qualifiers['Format']
+            config["input_type"] = 'ROOT' if file_format != 'MDF' else 'RAW'
+        if "data_type" not in config:
+            config["data_type"] = qualifiers['DataType']
+        if "simulation" not in config:
+            config["simulation"] = qualifiers['Simulation']
+        if "dddb_tag" not in config:
+            config["dddb_tag"] = qualifiers['DDDB']
+        if "conddb_tag" not in config:
+            config["conddb_tag"] = qualifiers['CondDB']
+        if "GeometryVersion" in qualifiers and "geometry_version" not in config:
+            config["geometry_version"] = qualifiers["GeometryVersion"]
+        if "ConditionsVersion" in qualifiers and "conditions_version" not in config:
+            config["conditions_version"] = qualifiers["ConditionsVersion"]
+    if "input_files" in config.keys():
+        inputs_fns = config["input_files"]
+    else:
+        raise KeyError(
+            f'{args.config} does not provide either the "testfiledb_key" or "input_files".'
+        )
+    job_inputs = inputs_fns
+
+    if args.download_input_files:
+
+        # Set up local directories where inputs are cached
+        if not os.path.isdir(args.cache_dir):
+            fallback_dir = tempfile.mkdtemp(
+                prefix='bandwidth-', dir=FALLBACK_CACHE_DIR)
+            logging.warning(
+                'Default cache dir {!r} does not exist, using {}'.format(
+                    args.cache_dir, fallback_dir))
+            args.cache_dir = fallback_dir
+            # if we use the fallback directory, clean up after ourselves
+            atexit.register(shutil.rmtree, fallback_dir)
+
+        # Now download files
+        if all(is_remote(url) for url in job_inputs):
+            from Moore.qmtest.context import download_mdf_inputs_locally, download_digi_inputs_locally
+            # download_inputs_locally only downloads if files
+            # are not already available locally on the machine
+            before_copy = datetime.now()
+            logging.info(
+                f'Downloading inputs for bandwidth job to {args.cache_dir}')
+            logging.info(
+                f'There are {len(job_inputs)} input files: [{job_inputs[0]} ' +
+                ']' if len(job_inputs) < 2 else f'{job_inputs[1]}, ... ]')
+            kB_to_GB = 1e3
+            download_inputs_locally = download_digi_inputs_locally if args.digi else download_mdf_inputs_locally
+            job_inputs = download_inputs_locally(
+                job_inputs,
+                args.cache_dir,
+                max_size=args.avg_evt_size * kB_to_GB * args.evt_max)
+            logging.info(
+                f"Finished file downloads. This took: {datetime.now() - before_copy}"
+            )
+        elif any(is_remote(url) for url in job_inputs):
+            parser.error('inputs must either be all xrootd or all local')
+        else:
+            pass  # They're all local so don't worry about it...
+
+    # Dump the input file names so we can work out the rate denominator afterwards
+    # Dump local file names that have been downloaded?
+    dump_fnames(args.process, args.stream_config, job_inputs)
+
+    run_gaudi_job(args, config, job_inputs)
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/hlt2_bandwidth_production_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/hlt2_bandwidth_production_streams.py
index 3bc0f533e02..15cbb1a3471 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/hlt2_bandwidth_production_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/hlt2_bandwidth_production_streams.py
@@ -15,7 +15,7 @@ from RecoConf.global_tools import stateProvider_with_simplified_geom, trackMaste
 from DDDB.CheckDD4Hep import UseDD4Hep
 from Hlt2Conf.settings.hlt2_pp_2024 import make_streams
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 
 fname_helper = FileNameHelper(process="hlt2", stream_config="production")
 fname_helper.make_tmp_dirs()
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_full_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_full_streams.py
index 00d1514a787..bf4cc5e7ba1 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_full_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_full_streams.py
@@ -25,7 +25,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_excl_spruce_p
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_hlt2calib_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_hlt2calib_streams.py
index 63908a2d22f..c0b01428a9b 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_hlt2calib_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_hlt2calib_streams.py
@@ -22,7 +22,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_hlt2calib_spr
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_lumi_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_lumi_streams.py
index be840625e51..f6148c11a97 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_lumi_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_lumi_streams.py
@@ -22,7 +22,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_lumi_spruce_p
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_no_bias_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_no_bias_streams.py
index a8fbec2ddc5..489a8ef6ff4 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_no_bias_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_no_bias_streams.py
@@ -22,7 +22,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_nobias_spruce
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
index 5a640a664c6..5ba40c04b33 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
@@ -22,7 +22,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_turbo_spruce_
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turcal_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turcal_streams.py
index e6873ee55ca..d4a9a8f3079 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turcal_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turcal_streams.py
@@ -23,7 +23,7 @@ from Hlt2Conf.sprucing_settings.Sprucing_production_pp import make_turcal_spruce
 
 import logging
 import json
-from PRConfig.bandwidth_helpers import FileNameHelper
+from Hlt2Conf.tests.bandwidth.bandwidth_helpers import FileNameHelper
 log = logging.getLogger()
 
 options.input_process = 'Hlt2'
-- 
GitLab


From 3386a692600502268190691a690e2ab0c92818fe Mon Sep 17 00:00:00 2001
From: Shunan Zhang <shunan.zhang@cern.ch>
Date: Fri, 13 Dec 2024 10:31:05 +0100
Subject: [PATCH 03/31] B2OC: Fixes for EoY24 re-Sprucing

---
 .../python/Hlt2Conf/lines/b_to_open_charm/b_to_dh.py     | 2 +-
 .../python/Hlt2Conf/lines/b_to_open_charm/spruce_b2oc.py | 9 ++++++++-
 2 files changed, 9 insertions(+), 2 deletions(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/b_to_dh.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/b_to_dh.py
index 57e50d61bd4..8f313e890bd 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/b_to_dh.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/b_to_dh.py
@@ -640,7 +640,7 @@ def make_BuToD0K_D0ToKsLLHH(process):
     elif process == 'spruce':
         kaon = basic_builder.make_tight_kaons()
         d = d_builder.make_dzero_to_kshh(
-            k_shorts=basic_builder.make_ks_DD(),
+            k_shorts=basic_builder.make_ks_LL(),
             pi_pidk_max=20,
             k_pidk_min=-10,
             pi_ipchi2_min=4,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/spruce_b2oc.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/spruce_b2oc.py
index 09ea923cac4..4ff32505f5f 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/spruce_b2oc.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/spruce_b2oc.py
@@ -189,7 +189,8 @@ all_lines = [
     'BdToDmK_DmToPimPimKp',
     #'BdToDsstmK_DsstmToDsmGamma_DsmToHHH',
     'BdToDsstmPi_DsstmToDsmGamma_DsmToHHH',
-
+    'BuToD0Pi_D0ToHH',
+    'BuToD0K_D0ToHH',
     #'BuToD0Pi_D0ToKsLLPi0Resolved',
     #'BuToD0Pi_D0ToKsDDPi0Resolved',
     #'BuToD0Pi_D0ToKsLLPi0Merged',
@@ -210,6 +211,8 @@ all_lines = [
     'BuToD0Pi_D0ToKsDDHH',
     'BuToD0K_D0ToKsLLHH',
     'BuToD0K_D0ToKsDDHH',
+    'BuToD0Pi_D0ToHHHH',
+    'BuToD0K_D0ToHHHH',
 
     #'BuToD0Pi_D0ToKsLLHHPi0Resolved',
     #'BuToD0Pi_D0ToKsDDHHPi0Resolved',
@@ -948,10 +951,14 @@ extra_config = {
         # book line here if FT is not required but PV-unbiasing is required.
     ],
     'isolation': [
+        'BuToD0Pi_D0ToHH',
+        'BuToD0K_D0ToHH',
         'BuToD0Pi_D0ToKsLLHH',
         'BuToD0Pi_D0ToKsDDHH',
         'BuToD0K_D0ToKsLLHH',
         'BuToD0K_D0ToKsDDHH',
+        'BuToD0Pi_D0ToHHHH',
+        'BuToD0K_D0ToHHHH',
     ]
 }
 
-- 
GitLab


From 4b73a029a95928d74205c54b3b2d06b62722a532 Mon Sep 17 00:00:00 2001
From: Software for LHCb <software.lhcb@cern.ch>
Date: Sat, 14 Dec 2024 10:31:32 +0100
Subject: [PATCH 04/31] Update of allen_mdf_write_for_hlt2 following Allen!1838

---
 Hlt/Hlt2Conf/tests/qmtest/allen_mdf_write_for_hlt2.qmt | 4 ++--
 1 file changed, 2 insertions(+), 2 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/qmtest/allen_mdf_write_for_hlt2.qmt b/Hlt/Hlt2Conf/tests/qmtest/allen_mdf_write_for_hlt2.qmt
index 4ffe31687c1..9ed8f96005a 100644
--- a/Hlt/Hlt2Conf/tests/qmtest/allen_mdf_write_for_hlt2.qmt
+++ b/Hlt/Hlt2Conf/tests/qmtest/allen_mdf_write_for_hlt2.qmt
@@ -99,8 +99,8 @@ hlt1_smog2_matches = re.findall(r"Selected by Hlt1.*SMOG2.*Decision", stdout)
 
 if len(hlt1_phys_matches) != 79:
 	causes.append("Wrong number of HLT1 PHYS lines, 79 lines expected but got {}, check instructions and update settings if needed".format(len(hlt1_phys_matches)))
-if len(hlt1_nonphys_matches) != 18:
-	causes.append("Wrong number of HLT1 NONPHYS lines, 18 lines expected but got {}, check instructions and update settings if needed".format(len(hlt1_nonphys_matches)))
+if len(hlt1_nonphys_matches) != 19:
+	causes.append("Wrong number of HLT1 NONPHYS lines, 19 lines expected but got {}, check instructions and update settings if needed".format(len(hlt1_nonphys_matches)))
 if len(hlt1_smog2_matches) !=16:
         causes.append("Wrong number of HLT1 SMOG2 lines, 16 lines expected but got {}, check instructions and  update settings if needed".format(len(hlt1_smog2_matches)))
 </text></argument>
-- 
GitLab


From bc35a3348e1330a2da78722e3d62bef5c2478bb5 Mon Sep 17 00:00:00 2001
From: Pawel Kopciewicz <pawel.kopciewicz@cern.ch>
Date: Sat, 14 Dec 2024 10:32:17 +0100
Subject: [PATCH 05/31] Adding HLT2 settings for TAE + lumi

---
 Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE.py      | 33 ++++++++++++++
 .../options/hlt2_pp_2024_TAE_veloSP.py        | 35 +++++++++++++++
 .../Hlt2Conf/settings/hlt2_pp_2024_TAE.py     | 45 +++++++++++++++++++
 3 files changed, 113 insertions(+)
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE.py
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE_veloSP.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_pp_2024_TAE.py

diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE.py b/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE.py
new file mode 100644
index 00000000000..87a53b42493
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE.py
@@ -0,0 +1,33 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore import options, run_moore
+from RecoConf.reconstruction_objects import reconstruction
+from RecoConf.global_tools import stateProvider_with_simplified_geom, trackMasterExtrapolator_with_simplified_geom
+from Hlt2Conf.settings.hlt2_pp_2024_TAE import make_streams
+
+options.lines_maker = make_streams
+
+# This needs to happen before the public tools are instantiated,
+# which means we cannot put it inside make_streams().
+from PyConf.Tools import TrackMasterExtrapolator, TrackMasterFitter
+TrackMasterExtrapolator.global_bind(
+    ApplyMultScattCorr=False,
+    ApplyEnergyLossCorr=False,
+    ApplyElectronEnergyLossCorr=False)
+TrackMasterFitter.global_bind(ApplyMaterialCorrections=False)
+
+public_tools = [
+    trackMasterExtrapolator_with_simplified_geom(),
+    stateProvider_with_simplified_geom()
+]
+
+with reconstruction.bind(from_file=False):
+    config = run_moore(options, public_tools=public_tools)
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE_veloSP.py b/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE_veloSP.py
new file mode 100644
index 00000000000..782ca4ef261
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_TAE_veloSP.py
@@ -0,0 +1,35 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore import options, run_moore
+from RecoConf.reconstruction_objects import reconstruction
+from RecoConf.decoders import default_VeloCluster_source
+from RecoConf.global_tools import stateProvider_with_simplified_geom, trackMasterExtrapolator_with_simplified_geom
+from Hlt2Conf.settings.hlt2_pp_2024_TAE import make_streams
+
+options.lines_maker = make_streams
+
+# This needs to happen before the public tools are instantiated,
+# which means we cannot put it inside make_streams().
+from PyConf.Tools import TrackMasterExtrapolator, TrackMasterFitter
+TrackMasterExtrapolator.global_bind(
+    ApplyMultScattCorr=False,
+    ApplyEnergyLossCorr=False,
+    ApplyElectronEnergyLossCorr=False)
+TrackMasterFitter.global_bind(ApplyMaterialCorrections=False)
+
+public_tools = [
+    trackMasterExtrapolator_with_simplified_geom(),
+    stateProvider_with_simplified_geom()
+]
+
+with reconstruction.bind(from_file=False),\
+    default_VeloCluster_source.bind(bank_type="VP"):
+    config = run_moore(options, public_tools=public_tools)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_pp_2024_TAE.py b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_pp_2024_TAE.py
new file mode 100644
index 00000000000..53d090bd24e
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_pp_2024_TAE.py
@@ -0,0 +1,45 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+"""Options for Muon TAE and lumi lines only
+"""
+from Hlt2Conf.lines.luminosity import (
+    lumi_nanofy_line,
+    calibration_lines as lumi_calibration_lines,
+)
+from Hlt2Conf.lines.calibration.calibration import hlt2_tae_line
+
+from Moore.streams import Stream, Streams
+
+from typing import Callable
+
+
+def _make_streams() -> Streams:
+    """Defines which trigger lines are run, which stream they belong to, and if the stream should persist raw banks.
+    """
+    full_lines = [
+        hlt2_tae_line(prescale=1),
+        lumi_nanofy_line(),
+    ]
+
+    lumi_lines = [b() for b in lumi_calibration_lines.values()]
+
+    return Streams(streams=[
+        Stream("hlt2calib", lines=full_lines, detectors=[]),
+        Stream("lumi", lines=lumi_lines, detectors=[]),
+    ])
+
+
+def make_streams(real_make_streams: Callable = _make_streams) -> Streams:
+    """Wrapper around the stream maker used to apply the necessary reconstruction binds.
+    """
+    from .hlt2_binds import config_pp_2024
+    with config_pp_2024():
+        return real_make_streams()
-- 
GitLab


From e853a1b456565e39deb1fd32e8cda3a2064c8ca9 Mon Sep 17 00:00:00 2001
From: Pawel Kopciewicz <pawel.kopciewicz@cern.ch>
Date: Sat, 14 Dec 2024 10:34:05 +0100
Subject: [PATCH 06/31] Adding settings for Hlt2 PbPb default 2024 with beamgas
 prescale=1

---
 Hlt/Hlt2Conf/options/hlt2_PbPb_bgi_2024.py    |  35 ++++++
 .../Hlt2Conf/settings/hlt2_PbPb_bgi_2024.py   | 100 ++++++++++++++++++
 2 files changed, 135 insertions(+)
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_PbPb_bgi_2024.py
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_bgi_2024.py

diff --git a/Hlt/Hlt2Conf/options/hlt2_PbPb_bgi_2024.py b/Hlt/Hlt2Conf/options/hlt2_PbPb_bgi_2024.py
new file mode 100644
index 00000000000..7435ec5ad25
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_PbPb_bgi_2024.py
@@ -0,0 +1,35 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore import options, run_moore
+from RecoConf.reconstruction_objects import reconstruction
+from Hlt2Conf.settings.hlt2_PbPb_bgi_2024 import make_streams
+from RecoConf.global_tools import stateProvider_with_simplified_geom, trackMasterExtrapolator_with_simplified_geom
+from DDDB.CheckDD4Hep import UseDD4Hep
+
+options.lines_maker = make_streams
+
+if UseDD4Hep:
+    # This needs to happen before the public tools are instantiated,
+    # which means we cannot put it inside make_streams().
+    from PyConf.Tools import TrackMasterExtrapolator, TrackMasterFitter
+    TrackMasterExtrapolator.global_bind(
+        ApplyMultScattCorr=False,
+        ApplyEnergyLossCorr=False,
+        ApplyElectronEnergyLossCorr=False)
+    TrackMasterFitter.global_bind(ApplyMaterialCorrections=False)
+
+public_tools = [
+    trackMasterExtrapolator_with_simplified_geom(),
+    stateProvider_with_simplified_geom()
+]
+
+with reconstruction.bind(from_file=False):
+    config = run_moore(options, public_tools=public_tools)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_bgi_2024.py b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_bgi_2024.py
new file mode 100644
index 00000000000..dcc0cd2d6d9
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/settings/hlt2_PbPb_bgi_2024.py
@@ -0,0 +1,100 @@
+###############################################################################
+# (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration           #
+#                                                                             #
+# This software is distributed under the terms of the GNU General Public      #
+# Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".   #
+#                                                                             #
+# In applying this licence, CERN does not waive the privileges and immunities #
+# granted to it by virtue of its status as an Intergovernmental Organization  #
+# or submit itself to any jurisdiction.                                       #
+###############################################################################
+from Moore.streams import Stream, Streams, DETECTORS
+from Hlt2Conf.settings.hlt2_binds import config_PbPb_2024
+from .hlt2_pp_2024 import _make_lines
+
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_charm import all_lines as charm_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_muons import all_lines as muon_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_omegas import all_lines as omega_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_xis import all_lines as xi_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_generic import all_lines as generic_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ionraw_lines
+from Hlt2Conf.lines.iftPbPb.hlt2_iftPbPb import ion_lines
+
+#Tracking line PbAr (PbPb is done offline)
+from Hlt2Conf.lines.iftPbPb.SMOG2_Jpsi_trackeff import all_lines as trackingeff_lines
+from Hlt2Conf.lines.iftPbPb.SMOG2_Ks_trackeff import all_lines as trackingeff_lines_Ks
+
+#pidline PbAr (PbPb is done offline)
+from Hlt2Conf.lines.iftPbPb.hlt2_ift_smog2Pb_ChargedPID import all_lines as chargedPid
+from Hlt2Conf.lines.iftPbPb.SMOG2_JpsiToMuMuTagged import all_lines as jpsiPID
+
+#DQ monitoring lines
+from Hlt2Conf.lines.monitoring.data_quality_PbPb import all_lines as monitoring_lines
+
+#hlt2calib
+from Hlt2Conf.lines.calibration import all_lines as hlt2_calibration_lines
+from Hlt2Conf.lines.calibration.calibration import hlt2_beamgas_line
+
+from Hlt2Conf.lines.luminosity import (
+    lumi_nanofy_line,
+    calibration_lines as lumi_calibration_lines,
+)
+from Hlt2Conf.lines.nobias.nobias_PbPb import all_lines as hlt2_no_bias_lines
+from Hlt2Conf.settings.hlt2_PbPb_default import _make_lines_and_require_gec
+
+all_lines_ionraw = {}
+all_lines_ionraw.update(ionraw_lines)
+
+all_lines_ion = {}
+all_lines_ion.update(ion_lines)
+all_lines_ion.update(charm_lines)
+all_lines_ion.update(muon_lines)
+all_lines_ion.update(omega_lines)
+all_lines_ion.update(xi_lines)
+all_lines_ion.update(generic_lines)
+#calib lines
+all_lines_ion.update(trackingeff_lines)
+all_lines_ion.update(trackingeff_lines_Ks)
+all_lines_ion.update(chargedPid)
+all_lines_ion.update(jpsiPID)
+
+
+def _make_streams():
+    ion_lines = _make_lines_and_require_gec(
+        all_lines_ion) + _make_lines_and_require_gec(monitoring_lines)
+
+    ionraw_lines = _make_lines(all_lines_ionraw)
+
+    lumi_nano_line = lumi_nanofy_line()
+
+    # Apply custom prescale to Hlt2Calib_BeamGas Hlt2Calib line
+    del hlt2_calibration_lines['Hlt2Calib_BeamGas']
+    hlt2calib_lines = _make_lines(hlt2_calibration_lines) + [
+        lumi_nano_line, hlt2_beamgas_line(prescale=1)
+    ]
+
+    lumi_lines = _make_lines(lumi_calibration_lines)
+
+    no_bias_lines = _make_lines(hlt2_no_bias_lines) + [
+        lumi_nano_line,
+        next((l for l in lumi_lines if l.name == "Hlt2LumiCounters")),
+    ]
+
+    return Streams(streams=[
+        Stream("ion", lines=[lumi_nano_line] + ion_lines, detectors=[]),
+        Stream(
+            "ionraw",
+            lines=[lumi_nano_line] + ionraw_lines,
+            detectors=DETECTORS),
+        Stream("hlt2calib", lines=hlt2calib_lines, detectors=[]),
+        Stream("lumi", lines=lumi_lines, detectors=[]),
+        Stream("no_bias", lines=no_bias_lines, detectors=[]),
+    ])
+
+
+from typing import Callable
+
+
+def make_streams(real_make_streams: Callable = _make_streams) -> Streams:
+    with config_PbPb_2024():
+        return real_make_streams()
-- 
GitLab


From 05fdf558640ade577f5979369992b58ac4d99fb5 Mon Sep 17 00:00:00 2001
From: Miroslav Saur <miroslav.saur@cern.ch>
Date: Sat, 14 Dec 2024 10:55:51 +0100
Subject: [PATCH 07/31] Merge branch 'msaur_disable_VP_clustering_test' for
 `2024-patches`

---
 Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring.qmt       | 8 ++++++++
 .../tests/qmtest/VP_cluster_monitoring_baseline.qmt       | 8 ++++++++
 .../tests/qmtest/VP_cluster_monitoring_retina.qmt         | 8 ++++++++
 .../VP_cluster_monitoring_baseline_plots.qmt              | 8 ++++++++
 ...luster_monitoring_comparison_baseline_retina_plots.qmt | 8 ++++++++
 .../VP_cluster_monitoring_retina_plots.qmt                | 8 ++++++++
 6 files changed, 48 insertions(+)

diff --git a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring.qmt b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring.qmt
index 9a8dac77253..58724b19305 100644
--- a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring.qmt
+++ b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring.qmt
@@ -34,4 +34,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
diff --git a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_baseline.qmt b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_baseline.qmt
index 4a89fdb77cd..3078720367f 100644
--- a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_baseline.qmt
+++ b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_baseline.qmt
@@ -34,4 +34,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
diff --git a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_retina.qmt b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_retina.qmt
index f12489a2235..dcf4b315444 100644
--- a/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_retina.qmt
+++ b/Hlt/RecoConf/tests/qmtest/VP_cluster_monitoring_retina.qmt
@@ -34,4 +34,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
diff --git a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_baseline_plots.qmt b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_baseline_plots.qmt
index dceab0114df..cc4d20916f6 100644
--- a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_baseline_plots.qmt
+++ b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_baseline_plots.qmt
@@ -38,4 +38,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
diff --git a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_comparison_baseline_retina_plots.qmt b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_comparison_baseline_retina_plots.qmt
index 1fb464d4c4c..b64bbb67ad1 100644
--- a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_comparison_baseline_retina_plots.qmt
+++ b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_comparison_baseline_retina_plots.qmt
@@ -43,4 +43,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
diff --git a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_retina_plots.qmt b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_retina_plots.qmt
index b2d7ae514ce..5a3400e02f9 100644
--- a/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_retina_plots.qmt
+++ b/Hlt/RecoConf/tests/qmtest/performance.qms/VP_cluster_monitoring_retina_plots.qmt
@@ -38,4 +38,12 @@ countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
 <argument name="unsupported_platforms"><set>
   <text>clang.*-dbg</text>
 </set></argument>
+
+<!--
+2024/11/27: Disabled due to a problem with the monitoring code, see lhcb/Moore#880
+-->
+<argument name="unsupported_platforms"><set>
+  <text>.*</text>
+</set></argument>
+
 </extension>
-- 
GitLab


From d8df07bae82f8fdf48fc0bbabd6e6a9a29f03060 Mon Sep 17 00:00:00 2001
From: Rowina Caspary <rowina.caspary@cern.ch>
Date: Mon, 16 Dec 2024 07:06:46 +0100
Subject: [PATCH 08/31] add additional input parameters to
 MuonProbeToLongMatcher for Rec!4150

---
 .../lines/iftPbPb/SMOG2_Jpsi_trackeff.py      |  5 ++-
 .../Hlt2Conf/lines/monitoring/calibmon.py     | 33 ++++++++++++++-----
 .../lines/trackeff/DiMuonTrackEfficiency.py   |  5 ++-
 .../lines/trackeff/SMOG2_Jpsi_trackeff.py     |  5 ++-
 .../lines/trackeff/ZTrackEfficiency.py        |  5 ++-
 5 files changed, 41 insertions(+), 12 deletions(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
index c7395c4a24a..9048961096b 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
@@ -29,6 +29,7 @@ from Hlt2Conf.algorithms_thor import ParticleFilter, ParticleCombiner
 from Hlt2Conf.lines.ift.builders.smog2_builders import sv_in_smog2, bpv_in_smog2
 from Hlt2Conf.lines.trackeff.DiMuonTrackEfficiency import make_LongFilter
 from RecoConf.event_filters import require_gec
+from RecoConf.muonid import make_muon_hits
 
 all_lines = {}
 
@@ -192,7 +193,9 @@ def create_MatchLine(name, prescale, persistreco, probe_charge, get_cuts,
         checkVP=get_cuts['checkVP'],
         checkFT=get_cuts['checkFT'],
         checkUT=get_cuts['checkUT'],
-        checkMuon=get_cuts['checkMuon'])
+        checkMuon=get_cuts['checkMuon'],
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True)
     JPsi_matched = matcher.MatchedComposites
     long_matched = matcher.MatchedLongTracks
     long_save = make_LongFilter(long_matched, probe_charge)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/monitoring/calibmon.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/monitoring/calibmon.py
index 11d8c2c80fa..8bdf00ab7d5 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/monitoring/calibmon.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/monitoring/calibmon.py
@@ -67,6 +67,7 @@ from Hlt2Conf.standard_particles import (
 from Moore.config import (Hlt2Line, register_line_builder)
 from RecoConf.event_filters import require_pvs
 from RecoConf.reconstruction_objects import make_pvs
+from RecoConf.muonid import make_muon_hits
 
 #from RecoConf.hlt1_allen import make_converted_tracks
 
@@ -1107,14 +1108,18 @@ def calibmon_dimuon_velomuon(name="Hlt2CalibMon_DiMuon_VeloMuon"):
         checkVP=True,
         checkFT=False,
         checkUT=False,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsi_mup_tagged = MuonProbeToLongMatcher(
         TwoBodyComposites=jpsis_mup_tagged,
         LongTracks=long_mums,
         checkVP=True,
         checkFT=False,
         checkUT=False,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsis = ParticleContainersMerger(
         [matched_jpsi_mum_tagged, matched_jpsi_mup_tagged])
 
@@ -1184,14 +1189,18 @@ def calibmon_dimuon_downstream(name="Hlt2CalibMon_DiMuon_Downstream",
         checkVP=False,
         checkFT=True,
         checkUT=True,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsi_mup_tagged = MuonProbeToLongMatcher(
         TwoBodyComposites=jpsis_mup_tagged,
         LongTracks=long_mums,
         checkVP=False,
         checkFT=True,
         checkUT=True,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsis = ParticleContainersMerger(
         [matched_jpsi_mum_tagged, matched_jpsi_mup_tagged])
 
@@ -1259,14 +1268,18 @@ def calibmon_dimuon_muonut(name="Hlt2CalibMon_DiMuon_MuonUT"):
         checkVP=False,
         checkFT=False,
         checkUT=True,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsi_mup_tagged = MuonProbeToLongMatcher(
         TwoBodyComposites=jpsis_mup_tagged,
         LongTracks=long_mums,
         checkVP=False,
         checkFT=False,
         checkUT=True,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsis = ParticleContainersMerger(
         [matched_jpsi_mum_tagged, matched_jpsi_mup_tagged])
 
@@ -1327,14 +1340,18 @@ def calibmon_dimuon_seedmuon(name="Hlt2CalibMon_DiMuon_SeedMuon"):
         checkVP=False,
         checkFT=True,
         checkUT=False,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsi_mup_tagged = MuonProbeToLongMatcher(
         TwoBodyComposites=jpsis_mup_tagged,
         LongTracks=long_mums,
         checkVP=False,
         checkFT=True,
         checkUT=False,
-        checkMuon=True).MatchedComposites
+        checkMuon=True,
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True).MatchedComposites
     matched_jpsis = ParticleContainersMerger(
         [matched_jpsi_mum_tagged, matched_jpsi_mup_tagged])
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/DiMuonTrackEfficiency.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/DiMuonTrackEfficiency.py
index 77bcbafa110..9fddbc0c279 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/DiMuonTrackEfficiency.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/DiMuonTrackEfficiency.py
@@ -21,6 +21,7 @@ from Hlt2Conf.standard_particles import make_ismuon_long_muon
 
 from RecoConf.reconstruction_objects import make_pvs, upfront_reconstruction
 from RecoConf.event_filters import require_pvs
+from RecoConf.muonid import make_muon_hits
 
 from Hlt2Conf.probe_muons import make_velomuon_muons, make_downstream_muons, make_muonut_muons, make_seed_muons
 from PyConf.Algorithms import MuonProbeToLongMatcher
@@ -266,7 +267,9 @@ def create_MatchLine(name, prescale, persistreco, probe_charge, get_cuts,
         checkVP=get_cuts['checkVP'],
         checkFT=get_cuts['checkFT'],
         checkUT=get_cuts['checkUT'],
-        checkMuon=get_cuts['checkMuon'])
+        checkMuon=get_cuts['checkMuon'],
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True)
     JPsi_matched = matcher.MatchedComposites
     long_matched = matcher.MatchedLongTracks
     long_save = make_LongFilter(long_matched, probe_charge)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/SMOG2_Jpsi_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/SMOG2_Jpsi_trackeff.py
index 201a9d504c8..33c823bfbac 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/SMOG2_Jpsi_trackeff.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/SMOG2_Jpsi_trackeff.py
@@ -28,6 +28,7 @@ from Functors.math import in_range
 from Hlt2Conf.algorithms_thor import ParticleFilter, ParticleCombiner
 from Hlt2Conf.lines.ift.builders.smog2_builders import sv_in_smog2, bpv_in_smog2
 from Hlt2Conf.lines.trackeff.DiMuonTrackEfficiency import make_LongFilter
+from RecoConf.muonid import make_muon_hits
 
 all_lines = {}
 
@@ -182,7 +183,9 @@ def create_MatchLine(name, prescale, persistreco, probe_charge, get_cuts,
         checkVP=get_cuts['checkVP'],
         checkFT=get_cuts['checkFT'],
         checkUT=get_cuts['checkUT'],
-        checkMuon=get_cuts['checkMuon'])
+        checkMuon=get_cuts['checkMuon'],
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True)
     JPsi_matched = matcher.MatchedComposites
     long_matched = matcher.MatchedLongTracks
     long_save = make_LongFilter(long_matched, probe_charge)
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/ZTrackEfficiency.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/ZTrackEfficiency.py
index 97927bc13ef..23a9b9db58d 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/ZTrackEfficiency.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/trackeff/ZTrackEfficiency.py
@@ -28,6 +28,7 @@ from Moore.lines import Hlt2Line
 from Moore.streams import DETECTORS
 
 from RecoConf.reconstruction_objects import upfront_reconstruction
+from RecoConf.muonid import make_muon_hits
 
 from Hlt2Conf.algorithms_thor import ParticleFilter, ParticleCombiner
 from Hlt2Conf.standard_particles import make_ismuon_long_muon
@@ -165,7 +166,9 @@ def create_Match_Line(name, line, prescale, persistreco, probe_charge,
         checkVP=get_cuts['checkVP'],
         checkFT=get_cuts['checkFT'],
         checkUT=get_cuts['checkUT'],
-        checkMuon=get_cuts['checkMuon'])
+        checkMuon=get_cuts['checkMuon'],
+        MuonHitContainer=make_muon_hits(),
+        addNeighbouringMuonHits=True)
     Z0_matched = matcher.MatchedComposites
     long_matched = matcher.MatchedLongTracks
     long_save = make_LongFilter(long_matched, probe_charge)
-- 
GitLab


From 7ab8c491b4a4dde43b0f6c4963d97dffdf07818f Mon Sep 17 00:00:00 2001
From: Miroslav Saur <miroslav.saur@cern.ch>
Date: Wed, 25 Dec 2024 15:57:55 +0800
Subject: [PATCH 09/31] Update References for: LHCb!4834, Moore!4190,
 DaVinci!1217 based on lhcb-2024-patches-mr/1897

---
 .../tests/refs/dump_for_standalone_allen.ref  |   2 +-
 .../dump_for_standalone_allen.ref.detdesc     |   2 +-
 ...standalone_allen.ref.x86_64_v3-detdesc-opt |   2 +-
 ...ump_for_standalone_allen.ref.x86_64_v3-opt |   2 +-
 .../dump_for_standalone_allen_Sim10aU1.ref    |   2 +-
 ..._for_standalone_allen_Sim10aU1.ref.detdesc |   2 +-
 .../tests/refs/hlt2_test_flagging.ref         | 767 +++++++++--------
 .../tests/refs/hlt2_test_flagging.ref.detdesc | 754 ++++++++++-------
 ...t2_test_flagging.ref.x86_64_v3-detdesc-opt | 760 ++++++++++-------
 .../refs/hlt2_test_flagging.ref.x86_64_v3-opt | 768 ++++++++++--------
 10 files changed, 1791 insertions(+), 1270 deletions(-)

diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref
index b36541965ec..9b6c49b3357 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_53a67151               INFO Size:104878064 Output: 'Connection':'/workspace/build/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:d11cc315d36bd885538924a8953d4589
+LHCb__MDFWriter_9c9930cf               INFO Size:104878064 Output: 'Connection':'/workspace/data/workspace/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:d11cc315d36bd885538924a8953d4589
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.detdesc b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.detdesc
index 5333ae349d5..70064d9ea95 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.detdesc
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.detdesc
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_53a67151               INFO Size:104878064 Output: 'Connection':'/workspace/build/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:27b66ac0a690228bbd499b21bf656ec0
+LHCb__MDFWriter_9c9930cf               INFO Size:104878064 Output: 'Connection':'/workspace/data/workspace/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:27b66ac0a690228bbd499b21bf656ec0
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-detdesc-opt
index afc0836c6e5..a48df4f2208 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-detdesc-opt
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_53a67151               INFO Size:104878064 Output: 'Connection':'/workspace/build/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:eae2d3247e61fd5e8d356ab4811c24da
+LHCb__MDFWriter_9c9930cf               INFO Size:104878064 Output: 'Connection':'/workspace/data/workspace/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:eae2d3247e61fd5e8d356ab4811c24da
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-opt b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-opt
index 7cacfb214cc..4544aafed12 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-opt
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen.ref.x86_64_v3-opt
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_53a67151               INFO Size:104878064 Output: 'Connection':'/workspace/build/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:f27afdaf689a7d3f7058ad30a7282a82
+LHCb__MDFWriter_9c9930cf               INFO Size:104878064 Output: 'Connection':'/workspace/data/workspace/Moore/build/Hlt/Hlt1Conf/qmtest_tmp/dump/mdf_sim-20231017-vc-mu100/dumped_file.mdf' MD5 sum:f27afdaf689a7d3f7058ad30a7282a82
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref
index 5ed6be664b5..ee785f16b49 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_29632b87               INFO
+LHCb__MDFWriter_485d8d28               INFO
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref.detdesc b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref.detdesc
index 8c942f07f82..4fe34ec0b0b 100644
--- a/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref.detdesc
+++ b/Hlt/Hlt1Conf/tests/refs/dump_for_standalone_allen_Sim10aU1.ref.detdesc
@@ -1,4 +1,4 @@
-LHCb__MDFWriter_29632b87               INFO
+LHCb__MDFWriter_485d8d28               INFO
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 DeviceBeamline                         INFO Number of counters : 1
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref
index d0b4b893d55..a856e3f6445 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref
@@ -4,36 +4,32 @@ ApplicationMgr                         INFO Application Manager Finalized succes
 ApplicationMgr                         INFO Application Manager Terminated successfully
 CaloAcceptanceBremAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.131 |      0.0000 |      62.000 |
+ | "#tracks in acceptance"                         |       200 |       2045 |     10.225 |     7.7881 |      0.0000 |      40.000 |
 CaloAcceptanceBremAlg_Long_142dbbc6    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12972 |     64.860 |     42.630 |      2.0000 |      237.00 |
- | "#tracks in acceptance"                         |       200 |       9527 |     47.635 |     30.982 |      1.0000 |      173.00 |
-CaloAcceptanceBremAlg_Upstream_3...    INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |      11848 |     59.240 |     37.788 |      2.0000 |      215.00 |
+ | "#tracks in acceptance"                         |       200 |       9006 |     45.030 |     28.443 |      1.0000 |      166.00 |
 CaloAcceptanceEcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.131 |      0.0000 |      62.000 |
+ | "#tracks in acceptance"                         |       200 |       2300 |     11.500 |     8.8769 |      0.0000 |      53.000 |
 CaloAcceptanceEcalAlg_Long_71599283    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12972 |     64.860 |     42.630 |      2.0000 |      237.00 |
- | "#tracks in acceptance"                         |       200 |      10869 |     54.345 |     35.801 |      2.0000 |      194.00 |
+ | "#total tracks"                                 |       200 |      11848 |     59.240 |     37.788 |      2.0000 |      215.00 |
+ | "#tracks in acceptance"                         |       200 |      10098 |     50.490 |     32.325 |      2.0000 |      176.00 |
 CaloAcceptanceEcalAlg_Ttrack_b29...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      10375 |     51.875 |     52.228 |      0.0000 |      481.00 |
- | "#tracks in acceptance"                         |       200 |       8350 |     41.750 |     44.709 |      0.0000 |      421.00 |
+ | "#total tracks"                                 |       200 |       8649 |     43.245 |     47.953 |      0.0000 |      445.00 |
+ | "#tracks in acceptance"                         |       200 |       6931 |     34.655 |     41.052 |      0.0000 |      389.00 |
 CaloAcceptanceHcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.131 |      0.0000 |      62.000 |
+ | "#tracks in acceptance"                         |       200 |       2100 |     10.500 |     8.1025 |      0.0000 |      49.000 |
 CaloAcceptanceHcalAlg_Long_1fd97970    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12972 |     64.860 |     42.630 |      2.0000 |      237.00 |
- | "#tracks in acceptance"                         |       200 |      10200 |     51.000 |     33.622 |      2.0000 |      185.00 |
+ | "#total tracks"                                 |       200 |      11848 |     59.240 |     37.788 |      2.0000 |      215.00 |
+ | "#tracks in acceptance"                         |       200 |       9486 |     47.430 |     30.425 |      2.0000 |      166.00 |
 CaloClusterMCTruth_f74c042c            INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#CC2MC links"                                  |       200 |     605231 |     3026.2 |
@@ -56,8 +52,8 @@ CaloFutureHypoMCTruth_62e2fa0d         INFO Number of counters : 2
  | "#links/hypo"                                   |       784 |      25172 |     32.107 |
 CaloFutureHypoMCTruth_e86f8ec2         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links"                                        |       200 |     370049 |     1850.2 |
- | "#links/hypo"                                   |     22640 |     370049 |     16.345 |
+ | "#links"                                        |       200 |     372878 |     1864.4 |
+ | "#links/hypo"                                   |     22780 |     372878 |     16.369 |
 CaloFutureMergedPi0_eb4f3a3b           INFO Number of counters : 12
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cluster without 2nd seed found"                |       784 |          0 |( 0.000000 +- 0.000000)% |
@@ -86,163 +82,190 @@ CaloFutureMergedPi0_eb4f3a3b.Eca...    INFO Number of counters : 3
  | "Corrected Clusters: # cells "                  |       184 |       1047 |     5.6902 |     1.6865 |      3.0000 |      9.0000 |
  | "Corrected Clusters: ET"                        |       184 |   165760.6 |     900.87 |     881.52 |      3.6000 |      7563.0 |
  | "Corrected Clusters: size ratio"                |       184 |   86.09061 |    0.46788 |    0.46423 |    0.015364 |      2.2345 |
-CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 1
+CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |        662 |     3.3100 |     3.6392 |      0.0000 |      18.000 |
+ | "average chi2"                                  |       662 |   2478.887 |     3.7445 |     4.7346 |   0.0024390 |      40.089 |
+ | "average energy (track based)"                  |      2045 |   123446.5 |     60.365 |     228.58 |      0.0000 |      6121.2 |
 CaloSelectiveBremMatchAlg_Long_e...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       3497 |     17.485 |     16.116 |      0.0000 |      79.000 |
- | "average chi2"                                  |      3497 |   3258.397 |    0.93177 |     1.7936 |  1.8701e-06 |      36.441 |
- | "average energy (track based)"                  |      9527 |   166834.2 |     17.512 |     51.521 |      0.0000 |      1333.3 |
-CaloSelectiveBremMatchAlg_Upstre...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       3279 |     16.395 |     14.699 |      0.0000 |      67.000 |
+ | "average chi2"                                  |      3279 |   3405.104 |     1.0385 |     1.9013 |  2.4497e-06 |      38.309 |
+ | "average energy (track based)"                  |      9006 |   157704.5 |     17.511 |     52.309 |      0.0000 |      1346.8 |
+CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#above threshold"                              |         1 |          1 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#links in table"                               |       200 |       2046 |     10.230 |     8.1091 |      0.0000 |      41.000 |
+ | "average chi2"                                  |      2046 |   40371.48 |     19.732 |     62.149 |   0.0010255 |      2134.2 |
 CaloSelectiveElectronMatchAlg_Lo...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       8932 |     44.660 |     32.245 |      2.0000 |      176.00 |
- | "average chi2"                                  |      8932 |   43243.78 |     4.8414 |     11.437 |  0.00021628 |      410.27 |
-CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       8272 |     41.360 |     29.201 |      2.0000 |      163.00 |
+ | "average chi2"                                  |      8272 |   41423.82 |     5.0077 |     12.017 |  0.00023863 |      407.46 |
+CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       2057 |     10.285 |     8.1015 |      0.0000 |      41.000 |
+ | "average chi2"                                  |      2057 |   1179.687 |    0.57350 |     1.0968 |  1.4910e-05 |      25.521 |
 CaloSelectiveTrackMatchAlg_Long_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       9037 |     45.185 |     32.374 |      2.0000 |      178.00 |
- | "average chi2"                                  |      9037 |   1336.738 |    0.14792 |    0.28383 |  7.1399e-06 |      8.8313 |
+ | "#links in table"                               |       200 |       8372 |     41.860 |     29.339 |      2.0000 |      165.00 |
+ | "average chi2"                                  |      8372 |   1330.669 |    0.15894 |    0.30294 |  6.9804e-06 |      8.8232 |
 CaloSelectiveTrackMatchAlg_Ttrac...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       6792 |     33.960 |     32.766 |      0.0000 |      296.00 |
- | "average chi2"                                  |      6792 |   430.8356 |   0.063433 |    0.12099 |  2.1887e-06 |      4.0928 |
+ | "#links in table"                               |       200 |       5497 |     27.485 |     29.464 |      0.0000 |      272.00 |
+ | "average chi2"                                  |      5497 |   435.8259 |   0.079284 |    0.14625 |  2.6544e-06 |      4.0928 |
+CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "average DLL"                                   |      2300 |  -339.2634 |   -0.14751 |    0.53853 |     -7.3593 |      3.5996 |
+ | "average E/p"                                   |      2300 |   96.05302 |   0.041762 |   0.066733 |      0.0000 |     0.95009 |
 CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "average DLL"                                   |     10869 |  -626.0269 |  -0.057597 |    0.10564 |     -2.7206 |     0.58054 |
- | "average E/p"                                   |     10869 |   70.05321 |  0.0064452 |  0.0094227 |      0.0000 |     0.16162 |
+ | "average DLL"                                   |     10098 |  -626.7264 |  -0.062064 |    0.11129 |     -2.6872 |     0.61537 |
+ | "average E/p"                                   |     10098 |   69.93638 |  0.0069258 |   0.010207 |      0.0000 |     0.16357 |
+CaloTrackToHcalEnergyAlg_Downstr...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "energy (calo) associated to track"             |      2100 |1.073036e+07 |     5109.7 |     9955.4 |      0.0000 |  1.0735e+05 |
 CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "energy (calo) associated to track"             |     10200 |4.479987e+07 |     4392.1 |     8188.2 |      0.0000 |  1.2332e+05 |
+ | "energy (calo) associated to track"             |      9486 |3.754027e+07 |     3957.4 |     7358.7 |      0.0000 |  1.2332e+05 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12972 |      11245 |( 86.68671 +- 0.2982741)% |
- | "MC particles per ProtoParticle"                |     11245 |      13088 |     1.1639 |
+ |*"Efficiency"                                    |      2984 |       2502 |( 83.84718 +- 0.6737037)% |
+ | "MC particles per ProtoParticle"                |      2502 |       2502 |     1.0000 |
+ChargedProtoParticleAssociator_9...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     11848 |      10537 |( 88.93484 +- 0.2881989)% |
+ | "MC particles per ProtoParticle"                |     10537 |      12221 |     1.1598 |
+ChargedProtoParticleMaker_Downst...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "CreatedProtos"                                 |      2984 |
 ChargedProtoParticleMaker_Long_f...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "CreatedProtos"                                 |     12972 |
+ | "CreatedProtos"                                 |     11848 |
 ClassifyPhotonElectronAlg_8ec9e29e     INFO Number of counters : 14
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Electron Delta(E)"                             |     12357 |   -5162529 |    -417.78 |     554.75 |     -5757.1 |      2738.6 |
- | "Electron Delta(X)"                             |     12357 |  -5159.212 |   -0.41751 |     12.280 |     -91.805 |      29.057 |
- | "Electron Delta(Y)"                             |     12357 |  -3384.793 |   -0.27392 |     12.296 |     -72.810 |      22.670 |
- | "Electron Delta(Z)"                             |     12357 |     859126 |     69.525 |     13.323 |     -10.624 |      123.98 |
- | "Electron corrected energy"                     |     12357 |7.599892e+07 |     6150.3 |     7308.6 |      19.963 |  1.2189e+05 |
- | "Electrons pT-rejected after correction"        |       121 |
- | "Photon Delta(E)"                               |     23069 |   -5510346 |    -238.86 |     398.88 |     -4036.0 |      2229.9 |
- | "Photon Delta(X)"                               |     23069 |  -8795.815 |   -0.38128 |     12.698 |     -91.984 |      62.040 |
- | "Photon Delta(Y)"                               |     23069 |  -5219.658 |   -0.22626 |     12.658 |     -91.966 |      61.225 |
- | "Photon Delta(Z)"                               |     23069 |    1374489 |     59.582 |     13.026 |     -8.7578 |      123.98 |
- | "Photon corrected energy"                       |     23069 |7.953442e+07 |     3447.7 |     5801.6 |      22.782 |  1.2636e+05 |
- | "Photons pT-rejected after correction"          |       429 |
- | "electronHypos"                                 |       200 |      12236 |     61.180 |     37.025 |      4.0000 |      217.00 |
- | "photonHypos"                                   |       200 |      22640 |     113.20 |     49.356 |      10.000 |      235.00 |
+ | "Electron Delta(E)"                             |     12342 |   -5160185 |    -418.10 |     555.17 |     -5757.1 |      2738.6 |
+ | "Electron Delta(X)"                             |     12342 |  -5314.331 |   -0.43059 |     12.270 |     -91.805 |      29.057 |
+ | "Electron Delta(Y)"                             |     12342 |  -3323.639 |   -0.26930 |     12.291 |     -72.810 |      22.670 |
+ | "Electron Delta(Z)"                             |     12342 |   858106.1 |     69.527 |     13.316 |     -10.624 |      123.98 |
+ | "Electron corrected energy"                     |     12342 |7.593475e+07 |     6152.5 |     7310.9 |      19.963 |  1.2189e+05 |
+ | "Electrons pT-rejected after correction"        |       119 |
+ | "Photon Delta(E)"                               |     23210 |   -5562769 |    -239.67 |     399.41 |     -4036.0 |      2229.9 |
+ | "Photon Delta(X)"                               |     23210 |  -8577.674 |   -0.36957 |     12.688 |     -91.984 |      62.040 |
+ | "Photon Delta(Y)"                               |     23210 |  -5116.338 |   -0.22044 |     12.648 |     -91.966 |      61.225 |
+ | "Photon Delta(Z)"                               |     23210 |    1383708 |     59.617 |     13.029 |     -8.7578 |      123.98 |
+ | "Photon corrected energy"                       |     23210 |8.020572e+07 |     3455.7 |     5798.3 |      22.782 |  1.2636e+05 |
+ | "Photons pT-rejected after correction"          |       430 |
+ | "electronHypos"                                 |       200 |      12223 |     61.115 |     37.026 |      4.0000 |      219.00 |
+ | "photonHypos"                                   |       200 |      22780 |     113.90 |     49.909 |      10.000 |      237.00 |
 ClassifyPhotonElectronAlg_8ec9e2...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "<alpha> Inner"                                 |     10033 |   9977.235 |    0.99444 |   0.019645 |     0.96438 |      1.1318 |
- | "<alpha> Middle"                                |      9319 |   9376.979 |     1.0062 |   0.020773 |     0.97670 |      1.2128 |
- | "<alpha> Outer"                                 |     15985 |   15975.82 |    0.99943 |   0.016326 |     0.97368 |      1.1242 |
- | "Pileup offset"                                 |     35337 |1.315642e+07 |     372.31 |     441.82 |      2.6870 |      4736.9 |
- | "Pileup scale"                                  |     35426 |     202888 |     5.7271 |     2.0446 |      1.0000 |      12.000 |
- | "Pileup subtracted ratio"                       |     35337 |   31039.96 |    0.87840 |    0.12413 |  0.00047684 |     0.99914 |
- | "Skip negative energy correction"               |        89 |
-CloneKillerForward_4991e24b            INFO Number of counters : 2
+ | "<alpha> Inner"                                 |     10081 |   10024.87 |    0.99443 |   0.019621 |     0.96438 |      1.1318 |
+ | "<alpha> Middle"                                |      9362 |   9420.229 |     1.0062 |   0.020782 |     0.97670 |      1.2128 |
+ | "<alpha> Outer"                                 |     16019 |   16010.11 |    0.99944 |   0.016330 |     0.97368 |      1.1242 |
+ | "Pileup offset"                                 |     35462 |1.321586e+07 |     372.68 |     441.94 |      2.6870 |      4736.9 |
+ | "Pileup scale"                                  |     35552 |     203663 |     5.7286 |     2.0450 |      1.0000 |      12.000 |
+ | "Pileup subtracted ratio"                       |     35462 |   31150.51 |    0.87842 |    0.12402 |  0.00047684 |     0.99914 |
+ | "Skip negative energy correction"               |        90 |
+CloneKillerMatch_2d6666d0              INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "nTracksInput"                                  |       200 |      13619 |     68.095 |
- | "nTracksSelected"                               |       200 |       2612 |     13.060 |
+ | "nTracksInput"                                  |       200 |      13598 |     67.990 |
+ | "nTracksSelected"                               |       200 |       3779 |     18.895 |
 CopySignalMCParticles_daf3c6a8         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"copy signal"                                   |   1061346 |          0 |( 0.000000 +- 0.000000)% |
  |*"input container present"                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |       400 |     408309 |     1020.8 |     1471.1 |      2.0000 |      7462.0 |
+ | "# of cloned entries"                           |       400 |     412773 |     1031.9 |     1479.3 |      2.0000 |      7476.0 |
  |*"Input container absent"                        |       400 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |    190725 |     190725 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |    101977 |      90835 |( 89.07401 +- 0.09769106)% |
+ |*"MCParticles cloned"                            |    191876 |     191876 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |    104041 |      91363 |( 87.81442 +- 0.1014154)% |
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |       200 |
  | "Nb events removed"                             |        24 |
 FilteredPIDElectrons                   INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        181 |( 90.50000 +- 2.073343)% |
- |*"Cut selection efficiency"                      |     12972 |       1359 |( 10.47641 +- 0.2688881)% |
+ |*"#passed"                                       |       200 |        178 |( 89.00000 +- 2.212465)% |
+ |*"Cut selection efficiency"                      |     11848 |       1119 |( 9.444632 +- 0.2686749)% |
 FilteredPIDMuons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        193 |( 96.50000 +- 1.299519)% |
- |*"Cut selection efficiency"                      |     12972 |       2129 |( 16.41227 +- 0.3252012)% |
+ |*"#passed"                                       |       200 |        194 |( 97.00000 +- 1.206234)% |
+ |*"Cut selection efficiency"                      |     11848 |       1890 |( 15.95206 +- 0.3363949)% |
 FilteredPIDkaons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     12972 |       7888 |( 60.80789 +- 0.4286233)% |
-FunctionalParticleMaker_149889e6       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"Cut selection efficiency"                      |     11848 |       7205 |( 60.81195 +- 0.4484859)% |
+FunctionalParticleMaker_149889e6       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        197 |( 98.50000 +- 0.8595057)% |
+ |*"# passed ProtoParticle filter"                 |      2984 |       2712 |( 90.88472 +- 0.5269035)% |
+ |*"# passed Track filter"                         |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1314 |     6.5700 |     5.0433 |      0.0000 |      26.000 |
+ | "Nb created particles"                          |       200 |       1398 |     6.9900 |     5.4194 |      0.0000 |      30.000 |
 FunctionalParticleMaker_2ff3f10f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12267 |( 94.56522 +- 0.1990459)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6119 |     30.595 |     19.755 |      1.0000 |      105.00 |
- | "Nb created particles"                          |       200 |       6148 |     30.740 |     20.747 |      1.0000 |      121.00 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11304 |( 95.40851 +- 0.1922861)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5659 |     28.295 |     17.801 |      1.0000 |      98.000 |
+ | "Nb created particles"                          |       200 |       5645 |     28.225 |     18.730 |      1.0000 |      110.00 |
 FunctionalParticleMaker_379cf33a       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6488 |     32.440 |     21.117 |      1.0000 |      111.00 |
- | "Nb created particles"                          |       200 |       6484 |     32.420 |     21.975 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5927 |     29.635 |     18.697 |      1.0000 |      103.00 |
+ | "Nb created particles"                          |       200 |       5921 |     29.605 |     19.598 |      1.0000 |      112.00 |
+FunctionalParticleMaker_442c3d96       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         5 |          5 |( 100.0000 +- 0.000000)% |
+ |*"# passed ProtoParticle filter"                 |       403 |        378 |( 93.79653 +- 1.201596)% |
+ |*"# passed Track filter"                         |       403 |        403 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |         5 |        192 |     38.400 |     18.018 |      8.0000 |      61.000 |
+ | "Nb created particles"                          |         5 |        186 |     37.200 |     18.745 |      8.0000 |      65.000 |
 FunctionalParticleMaker_950c4697       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12267 |( 94.56522 +- 0.1990459)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6119 |     30.595 |     19.755 |      1.0000 |      105.00 |
- | "Nb created particles"                          |       200 |       6148 |     30.740 |     20.747 |      1.0000 |      121.00 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11304 |( 95.40851 +- 0.1922861)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5659 |     28.295 |     17.801 |      1.0000 |      98.000 |
+ | "Nb created particles"                          |       200 |       5645 |     28.225 |     18.730 |      1.0000 |      110.00 |
 FunctionalParticleMaker_9614a368       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6488 |     32.440 |     21.117 |      1.0000 |      111.00 |
- | "Nb created particles"                          |       200 |       6484 |     32.420 |     21.975 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5927 |     29.635 |     18.697 |      1.0000 |      103.00 |
+ | "Nb created particles"                          |       200 |       5921 |     29.605 |     19.598 |      1.0000 |      112.00 |
 FunctionalParticleMaker_a90be71f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6488 |     32.440 |     21.117 |      1.0000 |      111.00 |
- | "Nb created particles"                          |       200 |       6484 |     32.420 |     21.975 |      1.0000 |      126.00 |
-FunctionalParticleMaker_c5ad9787       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5927 |     29.635 |     18.697 |      1.0000 |      103.00 |
+ | "Nb created particles"                          |       200 |       5921 |     29.605 |     19.598 |      1.0000 |      112.00 |
+FunctionalParticleMaker_c5ad9787       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        197 |( 98.50000 +- 0.8595057)% |
+ |*"# passed ProtoParticle filter"                 |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1453 |     7.2650 |     5.5942 |      0.0000 |      30.000 |
+ | "Nb created particles"                          |       200 |       1531 |     7.6550 |     6.0288 |      0.0000 |      32.000 |
 FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12972 |      12972 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6488 |     32.440 |     21.117 |      1.0000 |      111.00 |
- | "Nb created particles"                          |       200 |       6484 |     32.420 |     21.975 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11848 |      11848 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5927 |     29.635 |     18.697 |      1.0000 |      103.00 |
+ | "Nb created particles"                          |       200 |       5921 |     29.605 |     19.598 |      1.0000 |      112.00 |
 FutureNeutralProtoPAlg_8a4fb7d2        INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Neutral Protos"                                |       200 |      24992 |     124.96 |     60.321 |      10.000 |      301.00 |
+ | "Neutral Protos"                                |       200 |      25132 |     125.66 |     60.887 |      10.000 |      303.00 |
  | "Neutral Protos from MergedPi0s"                |       200 |        784 |     3.9200 |     4.6102 |      0.0000 |      24.000 |
- | "Neutral Protos from Photons"                   |       200 |      22640 |     113.20 |     49.356 |      10.000 |      235.00 |
+ | "Neutral Protos from Photons"                   |       200 |      22780 |     113.90 |     49.909 |      10.000 |      237.00 |
  | "Neutral Protos from SplitPhotons"              |       200 |       1568 |     7.8400 |     9.2203 |      0.0000 |      48.000 |
 GraphClustering_72971694               INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
@@ -282,13 +305,13 @@ Hlt2Test_Bs0ToJpsiPhi_JPsiToMupM...    INFO Number of counters : 1
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         58 |( 29.00000 +- 3.208582)% |
- |*"# passed CombinationCut"                       |     67996 |        160 |(0.2353080 +- 0.01858083)% |
- |*"# passed CompositeCut"                         |       160 |        154 |( 96.25000 +- 1.501952)% |
- |*"# passed vertex fit"                           |       160 |        160 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12972 |     64.860 |
- | "Input2 size"                                   |       200 |       1359 |     6.7950 |
- | "candidate multiplicity"                        |       200 |        154 |    0.77000 |     1.7341 |      0.0000 |      13.000 |
+ |*"# passed"                                      |       200 |         44 |( 22.00000 +- 2.929164)% |
+ |*"# passed CombinationCut"                       |     49725 |         96 |(0.1930618 +- 0.01968526)% |
+ |*"# passed CompositeCut"                         |        96 |         89 |( 92.70833 +- 2.653610)% |
+ |*"# passed vertex fit"                           |        96 |         96 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11848 |     59.240 |
+ | "Input2 size"                                   |       200 |       1119 |     5.5950 |
+ | "candidate multiplicity"                        |       200 |         89 |    0.44500 |     1.0756 |      0.0000 |      6.0000 |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
@@ -322,67 +345,65 @@ Hlt2Test_sRTPhotons_Prescaler          INFO Number of counters : 1
 HltDecReportsFilter_895ecf8e           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_9a845e76         INFO Number of counters : 2
+HltPackedBufferWriter_baee4457         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |       200 |3.612945e+07 | 1.8065e+05 | 1.1435e+05 |      12764. |  6.3784e+05 |
+ | "Size of serialized data"                       |       200 |     488285 |     2441.4 |     3138.2 |      108.00 |      16197. |
 Hlt__RoutingBitsCombiner_6642b907      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |       200 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Events without Tracks"                   |         1 |          0 |     0.0000 |
- | "Nb of Produced Tracks"                         |       199 |      10375 |     52.136 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |       200 |      12972 |     64.860 |
+ | "Nb of Produced Tracks"                         |       199 |       8649 |     43.462 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
+ | "Nb of Produced Tracks"                         |       200 |      11848 |     59.240 |
+LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
+ | "Nb of Events without Tracks"                   |         3 |          0 |     0.0000 |
+ | "Nb of Produced Tracks"                         |       197 |       2984 |     15.147 |
 LHCb__Phys__ParticleMakers__Phot...    INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- | "Confidence Level"                              |     14670 |   5003.611 |    0.34108 |    0.33095 |  7.0212e-05 |     0.99473 |
- | "Created photons"                               |     22640 |
- | "Selected photons"                              |       200 |      14670 |     73.350 |     38.507 |      4.0000 |      185.00 |
-LHCb__SelectivePacker_bce9f7c6         INFO Number of counters : 75
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BremInfos # containers packed"                 |       200 |        200 |     1.0000 |
- | "BremInfos # of packed entries"                 |       200 |       9527 |     47.635 |
- | "BremInfos buffer size"                         |       200 |     404534 |     2022.7 |
+ | "Confidence Level"                              |     14788 |   5023.955 |    0.33973 |    0.33078 |  7.0212e-05 |     0.99473 |
+ | "Created photons"                               |     22780 |
+ | "Selected photons"                              |       200 |      14788 |     73.940 |     39.025 |      4.0000 |      186.00 |
+LHCb__SelectivePacker_68fc5b26         INFO Number of counters : 75
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BremInfos # containers packed"                 |       200 |          6 |   0.030000 |
+ | "BremInfos # of packed entries"                 |         6 |         24 |     4.0000 |
+ | "BremInfos buffer size"                         |         6 |       1140 |     190.00 |
  | "BremInfosSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "CaloAdcs # containers packed"                  |       200 |          0 |     0.0000 |
- | "CaloChargedPIDs # containers packed"           |       200 |        200 |     1.0000 |
- | "CaloChargedPIDs # of packed entries"           |       200 |      10963 |     54.815 |
- | "CaloChargedPIDs buffer size"                   |       200 |     662180 |     3310.9 |
+ | "CaloChargedPIDs # containers packed"           |       200 |          6 |   0.030000 |
+ | "CaloChargedPIDs # of packed entries"           |         6 |         22 |     3.6667 |
+ | "CaloChargedPIDs buffer size"                   |         6 |       1452 |     242.00 |
  | "CaloChargedPIDsSelection # containers packed"  |       200 |          0 |     0.0000 |
  | "CaloClusters # containers packed"              |       200 |          0 |     0.0000 |
  | "CaloClustersSelection # containers packed"     |       200 |          0 |     0.0000 |
  | "CaloDigits # containers packed"                |       200 |          0 |     0.0000 |
- | "CaloHypos # containers packed"                 |       200 |        800 |     4.0000 |
- | "CaloHypos # of packed entries"                 |       800 |      37228 |     46.535 |
- | "CaloHypos buffer size"                         |       800 |    2863324 |     3579.2 |
+ | "CaloHypos # containers packed"                 |       200 |        109 |    0.54500 |
+ | "CaloHypos # of packed entries"                 |       109 |        375 |     3.4404 |
+ | "CaloHypos buffer size"                         |       109 |      31334 |     287.47 |
  | "CaloHyposSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "ExtendedPVs # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTags # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTagsSelection # containers packed"      |       200 |          0 |     0.0000 |
- | "GlobalChargedPIDs # containers packed"         |       200 |        200 |     1.0000 |
- | "GlobalChargedPIDs # of packed entries"         |       200 |      12972 |     64.860 |
- | "GlobalChargedPIDs buffer size"                 |       200 |     730832 |     3654.2 |
+ | "GlobalChargedPIDs # containers packed"         |       200 |          6 |   0.030000 |
+ | "GlobalChargedPIDs # of packed entries"         |         6 |         27 |     4.5000 |
+ | "GlobalChargedPIDs buffer size"                 |         6 |       1644 |     274.00 |
  | "GlobalChargedPIDsSelection # containers packed"|       200 |          0 |     0.0000 |
- | "LightPVs # containers packed"                  |       200 |         10 |   0.050000 |
- | "LightPVs # of packed entries"                  |        10 |         12 |     1.2000 |
- | "LightPVs buffer size"                          |        10 |        772 |     77.200 |
+ | "LightPVs # containers packed"                  |       200 |          8 |   0.040000 |
+ | "LightPVs # of packed entries"                  |         8 |         10 |     1.2500 |
+ | "LightPVs buffer size"                          |         8 |        636 |     79.500 |
  | "LightPVsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "MuonPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "MuonPIDs # of packed entries"                  |       200 |      12972 |     64.860 |
- | "MuonPIDs buffer size"                          |       200 |     784192 |     3921.0 |
+ | "MuonPIDs # containers packed"                  |       200 |          6 |   0.030000 |
+ | "MuonPIDs # of packed entries"                  |         6 |         27 |     4.5000 |
+ | "MuonPIDs buffer size"                          |         6 |       1784 |     297.33 |
  | "MuonPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "NeutralPIDs # containers packed"               |       200 |        200 |     1.0000 |
- | "NeutralPIDs # of packed entries"               |       200 |      24992 |     124.96 |
- | "NeutralPIDs buffer size"                       |       200 |    1503920 |     7519.6 |
+ | "NeutralPIDs # containers packed"               |       200 |        103 |    0.51500 |
+ | "NeutralPIDs # of packed entries"               |       103 |        350 |     3.3981 |
+ | "NeutralPIDs buffer size"                       |       103 |      23266 |     225.88 |
  | "NeutralPIDsSelection # containers packed"      |       200 |          0 |     0.0000 |
  | "P2InfoRelations # containers packed"           |       200 |          0 |     0.0000 |
  | "P2IntRelations # containers packed"            |       200 |          0 |     0.0000 |
@@ -390,121 +411,151 @@ LHCb__SelectivePacker_bce9f7c6         INFO Number of counters : 75
  | "P2PVRelations # containers packed"             |       200 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |       200 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |       200 |        400 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |       400 |     408309 |     1020.8 |
- | "PP2MCPRelations buffer size"                   |       400 |    8190980 |     20477. |
- | "PVs # containers packed"                       |       200 |        200 |     1.0000 |
- | "PVs # of packed entries"                       |       200 |        997 |     4.9850 |
- | "PVs buffer size"                               |       200 |     395256 |     1976.3 |
+ | "PP2MCPRelations # of packed entries"           |       400 |       8666 |     21.665 |
+ | "PP2MCPRelations buffer size"                   |       400 |     195792 |     489.48 |
+ | "PVs # containers packed"                       |       200 |        103 |    0.51500 |
+ | "PVs # of packed entries"                       |       103 |        599 |     5.8155 |
+ | "PVs buffer size"                               |       103 |      38244 |     371.30 |
  | "PVsSelection # containers packed"              |       200 |          0 |     0.0000 |
- | "Particles # containers packed"                 |       200 |        232 |     1.1600 |
- | "Particles # of packed entries"                 |       232 |        574 |     2.4741 |
- | "Particles buffer size"                         |       232 |     119856 |     516.62 |
- | "ParticlesSelection # containers packed"        |       200 |        244 |     1.2200 |
- | "ParticlesSelection # of packed entries"        |       244 |        350 |     1.4344 |
- | "ParticlesSelection buffer size"                |       244 |       9876 |     40.475 |
- | "ProtoParticles # containers packed"            |       200 |        800 |     4.0000 |
- | "ProtoParticles # of packed entries"            |       800 |      37964 |     47.455 |
- | "ProtoParticles buffer size"                    |       800 |    3058472 |     3823.1 |
+ | "Particles # containers packed"                 |       200 |        225 |     1.1250 |
+ | "Particles # of packed entries"                 |       225 |        547 |     2.4311 |
+ | "Particles buffer size"                         |       225 |     114224 |     507.66 |
+ | "ParticlesSelection # containers packed"        |       200 |        241 |     1.2050 |
+ | "ParticlesSelection # of packed entries"        |       241 |        342 |     1.4191 |
+ | "ParticlesSelection buffer size"                |       241 |       9725 |     40.353 |
+ | "ProtoParticles # containers packed"            |       200 |        109 |    0.54500 |
+ | "ProtoParticles # of packed entries"            |       109 |        377 |     3.4587 |
+ | "ProtoParticles buffer size"                    |       109 |      34434 |     315.91 |
  | "ProtoParticlesSelection # containers packed"   |       200 |          0 |     0.0000 |
- | "RecSummary # containers packed"                |       200 |        200 |     1.0000 |
- | "RecSummary # of packed entries"                |       200 |       7600 |     38.000 |
- | "RecSummary buffer size"                        |       200 |      34800 |     174.00 |
- | "RichPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "RichPIDs # of packed entries"                  |       200 |      12267 |     61.335 |
- | "RichPIDs buffer size"                          |       200 |     594016 |     2970.1 |
+ | "RecSummary # containers packed"                |       200 |        103 |    0.51500 |
+ | "RecSummary # of packed entries"                |       103 |       3914 |     38.000 |
+ | "RecSummary buffer size"                        |       103 |      17922 |     174.00 |
+ | "RichPIDs # containers packed"                  |       200 |          6 |   0.030000 |
+ | "RichPIDs # of packed entries"                  |         6 |         27 |     4.5000 |
+ | "RichPIDs buffer size"                          |         6 |       1452 |     242.00 |
  | "RichPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "Tracks # containers packed"                    |       200 |       1168 |     5.8400 |
- | "Tracks # of packed entries"                    |      1168 |      70816 |     60.630 |
- | "Tracks buffer size"                            |      1168 |1.677242e+07 |     14360. |
+ | "Tracks # containers packed"                    |       200 |          8 |   0.040000 |
+ | "Tracks # of packed entries"                    |         8 |         30 |     3.7500 |
+ | "Tracks buffer size"                            |         8 |      12644 |     1580.5 |
  | "TracksSelection # containers packed"           |       200 |          0 |     0.0000 |
  | "TwoProngVertices # containers packed"          |       200 |          0 |     0.0000 |
  | "TwoProngVerticesSelection # containers packed" |       200 |          0 |     0.0000 |
- | "Vertices # containers packed"                  |       200 |         23 |    0.11500 |
- | "Vertices # of packed entries"                  |        23 |         38 |     1.6522 |
- | "Vertices buffer size"                          |        23 |       4022 |     174.87 |
+ | "Vertices # containers packed"                  |       200 |         20 |    0.10000 |
+ | "Vertices # of packed entries"                  |        20 |         22 |     1.1000 |
+ | "Vertices buffer size"                          |        20 |       2592 |     129.60 |
  | "VerticesSelection # containers packed"         |       200 |          0 |     0.0000 |
  | "WeightsVectors # containers packed"            |       200 |          0 |     0.0000 |
+MuonIDHlt2AlgDownstream_81ff20a8       INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BgLL"                                          |       226 |  -118.6299 |   -0.52491 |     1.0766 |     -6.6799 |      0.0000 |
+ | "MuLL"                                          |       226 |   -2141.29 |    -9.4747 |     3.2315 |     -11.513 |   -0.081445 |
+ | "muonMVAStat"                                   |       226 |  -121.5595 |   -0.53787 |    0.98314 |     -2.9175 |      4.0010 |
+ |*"nInAcceptance"                                 |      2984 |       2153 |( 72.15147 +- 0.8205864)% |
+ |*"nIsMuon"                                       |      2984 |        226 |( 7.573727 +- 0.4843431)% |
+ |*"nIsMuonTight"                                  |      2984 |         96 |( 3.217158 +- 0.3230249)% |
+ |*"nMomentumCut"                                  |      2984 |       2322 |( 77.81501 +- 0.7606097)% |
 MuonIDHlt2AlgLong_ebde3a89             INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BgLL"                                          |      1133 |  -489.8266 |   -0.43233 |    0.78344 |     -6.0883 |      0.0000 |
- | "MuLL"                                          |      1133 |  -10748.69 |    -9.4869 |     2.9044 |     -11.513 |    -0.13418 |
- | "muonMVAStat"                                   |      1133 |   -714.994 |   -0.63106 |    0.81718 |     -3.0272 |      4.1483 |
- |*"nInAcceptance"                                 |     12972 |      10216 |( 78.75424 +- 0.3591448)% |
- |*"nIsMuon"                                       |     12972 |       1133 |( 8.734197 +- 0.2478917)% |
- |*"nIsMuonTight"                                  |     12972 |        490 |( 3.777367 +- 0.1673901)% |
- |*"nMomentumCut"                                  |     12972 |      10944 |( 84.36633 +- 0.3188685)% |
+ | "BgLL"                                          |      1066 |  -457.5107 |   -0.42918 |    0.77531 |     -6.1719 |      0.0000 |
+ | "MuLL"                                          |      1066 |  -10120.47 |    -9.4939 |     2.9051 |     -11.513 |    -0.12512 |
+ | "muonMVAStat"                                   |      1066 |  -682.1193 |   -0.63989 |    0.79384 |     -3.0272 |      4.2048 |
+ |*"nInAcceptance"                                 |     11848 |       9364 |( 79.03444 +- 0.3739719)% |
+ |*"nIsMuon"                                       |     11848 |       1066 |( 8.997299 +- 0.2628819)% |
+ |*"nIsMuonTight"                                  |     11848 |        460 |( 3.882512 +- 0.1774741)% |
+ |*"nMomentumCut"                                  |     11848 |      10045 |( 84.78224 +- 0.3299934)% |
+MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of input v2 MuonPIDs"                       |       200 |       2984 |     14.920 |
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of input v2 MuonPIDs"                       |       200 |      12972 |     64.860 |
+ | "Nb of input v2 MuonPIDs"                       |       200 |      11848 |     59.240 |
 NeutralProtoParticleAssociator_a...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     24992 |      23316 |( 93.29385 +- 0.1582204)% |
- | "MC particles per ProtoParticle"                |     23316 |     395221 |     16.951 |
+ |*"Efficiency"                                    |     25132 |      23456 |( 93.33121 +- 0.1573705)% |
+ | "MC particles per ProtoParticle"                |     23456 |     398050 |     16.970 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |       200 |     190725 |     953.62 |     600.94 |      65.000 |      2973.0 |
+ | "#MCParticles"                                  |       200 |     191876 |     959.38 |     602.42 |      65.000 |      2924.0 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |       200 |      90835 |     454.18 |     292.94 |      26.000 |      1439.0 |
+ | "#MCVertices"                                   |       200 |      91363 |     456.81 |     293.91 |      26.000 |      1436.0 |
 ParticleRangeFilter_22f84c5e           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        175 |( 87.50000 +- 2.338536)% |
- |*"Cut selection efficiency"                      |     12972 |       1045 |( 8.055813 +- 0.2389535)% |
+ |*"#passed"                                       |       200 |        178 |( 89.00000 +- 2.212465)% |
+ |*"Cut selection efficiency"                      |     11848 |        992 |( 8.372721 +- 0.2544621)% |
 ParticleRangeFilter_2cf9c882           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         40 |( 20.00000 +- 2.828427)% |
- |*"Cut selection efficiency"                      |     14670 |         46 |(0.3135651 +- 0.04616011)% |
+ |*"Cut selection efficiency"                      |     14788 |         46 |(0.3110630 +- 0.04579235)% |
 ParticleRangeFilter_2d1c6dde           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         42 |( 21.00000 +- 2.880104)% |
- |*"Cut selection efficiency"                      |     14670 |         48 |(0.3271984 +- 0.04714969)% |
+ |*"Cut selection efficiency"                      |     14788 |         48 |(0.3245875 +- 0.04677407)% |
 ParticleRangeFilter_2dd22701           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         65 |( 32.50000 +- 3.311910)% |
- |*"Cut selection efficiency"                      |     12267 |         97 |(0.7907394 +- 0.07996936)% |
+ |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
+ |*"Cut selection efficiency"                      |     11304 |         92 |(0.8138712 +- 0.08450594)% |
+ParticleRangeFilter_32aaad9e           INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         5 |          4 |( 80.00000 +- 17.88854)% |
+ |*"Cut selection efficiency"                      |       378 |         15 |( 3.968254 +- 1.004064)% |
 ParticleRangeFilter_497ef01a           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        100 |( 50.00000 +- 3.535534)% |
- |*"Cut selection efficiency"                      |     12267 |        206 |( 1.679302 +- 0.1160160)% |
+ |*"#passed"                                       |       200 |        101 |( 50.50000 +- 3.535357)% |
+ |*"Cut selection efficiency"                      |     11304 |        191 |( 1.689667 +- 0.1212227)% |
 ParticleRangeFilter_7c68ac05           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     14670 |       3663 |( 24.96933 +- 0.3573615)% |
+ |*"Cut selection efficiency"                      |     14788 |       3684 |( 24.91209 +- 0.3556603)% |
 ParticleRangeFilter_8ad15fd6           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         9 |          9 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |       785 |        117 |( 14.90446 +- 1.271091)% |
-ParticleRangeFilter_9dfc592f           INFO Number of counters : 1
+ |*"#passed"                                       |         6 |          6 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |       523 |         78 |( 14.91396 +- 1.557668)% |
+ParticleRangeFilter_9dfc592f           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        126 |( 63.00000 +- 3.413942)% |
+ |*"Cut selection efficiency"                      |      2712 |        239 |( 8.812684 +- 0.5443478)% |
 ParticleRangeFilter_a654d6c9           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
- |*"Cut selection efficiency"                      |     14670 |         92 |(0.6271302 +- 0.06517750)% |
-ParticleRangeFilter_f1423675           INFO Number of counters : 1
+ |*"Cut selection efficiency"                      |     14788 |         92 |(0.6221260 +- 0.06465905)% |
+ParticleRangeFilter_f1423675           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        196 |( 98.00000 +- 0.9899495)% |
+ |*"Cut selection efficiency"                      |      2984 |       2226 |( 74.59786 +- 0.7968911)% |
 ParticleRangeFilter_f36346d4           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
 ParticleUnbiasedPVAdder_198323e6       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         6 |
+ | "PV unbiasing successful"                       |         5 |
 ParticleUnbiasedPVAdder_49026aff       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         6 |
+ | "PV unbiasing successful"                       |         5 |
 ParticleWithBremMaker_49ed8ce1         INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of particles corrected with brem (including those without change)"|     12972 |
+ | "Nb of particles corrected with brem (including those without change)"|     11848 |
 ParticleWithBremMaker_49ed8ce1.S...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Delta(E)"                                      |       939 |    4168493 |     4439.3 |     7022.7 |      4.1166 |  1.0097e+05 |
- | "Nb photons added to single electrons"          |     12972 |        939 |   0.072387 |    0.25913 |      0.0000 |      1.0000 |
-PrCloneKillerSeed_c6b4ed23             INFO Number of counters : 2
+ | "Delta(E)"                                      |       853 |    3656898 |     4287.1 |     6897.5 |      4.1118 |  1.0097e+05 |
+ | "Nb photons added to single electrons"          |     11848 |        853 |   0.071995 |    0.25848 |      0.0000 |      1.0000 |
+PrCloneKillerDown_a5a3e1f1             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      13761 |     68.805 |
+ | "nTracksSelected"                               |       200 |       4198 |     20.990 |
+PrCloneKillerSeedDown_72eca869         INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      11527 |     57.635 |
+ | "nTracksSelected"                               |       200 |       8649 |     43.245 |
+PrCloneKillerSeed_ab132ee2             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       200 |      22370 |     111.85 |
- | "nTracksSelected"                               |       200 |      10375 |     51.875 |
-PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
+ | "nTracksSelected"                               |       200 |      11527 |     57.635 |
+PrCloneKillerUp_ac3bf235               INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       103 |       4841 |     47.000 |
+ | "nTracksSelected"                               |       103 |       1658 |     16.097 |
+PrForwardTrackingVelo_a7f67b46         INFO Number of counters : 10
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Accepted input tracks"                         |       200 |      27560 |     137.80 |
  | "Created long tracks"                           |       200 |      13619 |     68.095 |
@@ -516,6 +567,10 @@ PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
  | "Number of x candidates per track 2nd Loop"     |     12499 |      78129 |     6.2508 |     10.990 |
  | "Percentage second loop execution"              |     23780 |      12499 |    0.52561 |
  | "Removed duplicates"                            |       200 |        763 |     3.8150 |
+PrForwardTrackingVelo_a7f67b46.P...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11715 |      46974 |     4.0097 |
+ | "#tracks with hits added"                       |     11715 |
 PrHybridSeeding_97242385               INFO Number of counters : 21
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Created T2x1 three-hit combinations in case 0" |    451880 |     283732 |    0.62789 |    0.63420 |      0.0000 |      6.0000 |
@@ -539,30 +594,60 @@ PrHybridSeeding_97242385               INFO Number of counters : 21
  | "Created two-hit combinations in case 0"        |     64817 |    1590410 |     24.537 |     18.401 |      0.0000 |      119.00 |
  | "Created two-hit combinations in case 1"        |     58134 |    2008013 |     34.541 |     22.781 |      0.0000 |      182.00 |
  | "Created two-hit combinations in case 2"        |     49018 |    2612705 |     53.301 |     35.316 |      1.0000 |      252.00 |
-PrKalmanFilterForward_630360b9         INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       333 |
- | "chi2 cut"                                      |       768 |
- | "nIterations"                                   |      2612 |       7099 |     2.7178 |
- | "nOutlierIterations"                            |      2279 |       2398 |     1.0522 |
- | "nTracksInput"                                  |       200 |       2612 |     13.060 |
- | "nTracksOutput"                                 |       200 |       1511 |     7.5550 |
-PrKalmanFilterMatch_5b2d4ece           INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       272 |
- | "chi2 cut"                                      |       941 |
- | "nIterations"                                   |     13598 |      29488 |     2.1686 |
- | "nOutlierIterations"                            |     13326 |       7057 |    0.52957 |
- | "nTracksInput"                                  |       200 |      13598 |     67.990 |
- | "nTracksOutput"                                 |       200 |      12385 |     61.925 |
-PrLHCbID2MCParticleVPFTMU_7d3ccc1b     INFO Number of counters : 1
+PrKalmanFilterForward_2db16361         INFO Number of counters : 6
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#removed null MCParticles"                     |   1283247 |       2153 |  0.0016778 |
-PrMatchNN_946089ac                     INFO Number of counters : 3
+ | "Pre outlier chi2 cut"                          |       431 |
+ | "chi2 cut"                                      |      2229 |
+ | "nIterations"                                   |     13619 |      31532 |     2.3153 |
+ | "nOutlierIterations"                            |     13188 |      10661 |    0.80839 |
+ | "nTracksInput"                                  |       200 |      13619 |     68.095 |
+ | "nTracksOutput"                                 |       200 |      10959 |     54.795 |
+PrKalmanFilterMatch_6c041d56           INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       329 |
+ | "chi2 cut"                                      |      2118 |
+ | "nIterations"                                   |      3779 |       9262 |     2.4509 |
+ | "nOutlierIterations"                            |      3450 |       4105 |     1.1899 |
+ | "nTracksInput"                                  |       200 |       3779 |     18.895 |
+ | "nTracksOutput"                                 |       200 |       1332 |     6.6600 |
+PrKalmanFilter_Downstream_8fd8655a     INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       551 |
+ | "chi2 cut"                                      |       663 |
+ | "nIterations"                                   |      4198 |      10415 |     2.4809 |
+ | "nOutlierIterations"                            |      3647 |       2175 |    0.59638 |
+ | "nTracksInput"                                  |       200 |       4198 |     20.990 |
+ | "nTracksOutput"                                 |       200 |       2984 |     14.920 |
+PrKalmanFilter_Upstream_202d0d3b       INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |        99 |
+ | "chi2 cut"                                      |       606 |
+ | "nIterations"                                   |      1658 |       3362 |     2.0277 |
+ | "nOutlierIterations"                            |      1559 |       1190 |    0.76331 |
+ | "nTracksInput"                                  |       103 |       1658 |     16.097 |
+ | "nTracksOutput"                                 |       103 |        953 |     9.2524 |
+PrLHCbID2MCParticleVPUTFTMU_dc79...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#removed null MCParticles"                     |   1491997 |       2153 |  0.0014430 |
+PrLongLivedTracking_83484006           INFO Number of counters : 8
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Downstream tracks made"                       |       200 |      13761 |     68.805 |
+ | "#Good XUVcand"                                 |     20447 |     100707 |     4.9253 |
+ | "#Good Xcand"                                   |     20447 |     309532 |     15.138 |
+ | "#Presel hits0"                                 |     20447 |     266212 |     13.020 |
+ | "#Presel hits1"                                 |     20447 |     266757 |     13.046 |
+ | "#Presel hits2"                                 |     20447 |     257397 |     12.588 |
+ | "#Presel hits3"                                 |     20447 |     264194 |     12.921 |
+ | "#Seeds"                                        |       200 |      22370 |     111.85 |
+PrMatchNN_915466c5                     INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#MatchingChi2"                                 |       200 |   231004.2 |     1155.0 |
  | "#MatchingMLP"                                  |     13598 |   11348.87 |    0.83460 |
  | "#MatchingTracks"                               |       200 |      13598 |     67.990 |
+PrMatchNN_915466c5.PrAddUTHitsTool     INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11642 |      46709 |     4.0121 |
+ | "#tracks with hits added"                       |     11642 |
 PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Average X in T1U"                              |     65585 |    1832058 |     27.934 |     1214.1 |     -2656.0 |      2656.4 |
@@ -590,13 +675,26 @@ PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  | "Hits in T3X1"                                  |       800 |      68009 |     85.011 |     36.453 |      23.000 |      264.00 |
  | "Hits in T3X2"                                  |       800 |      74560 |     93.200 |     39.732 |      22.000 |      249.00 |
  | "Total number of hits"                          |       200 |     807039 |     4035.2 |     1656.6 |      1290.0 |      9859.0 |
-PrTrackAssociator_fa20e82b             INFO Number of counters : 2
+PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12972 |      11245 |( 86.68671 +- 0.2982741)% |
- | "MC particles per track"                        |     11245 |      13088 |     1.1639 |
+ | "# RawBank::UT banks"                           |       200 |      43200 |     216.00 |
+ | "# RawBank::UTError banks"                      |       200 |          0 |     0.0000 |
+ |*"Non-unique UT clusters in event"               |       200 |          0 |( 0.000000 +- 0.000000)% |
+PrTrackAssociator_1cbc46b9             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     11848 |      10537 |( 88.93484 +- 0.2881989)% |
+ | "MC particles per track"                        |     10537 |      12221 |     1.1598 |
+PrTrackAssociator_49a0075c             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |      2984 |       2502 |( 83.84718 +- 0.6737037)% |
+ | "MC particles per track"                        |      2502 |       2502 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
+PrVeloUT_daa62e37                      INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#seeds"                                        |       103 |      19278 |     187.17 |
+ | "#tracks"                                       |       103 |       4841 |     47.000 |
 SelectHlt1HltDecReports                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Number of selected banks"                      |       200 |          0 |( 0.000000 +- 0.000000)% |
@@ -609,107 +707,135 @@ SelectHlt1HltSelReports                INFO Number of counters : 1
 SelectiveCombineRawBanks_for_def...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Empty RawBank::View"                           |      1600 |          0 |     0.0000 |     0.0000 | 1.7977e+308 |-1.7977e+308 |
-TBTCForward_ccc11d9d                   INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |      1439 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |      1439 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |      1439 |
-TBTC_Match_20eca874                    INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |     11533 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |     11533 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |     11533 |
+TBTCMatch_c12345b8                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1271 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1271 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1271 |
+TBTC_Forward_4b913e5a                  INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |     10577 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |     10577 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |     10577 |
+TBTC_down_6d7029eb                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      2984 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      2984 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      2984 |
+TBTC_up_36fd2653                       INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |       953 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |       953 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |       953 |
 Test_BdsToPhiPhiCombiner               INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       104 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |       708 |         22 |( 3.107345 +- 0.6521140)% |
- |*"# passed CompositeCut"                         |        22 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed vertex fit"                           |        22 |         22 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       104 |        320 |     3.0769 |
- | "Input2 size"                                   |       104 |        320 |     3.0769 |
- | "candidate multiplicity"                        |       104 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |       100 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |       717 |         15 |( 2.092050 +- 0.5344849)% |
+ |*"# passed CompositeCut"                         |        15 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |        15 |         15 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       100 |        295 |     2.9500 |
+ | "Input2 size"                                   |       100 |        295 |     2.9500 |
+ | "candidate multiplicity"                        |       100 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Bs2JPsiPhiCombiner_67dc4ee3       INFO Number of counters : 8
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        58 |          3 |( 5.172414 +- 2.908037)% |
- |*"# passed CombinationCut"                       |       681 |        126 |( 18.50220 +- 1.488028)% |
- |*"# passed CompositeCut"                         |       126 |          9 |( 7.142857 +- 2.294343)% |
- |*"# passed vertex fit"                           |       126 |        126 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        58 |        154 |     2.6552 |
- | "Input2 size"                                   |        58 |        177 |     3.0517 |
- | "Lifetime fit did not converge. Aborting."      |         6 |
- | "candidate multiplicity"                        |        58 |          9 |    0.15517 |    0.73816 |      0.0000 |      4.0000 |
+ |*"# passed"                                      |        44 |          3 |( 6.818182 +- 3.799912)% |
+ |*"# passed CombinationCut"                       |       409 |         59 |( 14.42543 +- 1.737301)% |
+ |*"# passed CompositeCut"                         |        59 |          3 |( 5.084746 +- 2.860070)% |
+ |*"# passed vertex fit"                           |        59 |         59 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        44 |         89 |     2.0227 |
+ | "Input2 size"                                   |        44 |        129 |     2.9318 |
+ | "Lifetime fit did not converge. Aborting."      |         1 |
+ | "candidate multiplicity"                        |        44 |          3 |   0.068182 |    0.25206 |      0.0000 |      1.0000 |
 Test_Bs2JPsiPhiCombiner_d1451b3c       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        85 |          5 |( 5.882353 +- 2.552123)% |
- |*"# passed CombinationCut"                       |       772 |        128 |( 16.58031 +- 1.338511)% |
- |*"# passed CompositeCut"                         |       128 |          6 |( 4.687500 +- 1.868274)% |
- |*"# passed vertex fit"                           |       128 |        128 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        85 |        214 |     2.5176 |
- | "Input2 size"                                   |        85 |        225 |     2.6471 |
- | "candidate multiplicity"                        |        85 |          6 |   0.070588 |    0.29855 |      0.0000 |      2.0000 |
-Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 5
+ |*"# passed"                                      |        67 |          4 |( 5.970149 +- 2.894597)% |
+ |*"# passed CombinationCut"                       |       590 |         98 |( 16.61017 +- 1.532207)% |
+ |*"# passed CompositeCut"                         |        98 |          5 |( 5.102041 +- 2.222733)% |
+ |*"# passed vertex fit"                           |        98 |         98 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        67 |        154 |     2.2985 |
+ | "Input2 size"                                   |        67 |        183 |     2.7313 |
+ | "candidate multiplicity"                        |        67 |          5 |   0.074627 |    0.31450 |      0.0000 |      2.0000 |
+Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        50 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |         97 |    0.48500 |
- | "Input2 size"                                   |       200 |         97 |    0.48500 |
+ |*"# passed CombinationCut"                       |        48 |          2 |( 4.166667 +- 2.884244)% |
+ |*"# passed CompositeCut"                         |         2 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |         2 |          2 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |         92 |    0.46000 |
+ | "Input2 size"                                   |       200 |         92 |    0.46000 |
  | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_LambdaFromHyperon_LL     INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          9 |( 4.500000 +- 1.465862)% |
- |*"# passed CombinationCut"                       |       941 |         20 |( 2.125399 +- 0.4701759)% |
- |*"# passed CompositeCut"                         |        20 |         11 |( 55.00000 +- 11.12430)% |
- |*"# passed vertex fit"                           |        20 |         20 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |        206 |     1.0300 |
- | "Input2 size"                                   |       200 |       1045 |     5.2250 |
- | "candidate multiplicity"                        |       200 |         11 |   0.055000 |    0.28631 |      0.0000 |      3.0000 |
-Test_Hyperons_Lambda_DD                INFO Number of counters : 4
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |          0 |     0.0000 |
- | "Input2 size"                                   |       200 |          0 |     0.0000 |
- | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-Test_Hyperons_Xim_LLL                  INFO Number of counters : 7
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |         9 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        71 |          2 |( 2.816901 +- 1.963595)% |
- |*"# passed CompositeCut"                         |         2 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed vertex fit"                           |         2 |          2 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |         9 |         11 |     1.2222 |
- | "Input2 size"                                   |         9 |        117 |     13.000 |
- | "candidate multiplicity"                        |         9 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |       200 |          6 |( 3.000000 +- 1.206234)% |
+ |*"# passed CombinationCut"                       |       779 |         13 |( 1.668806 +- 0.4589653)% |
+ |*"# passed CompositeCut"                         |        13 |          6 |( 46.15385 +- 13.82642)% |
+ |*"# passed vertex fit"                           |        13 |         13 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        191 |    0.95500 |
+ | "Input2 size"                                   |       200 |        992 |     4.9600 |
+ | "candidate multiplicity"                        |       200 |          6 |   0.030000 |    0.17059 |      0.0000 |      1.0000 |
+Test_Hyperons_Lambda_DD                INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |          5 |( 2.500000 +- 1.103970)% |
+ |*"# passed CombinationCut"                       |      2032 |         16 |(0.7874016 +- 0.1960739)% |
+ |*"# passed CompositeCut"                         |        16 |          6 |( 37.50000 +- 12.10307)% |
+ |*"# passed vertex fit"                           |        16 |         16 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        239 |     1.1950 |
+ | "Input2 size"                                   |       200 |       2226 |     11.130 |
+ | "candidate multiplicity"                        |       200 |          6 |   0.030000 |    0.19774 |      0.0000 |      2.0000 |
+Test_Hyperons_Xic0ToL0PimPip_DD        INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         5 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed Combination12Cut"                     |         9 |          1 |( 11.11111 +- 10.47566)% |
+ |*"# passed CombinationCut"                       |         2 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         5 |          6 |     1.2000 |
+ | "Input2 size"                                   |         5 |         15 |     3.0000 |
+ | "Input3 size"                                   |         5 |         15 |     3.0000 |
+ | "candidate multiplicity"                        |         5 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+Test_Hyperons_Xim_LLL                  INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         6 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |        44 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         6 |          6 |     1.0000 |
+ | "Input2 size"                                   |         6 |         78 |     13.000 |
+ | "candidate multiplicity"                        |         6 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_MassConstrJpsi2MuMuMaker          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         85 |( 42.50000 +- 3.495533)% |
- |*"# passed CombinationCut"                       |     51314 |        217 |(0.4228865 +- 0.02864664)% |
- |*"# passed CompositeCut"                         |       217 |        214 |( 98.61751 +- 0.7926435)% |
- |*"# passed vertex fit"                           |       217 |        217 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12972 |     64.860 |
- | "Input2 size"                                   |       200 |       2129 |     10.645 |
- | "candidate multiplicity"                        |       200 |        214 |     1.0700 |     1.7650 |      0.0000 |      12.000 |
+ |*"# passed"                                      |       200 |         67 |( 33.50000 +- 3.337477)% |
+ |*"# passed CombinationCut"                       |     42369 |        158 |(0.3729142 +- 0.02961209)% |
+ |*"# passed CompositeCut"                         |       158 |        154 |( 97.46835 +- 1.249697)% |
+ |*"# passed vertex fit"                           |       158 |        158 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11848 |     59.240 |
+ | "Input2 size"                                   |       200 |       1890 |     9.4500 |
+ | "candidate multiplicity"                        |       200 |        154 |    0.77000 |     1.5675 |      0.0000 |      12.000 |
 Test_Phi2KKMaker                       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |        104 |( 52.00000 +- 3.532704)% |
- |*"# passed CombinationCut"                       |    192068 |      13136 |( 6.839244 +- 0.05759610)% |
- |*"# passed CompositeCut"                         |     13136 |        320 |( 2.436054 +- 0.1345106)% |
- |*"# passed vertex fit"                           |     13136 |      13136 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12972 |     64.860 |
- | "Input2 size"                                   |       200 |       7888 |     39.440 |
- | "candidate multiplicity"                        |       200 |        320 |     1.6000 |     2.4739 |      0.0000 |      14.000 |
+ |*"# passed"                                      |       200 |        100 |( 50.00000 +- 3.535534)% |
+ |*"# passed CombinationCut"                       |    156405 |       9767 |( 6.244685 +- 0.06118260)% |
+ |*"# passed CompositeCut"                         |      9767 |        295 |( 3.020375 +- 0.1731769)% |
+ |*"# passed vertex fit"                           |      9767 |       9767 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11848 |     59.240 |
+ | "Input2 size"                                   |       200 |       7205 |     36.025 |
+ | "candidate multiplicity"                        |       200 |        295 |     1.4750 |     2.5435 |      0.0000 |      20.000 |
 Test_Pi0ToGammaGamma_Combiner          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |         81 |( 40.50000 +- 3.471131)% |
- |*"# passed CombinationCut"                       |     40235 |        137 |(0.3404996 +- 0.02904127)% |
- |*"# passed CompositeCut"                         |       137 |        137 |( 100.0000 +- 0.000000)% |
- |*"# passed vertex fit"                           |       137 |        137 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |       3663 |     18.315 |
- | "Input2 size"                                   |       200 |       3663 |     18.315 |
- | "candidate multiplicity"                        |       200 |        137 |    0.68500 |     1.0324 |      0.0000 |      4.0000 |
+ |*"# passed CombinationCut"                       |     40689 |        138 |(0.3391580 +- 0.02882205)% |
+ |*"# passed CompositeCut"                         |       138 |        138 |( 100.0000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |       138 |        138 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |       3684 |     18.420 |
+ | "Input2 size"                                   |       200 |       3684 |     18.420 |
+ | "candidate multiplicity"                        |       200 |        138 |    0.69000 |     1.0363 |      0.0000 |      4.0000 |
 TrackBeamLineVertexFinderSoA_609...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fraction of failed PV fits"                    |      1020 |          0 |( 0.000000 +- 0.000000)% |
  |*"Fraction of unconverged PV fits"               |      1020 |         68 |( 6.666667 +- 0.7810389)% |
  | "Nb PVs"                                        |       200 |        997 |     4.9850 |
+UTHitClustersToPrUTHitsConverter...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
+UTHitClustersToUTHitHandlerConve...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
 VPLightClustersToVPMicroClusters...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# Converted Clusters"                          |       200 |     420481 |     2102.4 |
@@ -732,15 +858,18 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
  | "Nb of Produced Tracks"                         |       200 |      46336 |     231.68 |
-fromPrSeedingTracksV1Tracks_4ebf...    INFO Number of counters : 1
+fromPrSeedingTracksV1Tracks_1499...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of converted Tracks"                        |       200 |      10375 |     51.875 |
+ | "Nb of converted Tracks"                        |       200 |       8649 |     43.245 |
 fromPrVeloTracksV1TracksMerger_8...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of converted Tracks"                        |       200 |      46336 |     231.68 |
+fromV2MuonPIDV1MuonPIDDownstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of Produced MuonPIDs"                       |       200 |       2984 |     14.920 |
 fromV2MuonPIDV1MuonPIDLong_e60c416d    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced MuonPIDs"                       |       200 |      12972 |     64.860 |
+ | "Nb of Produced MuonPIDs"                       |       200 |      11848 |     59.240 |
 require_pvs                            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.detdesc b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.detdesc
index 54d0eaa117b..0829136efa7 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.detdesc
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.detdesc
@@ -1,39 +1,39 @@
 CopyInputStream_c601f8ec               INFO Events output: 200
 GraphClustering_72971694               INFO Built <171.765> graph calo clustering clusters/event
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Skip'     map has the size 0
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has the size 0
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Codes'    map has the size 0
+TransportSvc                           INFO Reset the static pointer to DetDesc::IGeometyrErrorSvc
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 CaloAcceptanceBremAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2436 |     12.180 |     9.3882 |      0.0000 |      56.000 |
+ | "#tracks in acceptance"                         |       200 |       1845 |     9.2250 |     7.1081 |      0.0000 |      41.000 |
 CaloAcceptanceBremAlg_Long_142dbbc6    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12964 |     64.820 |     42.896 |      2.0000 |      246.00 |
- | "#tracks in acceptance"                         |       200 |       9504 |     47.520 |     31.082 |      1.0000 |      178.00 |
-CaloAcceptanceBremAlg_Upstream_3...    INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |      12498 |     62.490 |     39.922 |      2.0000 |      221.00 |
+ | "#tracks in acceptance"                         |       200 |       9240 |     46.200 |     29.410 |      1.0000 |      166.00 |
 CaloAcceptanceEcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2436 |     12.180 |     9.3882 |      0.0000 |      56.000 |
+ | "#tracks in acceptance"                         |       200 |       1921 |     9.6050 |     7.5689 |      0.0000 |      47.000 |
 CaloAcceptanceEcalAlg_Long_71599283    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12964 |     64.820 |     42.896 |      2.0000 |      246.00 |
- | "#tracks in acceptance"                         |       200 |      10869 |     54.345 |     36.189 |      2.0000 |      204.00 |
+ | "#total tracks"                                 |       200 |      12498 |     62.490 |     39.922 |      2.0000 |      221.00 |
+ | "#tracks in acceptance"                         |       200 |      10551 |     52.755 |     34.031 |      2.0000 |      185.00 |
 CaloAcceptanceEcalAlg_Ttrack_b29...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      10386 |     51.930 |     52.131 |      0.0000 |      480.00 |
- | "#tracks in acceptance"                         |       200 |       8360 |     41.800 |     44.580 |      0.0000 |      420.00 |
+ | "#total tracks"                                 |       200 |       8580 |     42.900 |     47.814 |      0.0000 |      446.00 |
+ | "#tracks in acceptance"                         |       200 |       6897 |     34.485 |     41.100 |      0.0000 |      391.00 |
 CaloAcceptanceHcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2436 |     12.180 |     9.3882 |      0.0000 |      56.000 |
+ | "#tracks in acceptance"                         |       200 |       1733 |     8.6650 |     6.8237 |      0.0000 |      43.000 |
 CaloAcceptanceHcalAlg_Long_1fd97970    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12964 |     64.820 |     42.896 |      2.0000 |      246.00 |
- | "#tracks in acceptance"                         |       200 |      10210 |     51.050 |     34.038 |      2.0000 |      194.00 |
+ | "#total tracks"                                 |       200 |      12498 |     62.490 |     39.922 |      2.0000 |      221.00 |
+ | "#tracks in acceptance"                         |       200 |       9933 |     49.665 |     32.100 |      2.0000 |      174.00 |
 CaloClusterMCTruth_b1e9f302            INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#CC2MC links"                                  |       200 |     605266 |     3026.3 |
@@ -56,8 +56,8 @@ CaloFutureHypoMCTruth_b7aaff7e         INFO Number of counters : 2
  | "#links/hypo"                                   |       784 |      25174 |     32.110 |
 CaloFutureHypoMCTruth_db59dc13         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links"                                        |       200 |     370224 |     1851.1 |
- | "#links/hypo"                                   |     22649 |     370224 |     16.346 |
+ | "#links"                                        |       200 |     372974 |     1864.9 |
+ | "#links/hypo"                                   |     22786 |     372974 |     16.369 |
 CaloFutureMergedPi0_ee84f6b4           INFO Number of counters : 12
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cluster without 2nd seed found"                |       784 |          0 |( 0.000000 +- 0.000000)% |
@@ -86,164 +86,190 @@ CaloFutureMergedPi0_ee84f6b4.Eca...    INFO Number of counters : 3
  | "Corrected Clusters: # cells "                  |       184 |       1047 |     5.6902 |     1.6865 |      3.0000 |      9.0000 |
  | "Corrected Clusters: ET"                        |       184 |     165779 |     900.97 |     881.51 |      3.6000 |      7563.0 |
  | "Corrected Clusters: size ratio"                |       184 |   85.97536 |    0.46726 |    0.46258 |    0.015364 |      2.2345 |
-CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 1
+CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |        575 |     2.8750 |     3.1240 |      0.0000 |      16.000 |
+ | "average chi2"                                  |       575 |   2413.018 |     4.1966 |     5.2703 |   0.0039769 |      39.870 |
+ | "average energy (track based)"                  |      1845 |   116956.4 |     63.391 |     269.58 |      0.0000 |      6128.3 |
 CaloSelectiveBremMatchAlg_Long_2...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       3452 |     17.260 |     15.986 |      0.0000 |      78.000 |
- | "average chi2"                                  |      3452 |   3289.105 |    0.95281 |     1.8756 |  6.7958e-07 |      37.830 |
- | "average energy (track based)"                  |      9504 |   162040.6 |     17.050 |     49.668 |      0.0000 |      1334.7 |
-CaloSelectiveBremMatchAlg_Upstre...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       3359 |     16.795 |     15.226 |      0.0000 |      71.000 |
+ | "average chi2"                                  |      3359 |   3412.895 |     1.0160 |     1.9636 |  6.5390e-07 |      42.029 |
+ | "average energy (track based)"                  |      9240 |   155998.9 |     16.883 |     49.335 |      0.0000 |      1290.8 |
+CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       1747 |     8.7350 |     7.1010 |      0.0000 |      44.000 |
+ | "average chi2"                                  |      1747 |   27191.75 |     15.565 |     36.646 |   0.0010210 |      777.43 |
 CaloSelectiveElectronMatchAlg_Lo...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#above threshold"                              |         1 |          1 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#links in table"                               |       200 |       8935 |     44.675 |     32.483 |      2.0000 |      179.00 |
- | "average chi2"                                  |      8935 |   43145.07 |     4.8288 |     11.463 |  0.00020047 |      412.84 |
-CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 1
+ | "#above threshold"                              |         2 |          2 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#links in table"                               |       200 |       8620 |     43.100 |     30.544 |      2.0000 |      161.00 |
+ | "average chi2"                                  |      8620 |   43606.17 |     5.0587 |     11.847 |  0.00021641 |      413.01 |
+CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       1754 |     8.7700 |     7.1061 |      0.0000 |      44.000 |
+ | "average chi2"                                  |      1754 |   1069.374 |    0.60968 |     1.0178 |  1.3625e-05 |      12.252 |
 CaloSelectiveTrackMatchAlg_Long_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       9041 |     45.205 |     32.610 |      2.0000 |      181.00 |
- | "average chi2"                                  |      9041 |    1336.86 |    0.14787 |    0.28428 |  3.1370e-06 |      8.8273 |
+ | "#links in table"                               |       200 |       8725 |     43.625 |     30.684 |      2.0000 |      163.00 |
+ | "average chi2"                                  |      8725 |   1339.305 |    0.15350 |    0.29480 |  2.3415e-06 |      8.8202 |
 CaloSelectiveTrackMatchAlg_Ttrac...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       6810 |     34.050 |     32.839 |      0.0000 |      298.00 |
- | "average chi2"                                  |      6810 |     431.45 |   0.063355 |    0.12104 |  2.2528e-06 |      4.0928 |
+ | "#links in table"                               |       200 |       5472 |     27.360 |     29.495 |      0.0000 |      273.00 |
+ | "average chi2"                                  |      5472 |   435.5635 |   0.079599 |    0.14687 |  2.7321e-06 |      4.0928 |
 CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "average DLL"                                   |     10869 |  -627.2637 |  -0.057711 |    0.10536 |     -2.7103 |     0.57343 |
- | "average E/p"                                   |     10869 |   70.00511 |  0.0064408 |  0.0094522 |      0.0000 |     0.16104 |
+ | "average DLL"                                   |      1921 |  -212.9238 |   -0.11084 |    0.57204 |     -7.3665 |      3.4989 |
+ | "average E/p"                                   |      1921 |   107.3771 |   0.055896 |   0.081097 |      0.0000 |     0.93272 |
+CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "average DLL"                                   |     10551 |  -638.2821 |  -0.060495 |    0.10761 |     -2.6777 |     0.58154 |
+ | "average E/p"                                   |     10551 |   68.72462 |  0.0065136 |  0.0096549 |      0.0000 |     0.16108 |
+CaloTrackToHcalEnergyAlg_Downstr...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "energy (calo) associated to track"             |      1733 |    4631046 |     2672.3 |     5556.8 |      0.0000 |      90279. |
 CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "energy (calo) associated to track"             |     10210 |4.488601e+07 |     4396.3 |     8211.7 |      0.0000 |  1.2332e+05 |
+ | "energy (calo) associated to track"             |      9933 |4.435574e+07 |     4465.5 |     8211.4 |      0.0000 |  1.2332e+05 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12964 |      11233 |( 86.64764 +- 0.2987362)% |
- | "MC particles per ProtoParticle"                |     11233 |      13072 |     1.1637 |
+ |*"Efficiency"                                    |      2436 |       1966 |( 80.70608 +- 0.7995116)% |
+ | "MC particles per ProtoParticle"                |      1966 |       1966 |     1.0000 |
+ChargedProtoParticleAssociator_9...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     12498 |      11198 |( 89.59834 +- 0.2730745)% |
+ | "MC particles per ProtoParticle"                |     11198 |      12998 |     1.1607 |
+ChargedProtoParticleMaker_Downst...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "CreatedProtos"                                 |      2436 |
 ChargedProtoParticleMaker_Long_b...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "CreatedProtos"                                 |     12964 |
+ | "CreatedProtos"                                 |     12498 |
 ClassifyPhotonElectronAlg_5a60ece2     INFO Number of counters : 14
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Electron Delta(E)"                             |     12360 |   -5127365 |    -414.84 |     551.48 |     -5759.4 |      2744.3 |
- | "Electron Delta(X)"                             |     12360 |  -5313.128 |   -0.42986 |     12.284 |     -91.805 |      29.057 |
- | "Electron Delta(Y)"                             |     12360 |  -3329.464 |   -0.26937 |     12.300 |     -72.810 |      22.669 |
- | "Electron Delta(Z)"                             |     12360 |   808130.3 |     65.383 |     14.051 |     -10.804 |      123.98 |
- | "Electron corrected energy"                     |     12360 |7.60593e+07 |     6153.7 |     7311.8 |      19.715 |  1.2204e+05 |
- | "Electrons pT-rejected after correction"        |       118 |
- | "Photon Delta(E)"                               |     23069 |   -5466447 |    -236.96 |     396.26 |     -4040.0 |      2229.9 |
- | "Photon Delta(X)"                               |     23069 |  -8754.517 |   -0.37949 |     12.696 |     -91.984 |      62.040 |
- | "Photon Delta(Y)"                               |     23069 |  -5285.444 |   -0.22911 |     12.658 |     -91.966 |      61.225 |
- | "Photon Delta(Z)"                               |     23069 |    1275818 |     55.304 |     13.048 |     -8.7578 |      123.98 |
- | "Photon corrected energy"                       |     23069 |7.961668e+07 |     3451.2 |     5804.5 |      22.782 |  1.2653e+05 |
- | "Photons pT-rejected after correction"          |       420 |
- | "electronHypos"                                 |       200 |      12242 |     61.210 |     37.128 |      4.0000 |      218.00 |
- | "photonHypos"                                   |       200 |      22649 |     113.25 |     49.362 |      10.000 |      235.00 |
+ | "Electron Delta(E)"                             |     12344 |   -5124228 |    -415.12 |     551.89 |     -5759.4 |      2744.3 |
+ | "Electron Delta(X)"                             |     12344 |  -5430.585 |   -0.43994 |     12.274 |     -91.805 |      29.057 |
+ | "Electron Delta(Y)"                             |     12344 |  -3309.763 |   -0.26813 |     12.295 |     -72.810 |      22.669 |
+ | "Electron Delta(Z)"                             |     12344 |   807200.4 |     65.392 |     14.043 |     -10.804 |      123.98 |
+ | "Electron corrected energy"                     |     12344 |7.601621e+07 |     6158.2 |     7315.4 |      19.715 |  1.2204e+05 |
+ | "Electrons pT-rejected after correction"        |       116 |
+ | "Photon Delta(E)"                               |     23207 |   -5513275 |    -237.57 |     396.43 |     -4040.0 |      2229.9 |
+ | "Photon Delta(X)"                               |     23207 |  -8484.632 |   -0.36561 |     12.688 |     -91.984 |      62.040 |
+ | "Photon Delta(Y)"                               |     23207 |  -5086.123 |   -0.21916 |     12.649 |     -91.966 |      61.225 |
+ | "Photon Delta(Z)"                               |     23207 |    1284018 |     55.329 |     13.056 |     -8.7578 |      123.98 |
+ | "Photon corrected energy"                       |     23207 |8.025058e+07 |     3458.0 |     5800.5 |      22.782 |  1.2653e+05 |
+ | "Photons pT-rejected after correction"          |       421 |
+ | "electronHypos"                                 |       200 |      12228 |     61.140 |     37.099 |      4.0000 |      221.00 |
+ | "photonHypos"                                   |       200 |      22786 |     113.93 |     49.897 |      10.000 |      237.00 |
 ClassifyPhotonElectronAlg_5a60ec...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "<alpha> Inner"                                 |     10032 |   9976.066 |    0.99442 |   0.019632 |     0.96439 |      1.1318 |
- | "<alpha> Middle"                                |      9321 |   9379.046 |     1.0062 |   0.020792 |     0.97670 |      1.2128 |
- | "<alpha> Outer"                                 |     15987 |   15977.82 |    0.99943 |   0.016326 |     0.97368 |      1.1242 |
- | "Pileup offset"                                 |     35340 |1.30783e+07 |     370.07 |     438.72 |      2.6870 |      4736.9 |
- | "Pileup scale"                                  |     35429 |     201670 |     5.6922 |     2.0229 |      1.0000 |      12.000 |
- | "Pileup subtracted ratio"                       |     35340 |    31069.3 |    0.87915 |    0.12332 |  0.00021643 |     0.99914 |
- | "Skip negative energy correction"               |        89 |
-CloneKillerForward_88e428e1            INFO Number of counters : 2
+ | "<alpha> Inner"                                 |     10078 |   10021.81 |    0.99442 |   0.019610 |     0.96439 |      1.1318 |
+ | "<alpha> Middle"                                |      9360 |   9418.334 |     1.0062 |   0.020798 |     0.97670 |      1.2128 |
+ | "<alpha> Outer"                                 |     16023 |   16014.09 |    0.99944 |   0.016330 |     0.97368 |      1.1242 |
+ | "Pileup offset"                                 |     35461 |1.313184e+07 |     370.32 |     438.68 |      2.6870 |      4736.9 |
+ | "Pileup scale"                                  |     35551 |     202401 |     5.6933 |     2.0230 |      1.0000 |      12.000 |
+ | "Pileup subtracted ratio"                       |     35461 |   31176.21 |    0.87917 |    0.12324 |  0.00021643 |     0.99914 |
+ | "Skip negative energy correction"               |        90 |
+CloneKillerMatch_a528b1df              INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "nTracksInput"                                  |       200 |      13621 |     68.105 |
- | "nTracksSelected"                               |       200 |       2579 |     12.895 |
+ | "nTracksInput"                                  |       200 |      13652 |     68.260 |
+ | "nTracksSelected"                               |       200 |       3140 |     15.700 |
 CopySignalMCParticles_daf3c6a8         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"copy signal"                                   |   1061346 |          0 |( 0.000000 +- 0.000000)% |
  |*"input container present"                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |       400 |     408470 |     1021.2 |     1472.0 |      2.0000 |      7400.0 |
+ | "# of cloned entries"                           |       400 |     413112 |     1032.8 |     1478.9 |      2.0000 |      7433.0 |
  |*"Input container absent"                        |       400 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |    190749 |     190749 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |    101981 |      90853 |( 89.08816 +- 0.09763360)% |
+ |*"MCParticles cloned"                            |    192056 |     192056 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |    104250 |      91475 |( 87.74580 +- 0.1015588)% |
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |       200 |
  | "Nb events removed"                             |        24 |
 FilteredPIDElectrons                   INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        180 |( 90.00000 +- 2.121320)% |
- |*"Cut selection efficiency"                      |     12964 |       1379 |( 10.63715 +- 0.2707831)% |
+ |*"#passed"                                       |       200 |        177 |( 88.50000 +- 2.255826)% |
+ |*"Cut selection efficiency"                      |     12498 |       1247 |( 9.977596 +- 0.2680822)% |
 FilteredPIDMuons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        192 |( 96.00000 +- 1.385641)% |
- |*"Cut selection efficiency"                      |     12964 |       2112 |( 16.29127 +- 0.3243346)% |
+ |*"#passed"                                       |       200 |        193 |( 96.50000 +- 1.299519)% |
+ |*"Cut selection efficiency"                      |     12498 |       2003 |( 16.02656 +- 0.3281489)% |
 FilteredPIDkaons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     12964 |       7700 |( 59.39525 +- 0.4313152)% |
-FunctionalParticleMaker_149889e6       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"Cut selection efficiency"                      |     12498 |       7169 |( 57.36118 +- 0.4423758)% |
+FunctionalParticleMaker_149889e6       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        194 |( 97.00000 +- 1.206234)% |
+ |*"# passed ProtoParticle filter"                 |      2436 |       2177 |( 89.36782 +- 0.6245442)% |
+ |*"# passed Track filter"                         |      2436 |       2436 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1100 |     5.5000 |     4.4933 |      0.0000 |      26.000 |
+ | "Nb created particles"                          |       200 |       1077 |     5.3850 |     4.2693 |      0.0000 |      24.000 |
 FunctionalParticleMaker_2ff3f10f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12279 |( 94.71614 +- 0.1964800)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6140 |     30.700 |     20.890 |      1.0000 |      126.00 |
- | "Nb created particles"                          |       200 |       6139 |     30.695 |     20.085 |      1.0000 |      112.00 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      11967 |( 95.75132 +- 0.1804177)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6008 |     30.040 |     19.931 |      1.0000 |      116.00 |
+ | "Nb created particles"                          |       200 |       5959 |     29.795 |     18.849 |      1.0000 |      101.00 |
 FunctionalParticleMaker_379cf33a       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6482 |     32.410 |     22.123 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6482 |     32.410 |     21.239 |      1.0000 |      116.00 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6291 |     31.455 |     20.787 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       6207 |     31.035 |     19.638 |      1.0000 |      104.00 |
+FunctionalParticleMaker_442c3d96       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         3 |          3 |( 100.0000 +- 0.000000)% |
+ |*"# passed ProtoParticle filter"                 |       183 |        177 |( 96.72131 +- 1.316393)% |
+ |*"# passed Track filter"                         |       183 |        183 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |         3 |         91 |     30.333 |     16.438 |      9.0000 |      49.000 |
+ | "Nb created particles"                          |         3 |         86 |     28.667 |     14.974 |      8.0000 |      43.000 |
 FunctionalParticleMaker_950c4697       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12279 |( 94.71614 +- 0.1964800)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6140 |     30.700 |     20.890 |      1.0000 |      126.00 |
- | "Nb created particles"                          |       200 |       6139 |     30.695 |     20.085 |      1.0000 |      112.00 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      11967 |( 95.75132 +- 0.1804177)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6008 |     30.040 |     19.931 |      1.0000 |      116.00 |
+ | "Nb created particles"                          |       200 |       5959 |     29.795 |     18.849 |      1.0000 |      101.00 |
 FunctionalParticleMaker_9614a368       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6482 |     32.410 |     22.123 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6482 |     32.410 |     21.239 |      1.0000 |      116.00 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6291 |     31.455 |     20.787 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       6207 |     31.035 |     19.638 |      1.0000 |      104.00 |
 FunctionalParticleMaker_a90be71f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6482 |     32.410 |     22.123 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6482 |     32.410 |     21.239 |      1.0000 |      116.00 |
-FunctionalParticleMaker_c5ad9787       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6291 |     31.455 |     20.787 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       6207 |     31.035 |     19.638 |      1.0000 |      104.00 |
+FunctionalParticleMaker_c5ad9787       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        194 |( 97.00000 +- 1.206234)% |
+ |*"# passed ProtoParticle filter"                 |      2436 |       2436 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |      2436 |       2436 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1226 |     6.1300 |     5.0302 |      0.0000 |      27.000 |
+ | "Nb created particles"                          |       200 |       1210 |     6.0500 |     4.8381 |      0.0000 |      29.000 |
 FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12964 |      12964 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6482 |     32.410 |     22.123 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6482 |     32.410 |     21.239 |      1.0000 |      116.00 |
+ |*"# passed ProtoParticle filter"                 |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12498 |      12498 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6291 |     31.455 |     20.787 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       6207 |     31.035 |     19.638 |      1.0000 |      104.00 |
 FutureNeutralProtoPAlg_70ea5ecd        INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Neutral Protos"                                |       200 |      25001 |     125.00 |     60.330 |      10.000 |      301.00 |
+ | "Neutral Protos"                                |       200 |      25138 |     125.69 |     60.871 |      10.000 |      303.00 |
  | "Neutral Protos from MergedPi0s"                |       200 |        784 |     3.9200 |     4.6102 |      0.0000 |      24.000 |
- | "Neutral Protos from Photons"                   |       200 |      22649 |     113.25 |     49.362 |      10.000 |      235.00 |
+ | "Neutral Protos from Photons"                   |       200 |      22786 |     113.93 |     49.897 |      10.000 |      237.00 |
  | "Neutral Protos from SplitPhotons"              |       200 |       1568 |     7.8400 |     9.2203 |      0.0000 |      48.000 |
 GraphClustering_72971694               INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
@@ -283,13 +309,13 @@ Hlt2Test_Bs0ToJpsiPhi_JPsiToMupM...    INFO Number of counters : 1
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         66 |( 33.00000 +- 3.324906)% |
- |*"# passed CombinationCut"                       |     69462 |        170 |(0.2447381 +- 0.01874757)% |
- |*"# passed CompositeCut"                         |       170 |        165 |( 97.05882 +- 1.295847)% |
- |*"# passed vertex fit"                           |       170 |        170 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12964 |     64.820 |
- | "Input2 size"                                   |       200 |       1379 |     6.8950 |
- | "candidate multiplicity"                        |       200 |        165 |    0.82500 |     1.7591 |      0.0000 |      12.000 |
+ |*"# passed"                                      |       200 |         64 |( 32.00000 +- 3.298485)% |
+ |*"# passed CombinationCut"                       |     58436 |        166 |(0.2840715 +- 0.02201688)% |
+ |*"# passed CompositeCut"                         |       166 |        158 |( 95.18072 +- 1.662308)% |
+ |*"# passed vertex fit"                           |       166 |        166 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      12498 |     62.490 |
+ | "Input2 size"                                   |       200 |       1247 |     6.2350 |
+ | "candidate multiplicity"                        |       200 |        158 |    0.79000 |     1.5862 |      0.0000 |      10.000 |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
@@ -323,67 +349,65 @@ Hlt2Test_sRTPhotons_Prescaler          INFO Number of counters : 1
 HltDecReportsFilter_895ecf8e           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_d2b05f88         INFO Number of counters : 2
+HltPackedBufferWriter_18f93d32         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |       200 |3.612245e+07 | 1.8061e+05 | 1.1447e+05 |      12764. |  6.4036e+05 |
+ | "Size of serialized data"                       |       200 |     567678 |     2838.4 |     3914.8 |      108.00 |      24579. |
 Hlt__RoutingBitsCombiner_6642b907      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |       200 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Events without Tracks"                   |         1 |          0 |     0.0000 |
- | "Nb of Produced Tracks"                         |       199 |      10386 |     52.191 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |       200 |      12964 |     64.820 |
+ | "Nb of Produced Tracks"                         |       199 |       8580 |     43.116 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
+ | "Nb of Produced Tracks"                         |       200 |      12498 |     62.490 |
+LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
+ | "Nb of Events without Tracks"                   |         6 |          0 |     0.0000 |
+ | "Nb of Produced Tracks"                         |       194 |       2436 |     12.557 |
 LHCb__Phys__ParticleMakers__Phot...    INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- | "Confidence Level"                              |     14691 |   5012.347 |    0.34118 |    0.33103 |  7.0212e-05 |     0.99473 |
- | "Created photons"                               |     22649 |
- | "Selected photons"                              |       200 |      14691 |     73.455 |     38.555 |      4.0000 |      185.00 |
-LHCb__SelectivePacker_c6eaf391         INFO Number of counters : 75
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BremInfos # containers packed"                 |       200 |        200 |     1.0000 |
- | "BremInfos # of packed entries"                 |       200 |       9504 |     47.520 |
- | "BremInfos buffer size"                         |       200 |     403568 |     2017.8 |
+ | "Confidence Level"                              |     14805 |   5029.775 |    0.33973 |    0.33077 |  7.0212e-05 |     0.99473 |
+ | "Created photons"                               |     22786 |
+ | "Selected photons"                              |       200 |      14805 |     74.025 |     39.047 |      4.0000 |      186.00 |
+LHCb__SelectivePacker_e4994c30         INFO Number of counters : 75
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BremInfos # containers packed"                 |       200 |         14 |   0.070000 |
+ | "BremInfos # of packed entries"                 |        14 |         56 |     4.0000 |
+ | "BremInfos buffer size"                         |        14 |       2660 |     190.00 |
  | "BremInfosSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "CaloAdcs # containers packed"                  |       200 |          0 |     0.0000 |
- | "CaloChargedPIDs # containers packed"           |       200 |        200 |     1.0000 |
- | "CaloChargedPIDs # of packed entries"           |       200 |      10963 |     54.815 |
- | "CaloChargedPIDs buffer size"                   |       200 |     662180 |     3310.9 |
+ | "CaloChargedPIDs # containers packed"           |       200 |         14 |   0.070000 |
+ | "CaloChargedPIDs # of packed entries"           |        14 |         59 |     4.2143 |
+ | "CaloChargedPIDs buffer size"                   |        14 |       3848 |     274.86 |
  | "CaloChargedPIDsSelection # containers packed"  |       200 |          0 |     0.0000 |
  | "CaloClusters # containers packed"              |       200 |          0 |     0.0000 |
  | "CaloClustersSelection # containers packed"     |       200 |          0 |     0.0000 |
  | "CaloDigits # containers packed"                |       200 |          0 |     0.0000 |
- | "CaloHypos # containers packed"                 |       200 |        800 |     4.0000 |
- | "CaloHypos # of packed entries"                 |       800 |      37243 |     46.554 |
- | "CaloHypos buffer size"                         |       800 |    2864464 |     3580.6 |
+ | "CaloHypos # containers packed"                 |       200 |        118 |    0.59000 |
+ | "CaloHypos # of packed entries"                 |       118 |        420 |     3.5593 |
+ | "CaloHypos buffer size"                         |       118 |      34988 |     296.51 |
  | "CaloHyposSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "ExtendedPVs # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTags # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTagsSelection # containers packed"      |       200 |          0 |     0.0000 |
- | "GlobalChargedPIDs # containers packed"         |       200 |        200 |     1.0000 |
- | "GlobalChargedPIDs # of packed entries"         |       200 |      12964 |     64.820 |
- | "GlobalChargedPIDs buffer size"                 |       200 |     730384 |     3651.9 |
+ | "GlobalChargedPIDs # containers packed"         |       200 |         14 |   0.070000 |
+ | "GlobalChargedPIDs # of packed entries"         |        14 |         72 |     5.1429 |
+ | "GlobalChargedPIDs buffer size"                 |        14 |       4340 |     310.00 |
  | "GlobalChargedPIDsSelection # containers packed"|       200 |          0 |     0.0000 |
- | "LightPVs # containers packed"                  |       200 |         12 |   0.060000 |
- | "LightPVs # of packed entries"                  |        12 |         18 |     1.5000 |
- | "LightPVs buffer size"                          |        12 |       1092 |     91.000 |
+ | "LightPVs # containers packed"                  |       200 |         18 |   0.090000 |
+ | "LightPVs # of packed entries"                  |        18 |         24 |     1.3333 |
+ | "LightPVs buffer size"                          |        18 |       1500 |     83.333 |
  | "LightPVsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "MuonPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "MuonPIDs # of packed entries"                  |       200 |      12964 |     64.820 |
- | "MuonPIDs buffer size"                          |       200 |     783732 |     3918.7 |
+ | "MuonPIDs # containers packed"                  |       200 |         14 |   0.070000 |
+ | "MuonPIDs # of packed entries"                  |        14 |         72 |     5.1429 |
+ | "MuonPIDs buffer size"                          |        14 |       4700 |     335.71 |
  | "MuonPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "NeutralPIDs # containers packed"               |       200 |        200 |     1.0000 |
- | "NeutralPIDs # of packed entries"               |       200 |      25001 |     125.00 |
- | "NeutralPIDs buffer size"                       |       200 |    1504460 |     7522.3 |
+ | "NeutralPIDs # containers packed"               |       200 |        103 |    0.51500 |
+ | "NeutralPIDs # of packed entries"               |       103 |        355 |     3.4466 |
+ | "NeutralPIDs buffer size"                       |       103 |      23566 |     228.80 |
  | "NeutralPIDsSelection # containers packed"      |       200 |          0 |     0.0000 |
  | "P2InfoRelations # containers packed"           |       200 |          0 |     0.0000 |
  | "P2IntRelations # containers packed"            |       200 |          0 |     0.0000 |
@@ -391,121 +415,151 @@ LHCb__SelectivePacker_c6eaf391         INFO Number of counters : 75
  | "P2PVRelations # containers packed"             |       200 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |       200 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |       200 |        400 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |       400 |     408470 |     1021.2 |
- | "PP2MCPRelations buffer size"                   |       400 |    8194200 |     20486. |
- | "PVs # containers packed"                       |       200 |        200 |     1.0000 |
- | "PVs # of packed entries"                       |       200 |        991 |     4.9550 |
- | "PVs buffer size"                               |       200 |     391498 |     1957.5 |
+ | "PP2MCPRelations # of packed entries"           |       400 |       8856 |     22.140 |
+ | "PP2MCPRelations buffer size"                   |       400 |     199656 |     499.14 |
+ | "PVs # containers packed"                       |       200 |        106 |    0.53000 |
+ | "PVs # of packed entries"                       |       106 |        608 |     5.7358 |
+ | "PVs buffer size"                               |       106 |      38868 |     366.68 |
  | "PVsSelection # containers packed"              |       200 |          0 |     0.0000 |
- | "Particles # containers packed"                 |       200 |        271 |     1.3550 |
- | "Particles # of packed entries"                 |       271 |        660 |     2.4354 |
- | "Particles buffer size"                         |       271 |     138438 |     510.84 |
- | "ParticlesSelection # containers packed"        |       200 |        256 |     1.2800 |
- | "ParticlesSelection # of packed entries"        |       256 |        374 |     1.4609 |
- | "ParticlesSelection buffer size"                |       256 |      10416 |     40.688 |
- | "ProtoParticles # containers packed"            |       200 |        800 |     4.0000 |
- | "ProtoParticles # of packed entries"            |       800 |      37965 |     47.456 |
- | "ProtoParticles buffer size"                    |       800 |    3058328 |     3822.9 |
+ | "Particles # containers packed"                 |       200 |        284 |     1.4200 |
+ | "Particles # of packed entries"                 |       284 |        668 |     2.3521 |
+ | "Particles buffer size"                         |       284 |     140592 |     495.04 |
+ | "ParticlesSelection # containers packed"        |       200 |        262 |     1.3100 |
+ | "ParticlesSelection # of packed entries"        |       262 |        379 |     1.4466 |
+ | "ParticlesSelection buffer size"                |       262 |      10630 |     40.573 |
+ | "ProtoParticles # containers packed"            |       200 |        117 |    0.58500 |
+ | "ProtoParticles # of packed entries"            |       117 |        427 |     3.6496 |
+ | "ProtoParticles buffer size"                    |       117 |      38902 |     332.50 |
  | "ProtoParticlesSelection # containers packed"   |       200 |          0 |     0.0000 |
- | "RecSummary # containers packed"                |       200 |        200 |     1.0000 |
- | "RecSummary # of packed entries"                |       200 |       7600 |     38.000 |
- | "RecSummary buffer size"                        |       200 |      34800 |     174.00 |
- | "RichPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "RichPIDs # of packed entries"                  |       200 |      12279 |     61.395 |
- | "RichPIDs buffer size"                          |       200 |     594592 |     2973.0 |
+ | "RecSummary # containers packed"                |       200 |        106 |    0.53000 |
+ | "RecSummary # of packed entries"                |       106 |       4028 |     38.000 |
+ | "RecSummary buffer size"                        |       106 |      18444 |     174.00 |
+ | "RichPIDs # containers packed"                  |       200 |         14 |   0.070000 |
+ | "RichPIDs # of packed entries"                  |        14 |         72 |     5.1429 |
+ | "RichPIDs buffer size"                          |        14 |       3820 |     272.86 |
  | "RichPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "Tracks # containers packed"                    |       200 |       1173 |     5.8650 |
- | "Tracks # of packed entries"                    |      1173 |      70735 |     60.303 |
- | "Tracks buffer size"                            |      1173 |1.67425e+07 |     14273. |
+ | "Tracks # containers packed"                    |       200 |         18 |   0.090000 |
+ | "Tracks # of packed entries"                    |        18 |         77 |     4.2778 |
+ | "Tracks buffer size"                            |        18 |      33534 |     1863.0 |
  | "TracksSelection # containers packed"           |       200 |          0 |     0.0000 |
  | "TwoProngVertices # containers packed"          |       200 |          0 |     0.0000 |
  | "TwoProngVerticesSelection # containers packed" |       200 |          0 |     0.0000 |
- | "Vertices # containers packed"                  |       200 |         46 |    0.23000 |
- | "Vertices # of packed entries"                  |        46 |         73 |     1.5870 |
- | "Vertices buffer size"                          |        46 |       7798 |     169.52 |
+ | "Vertices # containers packed"                  |       200 |         50 |    0.25000 |
+ | "Vertices # of packed entries"                  |        50 |         69 |     1.3800 |
+ | "Vertices buffer size"                          |        50 |       7630 |     152.60 |
  | "VerticesSelection # containers packed"         |       200 |          0 |     0.0000 |
  | "WeightsVectors # containers packed"            |       200 |          0 |     0.0000 |
+MuonIDHlt2AlgDownstream_81ff20a8       INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BgLL"                                          |       255 |   -227.724 |   -0.89304 |     1.3706 |     -7.8932 |      0.0000 |
+ | "MuLL"                                          |       255 |  -2093.102 |    -8.2082 |     3.7667 |     -11.513 |   -0.021982 |
+ | "muonMVAStat"                                   |       255 |  -89.66325 |   -0.35162 |     1.0516 |     -2.9175 |      4.1566 |
+ |*"nInAcceptance"                                 |      2436 |       1614 |( 66.25616 +- 0.9580138)% |
+ |*"nIsMuon"                                       |      2436 |        255 |( 10.46798 +- 0.6202717)% |
+ |*"nIsMuonTight"                                  |      2436 |        135 |( 5.541872 +- 0.4635635)% |
+ |*"nMomentumCut"                                  |      2436 |       1754 |( 72.00328 +- 0.9096850)% |
 MuonIDHlt2AlgLong_ebde3a89             INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BgLL"                                          |      1283 |  -856.8278 |   -0.66783 |     1.0394 |     -7.2271 |      0.0000 |
- | "MuLL"                                          |      1283 |  -11145.35 |    -8.6869 |     3.3991 |     -11.513 |   -0.046524 |
- | "muonMVAStat"                                   |      1283 |  -670.2324 |   -0.52239 |    0.89013 |     -3.0272 |      4.0084 |
- |*"nInAcceptance"                                 |     12964 |      10218 |( 78.81827 +- 0.3588597)% |
- |*"nIsMuon"                                       |     12964 |       1283 |( 9.896637 +- 0.2622677)% |
- |*"nIsMuonTight"                                  |     12964 |        640 |( 4.936748 +- 0.1902643)% |
- |*"nMomentumCut"                                  |     12964 |      10946 |( 84.43382 +- 0.3184049)% |
+ | "BgLL"                                          |      1187 |  -735.8525 |   -0.61993 |    0.97160 |     -6.5333 |      0.0000 |
+ | "MuLL"                                          |      1187 |  -10459.87 |    -8.8120 |     3.3118 |     -11.513 |   -0.092726 |
+ | "muonMVAStat"                                   |      1187 |  -652.1619 |   -0.54942 |    0.86069 |     -3.0272 |      4.1590 |
+ |*"nInAcceptance"                                 |     12498 |       9987 |( 79.90879 +- 0.3584100)% |
+ |*"nIsMuon"                                       |     12498 |       1187 |( 9.497520 +- 0.2622497)% |
+ |*"nIsMuonTight"                                  |     12498 |        576 |( 4.608737 +- 0.1875534)% |
+ |*"nMomentumCut"                                  |     12498 |      10700 |( 85.61370 +- 0.3139250)% |
+MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of input v2 MuonPIDs"                       |       200 |       2436 |     12.180 |
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of input v2 MuonPIDs"                       |       200 |      12964 |     64.820 |
+ | "Nb of input v2 MuonPIDs"                       |       200 |      12498 |     62.490 |
 NeutralProtoParticleAssociator_9...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     25001 |      23325 |( 93.29627 +- 0.1581655)% |
- | "MC particles per ProtoParticle"                |     23325 |     395398 |     16.952 |
+ |*"Efficiency"                                    |     25138 |      23462 |( 93.33280 +- 0.1573343)% |
+ | "MC particles per ProtoParticle"                |     23462 |     398148 |     16.970 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |       200 |     190749 |     953.75 |     601.33 |      65.000 |      2974.0 |
+ | "#MCParticles"                                  |       200 |     192056 |     960.28 |     602.83 |      65.000 |      2915.0 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |       200 |      90853 |     454.26 |     293.04 |      26.000 |      1440.0 |
+ | "#MCVertices"                                   |       200 |      91475 |     457.38 |     294.09 |      26.000 |      1429.0 |
 ParticleRangeFilter_22f84c5e           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        174 |( 87.00000 +- 2.378024)% |
- |*"Cut selection efficiency"                      |     12964 |       1047 |( 8.076211 +- 0.2393031)% |
+ |*"#passed"                                       |       200 |        175 |( 87.50000 +- 2.338536)% |
+ |*"Cut selection efficiency"                      |     12498 |       1017 |( 8.137302 +- 0.2445623)% |
 ParticleRangeFilter_2cf9c882           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         40 |( 20.00000 +- 2.828427)% |
- |*"Cut selection efficiency"                      |     14691 |         46 |(0.3131169 +- 0.04609423)% |
+ |*"Cut selection efficiency"                      |     14805 |         46 |(0.3107058 +- 0.04573985)% |
 ParticleRangeFilter_2d1c6dde           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         42 |( 21.00000 +- 2.880104)% |
- |*"Cut selection efficiency"                      |     14691 |         48 |(0.3267307 +- 0.04708240)% |
+ |*"Cut selection efficiency"                      |     14805 |         48 |(0.3242148 +- 0.04672045)% |
 ParticleRangeFilter_2dd22701           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         61 |( 30.50000 +- 3.255572)% |
- |*"Cut selection efficiency"                      |     12279 |         90 |(0.7329587 +- 0.07697697)% |
+ |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
+ |*"Cut selection efficiency"                      |     11967 |         90 |(0.7520682 +- 0.07897628)% |
+ParticleRangeFilter_32aaad9e           INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         3 |          2 |( 66.66667 +- 27.21655)% |
+ |*"Cut selection efficiency"                      |       177 |          9 |( 5.084746 +- 1.651262)% |
 ParticleRangeFilter_497ef01a           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         90 |( 45.00000 +- 3.517812)% |
- |*"Cut selection efficiency"                      |     12279 |        170 |( 1.384478 +- 0.1054470)% |
+ |*"#passed"                                       |       200 |         93 |( 46.50000 +- 3.526861)% |
+ |*"Cut selection efficiency"                      |     11967 |        185 |( 1.545918 +- 0.1127762)% |
 ParticleRangeFilter_7c68ac05           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     14691 |       3666 |( 24.95405 +- 0.3570331)% |
+ |*"Cut selection efficiency"                      |     14805 |       3686 |( 24.89699 +- 0.3553840)% |
 ParticleRangeFilter_8ad15fd6           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         9 |          9 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |       784 |        116 |( 14.79592 +- 1.268070)% |
-ParticleRangeFilter_9dfc592f           INFO Number of counters : 1
+ |*"#passed"                                       |        10 |         10 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |       839 |        134 |( 15.97139 +- 1.264748)% |
+ParticleRangeFilter_9dfc592f           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |         71 |( 35.50000 +- 3.383600)% |
+ |*"Cut selection efficiency"                      |      2177 |        101 |( 4.639412 +- 0.4508029)% |
 ParticleRangeFilter_a654d6c9           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
- |*"Cut selection efficiency"                      |     14691 |         92 |(0.6262337 +- 0.06508463)% |
-ParticleRangeFilter_f1423675           INFO Number of counters : 1
+ |*"Cut selection efficiency"                      |     14805 |         92 |(0.6214117 +- 0.06458504)% |
+ParticleRangeFilter_f1423675           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        191 |( 95.50000 +- 1.465862)% |
+ |*"Cut selection efficiency"                      |      2436 |       1650 |( 67.73399 +- 0.9471905)% |
 ParticleRangeFilter_f36346d4           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
 ParticleUnbiasedPVAdder_198323e6       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         9 |
+ | "PV unbiasing successful"                       |        12 |
 ParticleUnbiasedPVAdder_49026aff       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         9 |
+ | "PV unbiasing successful"                       |        12 |
 ParticleWithBremMaker_49ed8ce1         INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of particles corrected with brem (including those without change)"|     12964 |
+ | "Nb of particles corrected with brem (including those without change)"|     12498 |
 ParticleWithBremMaker_49ed8ce1.S...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Delta(E)"                                      |       916 |    4092680 |     4468.0 |     7235.5 |      4.1200 |  1.0095e+05 |
- | "Nb photons added to single electrons"          |     12964 |        916 |   0.070657 |    0.25625 |      0.0000 |      1.0000 |
-PrCloneKillerSeed_8e934c5f             INFO Number of counters : 2
+ | "Delta(E)"                                      |       872 |    3740193 |     4289.2 |     6915.6 |      4.1200 |  1.0095e+05 |
+ | "Nb photons added to single electrons"          |     12498 |        872 |   0.069771 |    0.25476 |      0.0000 |      1.0000 |
+PrCloneKillerDown_93e0ec59             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      13806 |     69.030 |
+ | "nTracksSelected"                               |       200 |       3650 |     18.250 |
+PrCloneKillerSeedDown_913c1b16         INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      10912 |     54.560 |
+ | "nTracksSelected"                               |       200 |       8580 |     42.900 |
+PrCloneKillerSeed_cd7a5f5f             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       200 |      22370 |     111.85 |
- | "nTracksSelected"                               |       200 |      10386 |     51.930 |
-PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
+ | "nTracksSelected"                               |       200 |      10912 |     54.560 |
+PrCloneKillerUp_406af2b0               INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       106 |       5357 |     50.538 |
+ | "nTracksSelected"                               |       106 |       1376 |     12.981 |
+PrForwardTrackingVelo_a7f67b46         INFO Number of counters : 10
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Accepted input tracks"                         |       200 |      27555 |     137.78 |
  | "Created long tracks"                           |       200 |      13621 |     68.105 |
@@ -517,6 +571,10 @@ PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
  | "Number of x candidates per track 2nd Loop"     |     12521 |      78802 |     6.2936 |     11.087 |
  | "Percentage second loop execution"              |     23800 |      12521 |    0.52609 |
  | "Removed duplicates"                            |       200 |        777 |     3.8850 |
+PrForwardTrackingVelo_a7f67b46.P...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11980 |      48375 |     4.0380 |
+ | "#tracks with hits added"                       |     11980 |
 PrHybridSeeding_97242385               INFO Number of counters : 21
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Created T2x1 three-hit combinations in case 0" |    451880 |     283732 |    0.62789 |    0.63420 |      0.0000 |      6.0000 |
@@ -540,30 +598,60 @@ PrHybridSeeding_97242385               INFO Number of counters : 21
  | "Created two-hit combinations in case 0"        |     64817 |    1590410 |     24.537 |     18.401 |      0.0000 |      119.00 |
  | "Created two-hit combinations in case 1"        |     58134 |    2008013 |     34.541 |     22.781 |      0.0000 |      182.00 |
  | "Created two-hit combinations in case 2"        |     49018 |    2612705 |     53.301 |     35.316 |      1.0000 |      252.00 |
-PrKalmanFilterForward_92f61463         INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       344 |
- | "chi2 cut"                                      |       743 |
- | "nIterations"                                   |      2579 |       7047 |     2.7325 |
- | "nOutlierIterations"                            |      2235 |       2356 |     1.0541 |
- | "nTracksInput"                                  |       200 |       2579 |     12.895 |
- | "nTracksOutput"                                 |       200 |       1492 |     7.4600 |
-PrKalmanFilterMatch_fdc68e9f           INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       274 |
- | "chi2 cut"                                      |       966 |
- | "nIterations"                                   |     13652 |      29610 |     2.1689 |
- | "nOutlierIterations"                            |     13378 |       7080 |    0.52923 |
- | "nTracksInput"                                  |       200 |      13652 |     68.260 |
- | "nTracksOutput"                                 |       200 |      12412 |     62.060 |
-PrLHCbID2MCParticleVPFTMU_7d3ccc1b     INFO Number of counters : 1
+PrKalmanFilterForward_907c6c68         INFO Number of counters : 6
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#removed null MCParticles"                     |   1283247 |       2459 |  0.0019162 |
-PrMatchNN_946089ac                     INFO Number of counters : 3
+ | "Pre outlier chi2 cut"                          |       437 |
+ | "chi2 cut"                                      |      1500 |
+ | "nIterations"                                   |     13621 |      31487 |     2.3117 |
+ | "nOutlierIterations"                            |     13184 |       8694 |    0.65944 |
+ | "nTracksInput"                                  |       200 |      13621 |     68.105 |
+ | "nTracksOutput"                                 |       200 |      11684 |     58.420 |
+PrKalmanFilterMatch_8b37c0b3           INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       328 |
+ | "chi2 cut"                                      |      1521 |
+ | "nIterations"                                   |      3140 |       7986 |     2.5433 |
+ | "nOutlierIterations"                            |      2812 |       3076 |     1.0939 |
+ | "nTracksInput"                                  |       200 |       3140 |     15.700 |
+ | "nTracksOutput"                                 |       200 |       1291 |     6.4550 |
+PrKalmanFilter_Downstream_774e4436     INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       560 |
+ | "chi2 cut"                                      |       654 |
+ | "nIterations"                                   |      3650 |       9320 |     2.5534 |
+ | "nOutlierIterations"                            |      3090 |       1830 |    0.59223 |
+ | "nTracksInput"                                  |       200 |       3650 |     18.250 |
+ | "nTracksOutput"                                 |       200 |       2436 |     12.180 |
+PrKalmanFilter_Upstream_1cb85a56       INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |        95 |
+ | "chi2 cut"                                      |       212 |
+ | "nIterations"                                   |      1376 |       2798 |     2.0334 |
+ | "nOutlierIterations"                            |      1281 |        460 |    0.35909 |
+ | "nTracksInput"                                  |       106 |       1376 |     12.981 |
+ | "nTracksOutput"                                 |       106 |       1069 |     10.085 |
+PrLHCbID2MCParticleVPUTFTMU_dc79...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#removed null MCParticles"                     |   1491997 |       2459 |  0.0016481 |
+PrLongLivedTracking_83484006           INFO Number of counters : 8
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Downstream tracks made"                       |       200 |      13806 |     69.030 |
+ | "#Good XUVcand"                                 |     20447 |     100942 |     4.9368 |
+ | "#Good Xcand"                                   |     20447 |     317401 |     15.523 |
+ | "#Presel hits0"                                 |     20447 |     269267 |     13.169 |
+ | "#Presel hits1"                                 |     20447 |     270314 |     13.220 |
+ | "#Presel hits2"                                 |     20447 |     260478 |     12.739 |
+ | "#Presel hits3"                                 |     20447 |     267139 |     13.065 |
+ | "#Seeds"                                        |       200 |      22370 |     111.85 |
+PrMatchNN_915466c5                     INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#MatchingChi2"                                 |       200 |   230893.2 |     1154.5 |
  | "#MatchingMLP"                                  |     13652 |   11414.78 |    0.83612 |
  | "#MatchingTracks"                               |       200 |      13652 |     68.260 |
+PrMatchNN_915466c5.PrAddUTHitsTool     INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11894 |      48055 |     4.0403 |
+ | "#tracks with hits added"                       |     11894 |
 PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Average X in T1U"                              |     65585 |    1832058 |     27.934 |     1214.1 |     -2656.0 |      2656.4 |
@@ -591,13 +679,26 @@ PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  | "Hits in T3X1"                                  |       800 |      68009 |     85.011 |     36.453 |      23.000 |      264.00 |
  | "Hits in T3X2"                                  |       800 |      74560 |     93.200 |     39.732 |      22.000 |      249.00 |
  | "Total number of hits"                          |       200 |     807039 |     4035.2 |     1656.6 |      1290.0 |      9859.0 |
-PrTrackAssociator_fa20e82b             INFO Number of counters : 2
+PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# RawBank::UT banks"                           |       200 |      43200 |     216.00 |
+ | "# RawBank::UTError banks"                      |       200 |          0 |     0.0000 |
+ |*"Non-unique UT clusters in event"               |       200 |          0 |( 0.000000 +- 0.000000)% |
+PrTrackAssociator_1cbc46b9             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12964 |      11233 |( 86.64764 +- 0.2987362)% |
- | "MC particles per track"                        |     11233 |      13072 |     1.1637 |
+ |*"Efficiency"                                    |     12498 |      11198 |( 89.59834 +- 0.2730745)% |
+ | "MC particles per track"                        |     11198 |      12998 |     1.1607 |
+PrTrackAssociator_49a0075c             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |      2436 |       1966 |( 80.70608 +- 0.7995116)% |
+ | "MC particles per track"                        |      1966 |       1966 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
+PrVeloUT_daa62e37                      INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#seeds"                                        |       106 |      19659 |     185.46 |
+ | "#tracks"                                       |       106 |       5357 |     50.538 |
 SelectHlt1HltDecReports                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Number of selected banks"                      |       200 |          0 |( 0.000000 +- 0.000000)% |
@@ -610,105 +711,133 @@ SelectHlt1HltSelReports                INFO Number of counters : 1
 SelectiveCombineRawBanks_for_def...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Empty RawBank::View"                           |      1600 |          0 |     0.0000 |     0.0000 | 1.7977e+308 |-1.7977e+308 |
-TBTCForward_afd7320e                   INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |      1406 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |      1406 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |      1406 |
-TBTC_Match_61db36c4                    INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |     11558 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |     11558 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |     11558 |
+TBTCMatch_239b7419                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1228 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1228 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1228 |
+TBTC_Forward_805a8cb5                  INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |     11270 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |     11270 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |     11270 |
+TBTC_down_a8eb2751                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      2436 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      2436 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      2436 |
+TBTC_up_2250d07b                       INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1067 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1067 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1067 |
 Test_BdsToPhiPhiCombiner               INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       104 |          1 |(0.9615385 +- 0.9569045)% |
- |*"# passed CombinationCut"                       |       562 |         13 |( 2.313167 +- 0.6340936)% |
- |*"# passed CompositeCut"                         |        13 |          1 |( 7.692308 +- 7.390530)% |
- |*"# passed vertex fit"                           |        13 |         13 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       104 |        290 |     2.7885 |
- | "Input2 size"                                   |       104 |        290 |     2.7885 |
- | "candidate multiplicity"                        |       104 |          1 |  0.0096154 |   0.097585 |      0.0000 |      1.0000 |
+ |*"# passed"                                      |        98 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |       588 |         19 |( 3.231293 +- 0.7292341)% |
+ |*"# passed CompositeCut"                         |        19 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |        19 |         19 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        98 |        287 |     2.9286 |
+ | "Input2 size"                                   |        98 |        287 |     2.9286 |
+ | "candidate multiplicity"                        |        98 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Bs2JPsiPhiCombiner_67dc4ee3       INFO Number of counters : 8
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        66 |         10 |( 15.15152 +- 4.413449)% |
- |*"# passed CombinationCut"                       |       742 |        150 |( 20.21563 +- 1.474350)% |
- |*"# passed CompositeCut"                         |       150 |         19 |( 12.66667 +- 2.715661)% |
- |*"# passed vertex fit"                           |       150 |        150 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        66 |        165 |     2.5000 |
- | "Input2 size"                                   |        66 |        182 |     2.7576 |
- | "Lifetime fit did not converge. Aborting."      |         5 |
- | "candidate multiplicity"                        |        66 |         19 |    0.28788 |    0.86629 |      0.0000 |      5.0000 |
+ |*"# passed"                                      |        64 |          9 |( 14.06250 +- 4.345429)% |
+ |*"# passed CombinationCut"                       |       685 |        129 |( 18.83212 +- 1.493814)% |
+ |*"# passed CompositeCut"                         |       129 |         15 |( 11.62791 +- 2.822367)% |
+ |*"# passed vertex fit"                           |       129 |        129 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        64 |        158 |     2.4688 |
+ | "Input2 size"                                   |        64 |        177 |     2.7656 |
+ | "Lifetime fit did not converge. Aborting."      |         3 |
+ | "candidate multiplicity"                        |        64 |         15 |    0.23438 |    0.70139 |      0.0000 |      4.0000 |
 Test_Bs2JPsiPhiCombiner_d1451b3c       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        89 |          6 |( 6.741573 +- 2.657845)% |
- |*"# passed CombinationCut"                       |       705 |        145 |( 20.56738 +- 1.522279)% |
- |*"# passed CompositeCut"                         |       145 |          9 |( 6.206897 +- 2.003728)% |
- |*"# passed vertex fit"                           |       145 |        145 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        89 |        206 |     2.3146 |
- | "Input2 size"                                   |        89 |        211 |     2.3708 |
- | "candidate multiplicity"                        |        89 |          9 |    0.10112 |    0.39789 |      0.0000 |      2.0000 |
+ |*"# passed"                                      |        89 |          9 |( 10.11236 +- 3.195812)% |
+ |*"# passed CombinationCut"                       |       696 |        154 |( 22.12644 +- 1.573425)% |
+ |*"# passed CompositeCut"                         |       154 |         12 |( 7.792208 +- 2.160000)% |
+ |*"# passed vertex fit"                           |       154 |        154 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        89 |        205 |     2.3034 |
+ | "Input2 size"                                   |        89 |        209 |     2.3483 |
+ | "candidate multiplicity"                        |        89 |         12 |    0.13483 |    0.42903 |      0.0000 |      2.0000 |
 Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        40 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |        34 |          0 |( 0.000000 +- 0.000000)% |
  | "Input1 size"                                   |       200 |         90 |    0.45000 |
  | "Input2 size"                                   |       200 |         90 |    0.45000 |
  | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_LambdaFromHyperon_LL     INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          9 |( 4.500000 +- 1.465862)% |
- |*"# passed CombinationCut"                       |       755 |         17 |( 2.251656 +- 0.5399235)% |
- |*"# passed CompositeCut"                         |        17 |          9 |( 52.94118 +- 12.10578)% |
- |*"# passed vertex fit"                           |        17 |         17 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |        170 |    0.85000 |
- | "Input2 size"                                   |       200 |       1047 |     5.2350 |
- | "candidate multiplicity"                        |       200 |          9 |   0.045000 |    0.20730 |      0.0000 |      1.0000 |
-Test_Hyperons_Lambda_DD                INFO Number of counters : 4
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |          0 |     0.0000 |
- | "Input2 size"                                   |       200 |          0 |     0.0000 |
- | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |       200 |         10 |( 5.000000 +- 1.541104)% |
+ |*"# passed CombinationCut"                       |       769 |         19 |( 2.470741 +- 0.5597807)% |
+ |*"# passed CompositeCut"                         |        19 |         10 |( 52.63158 +- 11.45489)% |
+ |*"# passed vertex fit"                           |        19 |         19 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        185 |    0.92500 |
+ | "Input2 size"                                   |       200 |       1017 |     5.0850 |
+ | "candidate multiplicity"                        |       200 |         10 |   0.050000 |    0.21794 |      0.0000 |      1.0000 |
+Test_Hyperons_Lambda_DD                INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |          3 |( 1.500000 +- 0.8595057)% |
+ |*"# passed CombinationCut"                       |       681 |          9 |( 1.321586 +- 0.4376080)% |
+ |*"# passed CompositeCut"                         |         9 |          3 |( 33.33333 +- 15.71348)% |
+ |*"# passed vertex fit"                           |         9 |          9 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        101 |    0.50500 |
+ | "Input2 size"                                   |       200 |       1650 |     8.2500 |
+ | "candidate multiplicity"                        |       200 |          3 |   0.015000 |    0.12155 |      0.0000 |      1.0000 |
+Test_Hyperons_Xic0ToL0PimPip_DD        INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         3 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed Combination12Cut"                     |         4 |          1 |( 25.00000 +- 21.65064)% |
+ |*"# passed CombinationCut"                       |         2 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         3 |          3 |     1.0000 |
+ | "Input2 size"                                   |         3 |          9 |     3.0000 |
+ | "Input3 size"                                   |         3 |          9 |     3.0000 |
+ | "candidate multiplicity"                        |         3 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_Xim_LLL                  INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |         9 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        62 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |         9 |          9 |     1.0000 |
- | "Input2 size"                                   |         9 |        116 |     12.889 |
- | "candidate multiplicity"                        |         9 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |        10 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |        71 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |        10 |         10 |     1.0000 |
+ | "Input2 size"                                   |        10 |        134 |     13.400 |
+ | "candidate multiplicity"                        |        10 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_MassConstrJpsi2MuMuMaker          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |         89 |( 44.50000 +- 3.514079)% |
- |*"# passed CombinationCut"                       |     48683 |        214 |(0.4395785 +- 0.02998285)% |
- |*"# passed CompositeCut"                         |       214 |        206 |( 96.26168 +- 1.296755)% |
+ |*"# passed CombinationCut"                       |     42590 |        214 |(0.5024654 +- 0.03426142)% |
+ |*"# passed CompositeCut"                         |       214 |        205 |( 95.79439 +- 1.372074)% |
  |*"# passed vertex fit"                           |       214 |        214 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12964 |     64.820 |
- | "Input2 size"                                   |       200 |       2112 |     10.560 |
- | "candidate multiplicity"                        |       200 |        206 |     1.0300 |     1.6490 |      0.0000 |      11.000 |
+ | "Input1 size"                                   |       200 |      12498 |     62.490 |
+ | "Input2 size"                                   |       200 |       2003 |     10.015 |
+ | "candidate multiplicity"                        |       200 |        205 |     1.0250 |     1.6014 |      0.0000 |      8.0000 |
 Test_Phi2KKMaker                       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |        104 |( 52.00000 +- 3.532704)% |
- |*"# passed CombinationCut"                       |    186776 |      12960 |( 6.938793 +- 0.05879844)% |
- |*"# passed CompositeCut"                         |     12960 |        290 |( 2.237654 +- 0.1299211)% |
- |*"# passed vertex fit"                           |     12960 |      12960 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12964 |     64.820 |
- | "Input2 size"                                   |       200 |       7700 |     38.500 |
- | "candidate multiplicity"                        |       200 |        290 |     1.4500 |     2.2288 |      0.0000 |      13.000 |
+ |*"# passed"                                      |       200 |         98 |( 49.00000 +- 3.534827)% |
+ |*"# passed CombinationCut"                       |    164380 |       9760 |( 5.937462 +- 0.05828869)% |
+ |*"# passed CompositeCut"                         |      9760 |        287 |( 2.940574 +- 0.1710055)% |
+ |*"# passed vertex fit"                           |      9760 |       9760 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      12498 |     62.490 |
+ | "Input2 size"                                   |       200 |       7169 |     35.845 |
+ | "candidate multiplicity"                        |       200 |        287 |     1.4350 |     2.2925 |      0.0000 |      14.000 |
 Test_Pi0ToGammaGamma_Combiner          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |         81 |( 40.50000 +- 3.471131)% |
- |*"# passed CombinationCut"                       |     40314 |        140 |(0.3472739 +- 0.02929899)% |
- |*"# passed CompositeCut"                         |       140 |        140 |( 100.0000 +- 0.000000)% |
- |*"# passed vertex fit"                           |       140 |        140 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |       3666 |     18.330 |
- | "Input2 size"                                   |       200 |       3666 |     18.330 |
- | "candidate multiplicity"                        |       200 |        140 |    0.70000 |     1.0536 |      0.0000 |      4.0000 |
+ |*"# passed CombinationCut"                       |     40782 |        142 |(0.3481928 +- 0.02916878)% |
+ |*"# passed CompositeCut"                         |       142 |        142 |( 100.0000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |       142 |        142 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |       3686 |     18.430 |
+ | "Input2 size"                                   |       200 |       3686 |     18.430 |
+ | "candidate multiplicity"                        |       200 |        142 |    0.71000 |     1.0705 |      0.0000 |      4.0000 |
 TrackBeamLineVertexFinderSoA_609...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fraction of failed PV fits"                    |      1016 |          0 |( 0.000000 +- 0.000000)% |
  |*"Fraction of unconverged PV fits"               |      1016 |         69 |( 6.791339 +- 0.7893307)% |
  | "Nb PVs"                                        |       200 |        991 |     4.9550 |
+UTHitClustersToPrUTHitsConverter...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
+UTHitClustersToUTHitHandlerConve...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
 VPLightClustersToVPMicroClusters...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# Converted Clusters"                          |       200 |     420481 |     2102.4 |
@@ -731,15 +860,18 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
  | "Nb of Produced Tracks"                         |       200 |      46102 |     230.51 |
-fromPrSeedingTracksV1Tracks_320a...    INFO Number of counters : 1
+fromPrSeedingTracksV1Tracks_8d48...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of converted Tracks"                        |       200 |      10386 |     51.930 |
+ | "Nb of converted Tracks"                        |       200 |       8580 |     42.900 |
 fromPrVeloTracksV1TracksMerger_8...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of converted Tracks"                        |       200 |      46102 |     230.51 |
+fromV2MuonPIDV1MuonPIDDownstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of Produced MuonPIDs"                       |       200 |       2436 |     12.180 |
 fromV2MuonPIDV1MuonPIDLong_e60c416d    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced MuonPIDs"                       |       200 |      12964 |     64.820 |
+ | "Nb of Produced MuonPIDs"                       |       200 |      12498 |     62.490 |
 require_pvs                            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-detdesc-opt
index 23c971b11af..f9360d2e953 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-detdesc-opt
@@ -1,39 +1,39 @@
 CopyInputStream_c601f8ec               INFO Events output: 200
 GraphClustering_72971694               INFO Built <171.765> graph calo clustering clusters/event
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Skip'     map has the size 0
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has the size 0
+TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Codes'    map has the size 0
+TransportSvc                           INFO Reset the static pointer to DetDesc::IGeometyrErrorSvc
 ApplicationMgr                         INFO Application Manager Finalized successfully
 ApplicationMgr                         INFO Application Manager Terminated successfully
 CaloAcceptanceBremAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2432 |     12.160 |     9.3244 |      0.0000 |      55.000 |
+ | "#tracks in acceptance"                         |       200 |       1842 |     9.2100 |     7.0743 |      0.0000 |      40.000 |
 CaloAcceptanceBremAlg_Long_142dbbc6    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     43.027 |      2.0000 |      247.00 |
- | "#tracks in acceptance"                         |       200 |       9516 |     47.580 |     31.182 |      1.0000 |      178.00 |
-CaloAcceptanceBremAlg_Upstream_3...    INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |      12515 |     62.575 |     40.043 |      2.0000 |      223.00 |
+ | "#tracks in acceptance"                         |       200 |       9252 |     46.260 |     29.520 |      1.0000 |      167.00 |
 CaloAcceptanceEcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2432 |     12.160 |     9.3244 |      0.0000 |      55.000 |
+ | "#tracks in acceptance"                         |       200 |       1918 |     9.5900 |     7.5287 |      0.0000 |      46.000 |
 CaloAcceptanceEcalAlg_Long_71599283    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     43.027 |      2.0000 |      247.00 |
- | "#tracks in acceptance"                         |       200 |      10879 |     54.395 |     36.321 |      2.0000 |      205.00 |
+ | "#total tracks"                                 |       200 |      12515 |     62.575 |     40.043 |      2.0000 |      223.00 |
+ | "#tracks in acceptance"                         |       200 |      10562 |     52.810 |     34.132 |      2.0000 |      187.00 |
 CaloAcceptanceEcalAlg_Ttrack_b29...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      10378 |     51.890 |     52.015 |      0.0000 |      479.00 |
- | "#tracks in acceptance"                         |       200 |       8355 |     41.775 |     44.501 |      0.0000 |      419.00 |
+ | "#total tracks"                                 |       200 |       8576 |     42.880 |     47.791 |      0.0000 |      446.00 |
+ | "#tracks in acceptance"                         |       200 |       6896 |     34.480 |     41.078 |      0.0000 |      391.00 |
 CaloAcceptanceHcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2432 |     12.160 |     9.3244 |      0.0000 |      55.000 |
+ | "#tracks in acceptance"                         |       200 |       1730 |     8.6500 |     6.7836 |      0.0000 |      42.000 |
 CaloAcceptanceHcalAlg_Long_1fd97970    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     43.027 |      2.0000 |      247.00 |
- | "#tracks in acceptance"                         |       200 |      10219 |     51.095 |     34.174 |      2.0000 |      195.00 |
+ | "#total tracks"                                 |       200 |      12515 |     62.575 |     40.043 |      2.0000 |      223.00 |
+ | "#tracks in acceptance"                         |       200 |       9942 |     49.710 |     32.182 |      2.0000 |      175.00 |
 CaloClusterMCTruth_b1e9f302            INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#CC2MC links"                                  |       200 |     605266 |     3026.3 |
@@ -56,8 +56,8 @@ CaloFutureHypoMCTruth_b7aaff7e         INFO Number of counters : 2
  | "#links/hypo"                                   |       784 |      25174 |     32.110 |
 CaloFutureHypoMCTruth_db59dc13         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links"                                        |       200 |     370242 |     1851.2 |
- | "#links/hypo"                                   |     22650 |     370242 |     16.346 |
+ | "#links"                                        |       200 |     372992 |     1865.0 |
+ | "#links/hypo"                                   |     22787 |     372992 |     16.369 |
 CaloFutureMergedPi0_ee84f6b4           INFO Number of counters : 12
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cluster without 2nd seed found"                |       784 |          0 |( 0.000000 +- 0.000000)% |
@@ -86,164 +86,190 @@ CaloFutureMergedPi0_ee84f6b4.Eca...    INFO Number of counters : 3
  | "Corrected Clusters: # cells "                  |       184 |       1047 |     5.6902 |     1.6865 |      3.0000 |      9.0000 |
  | "Corrected Clusters: ET"                        |       184 |   165778.8 |     900.97 |     881.51 |      3.6000 |      7563.0 |
  | "Corrected Clusters: size ratio"                |       184 |   85.97535 |    0.46726 |    0.46258 |    0.015364 |      2.2345 |
-CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 1
+CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |        576 |     2.8800 |     3.1218 |      0.0000 |      16.000 |
+ | "average chi2"                                  |       576 |   2420.389 |     4.2021 |     5.2683 |   0.0039769 |      39.870 |
+ | "average energy (track based)"                  |      1842 |     117282 |     63.671 |     269.89 |      0.0000 |      6128.3 |
 CaloSelectiveBremMatchAlg_Long_2...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       3458 |     17.290 |     16.053 |      0.0000 |      79.000 |
- | "average chi2"                                  |      3458 |   3290.373 |    0.95152 |     1.8745 |  6.2941e-07 |      37.830 |
- | "average energy (track based)"                  |      9516 |   161818.4 |     17.005 |     49.426 |      0.0000 |      1334.7 |
-CaloSelectiveBremMatchAlg_Upstre...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       3365 |     16.825 |     15.327 |      0.0000 |      72.000 |
+ | "average chi2"                                  |      3365 |   3420.893 |     1.0166 |     1.9810 |  6.3590e-07 |      42.029 |
+ | "average energy (track based)"                  |      9252 |   155979.2 |     16.859 |     49.268 |      0.0000 |      1290.8 |
+CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       1743 |     8.7150 |     7.0678 |      0.0000 |      43.000 |
+ | "average chi2"                                  |      1743 |   27170.63 |     15.588 |     36.677 |   0.0010210 |      777.43 |
 CaloSelectiveElectronMatchAlg_Lo...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#above threshold"                              |         1 |          1 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#links in table"                               |       200 |       8948 |     44.740 |     32.620 |      2.0000 |      180.00 |
- | "average chi2"                                  |      8948 |   43035.73 |     4.8095 |     11.405 |  0.00020008 |      412.84 |
-CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 1
+ | "#above threshold"                              |         2 |          2 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#links in table"                               |       200 |       8634 |     43.170 |     30.669 |      2.0000 |      163.00 |
+ | "average chi2"                                  |      8634 |   43424.56 |     5.0295 |     11.780 |  0.00021607 |      413.01 |
+CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       1751 |     8.7550 |     7.0679 |      0.0000 |      43.000 |
+ | "average chi2"                                  |      1751 |   1067.502 |    0.60965 |     1.0185 |  1.3942e-05 |      12.252 |
 CaloSelectiveTrackMatchAlg_Long_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       9054 |     45.270 |     32.746 |      2.0000 |      182.00 |
- | "average chi2"                                  |      9054 |   1337.495 |    0.14772 |    0.28425 |  3.1386e-06 |      8.8273 |
+ | "#links in table"                               |       200 |       8739 |     43.695 |     30.810 |      2.0000 |      165.00 |
+ | "average chi2"                                  |      8739 |   1338.145 |    0.15312 |    0.29434 |  2.3423e-06 |      8.8202 |
 CaloSelectiveTrackMatchAlg_Ttrac...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       6804 |     34.020 |     32.758 |      0.0000 |      297.00 |
- | "average chi2"                                  |      6804 |   430.9227 |   0.063334 |    0.12101 |  2.2962e-06 |      4.0922 |
+ | "#links in table"                               |       200 |       5470 |     27.350 |     29.471 |      0.0000 |      273.00 |
+ | "average chi2"                                  |      5470 |   434.9302 |   0.079512 |    0.14674 |  2.7847e-06 |      4.0922 |
 CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "average DLL"                                   |     10879 |  -626.8005 |  -0.057616 |    0.10524 |     -2.7103 |     0.57343 |
- | "average E/p"                                   |     10879 |   70.02869 |  0.0064371 |  0.0094464 |      0.0000 |     0.16104 |
+ | "average DLL"                                   |      1918 |  -213.7112 |   -0.11142 |    0.57244 |     -7.3665 |      3.4989 |
+ | "average E/p"                                   |      1918 |    107.373 |   0.055982 |   0.081231 |      0.0000 |     0.93272 |
+CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "average DLL"                                   |     10562 |  -637.5818 |  -0.060366 |    0.10748 |     -2.6777 |     0.58154 |
+ | "average E/p"                                   |     10562 |   68.78454 |  0.0065125 |  0.0096459 |      0.0000 |     0.16108 |
+CaloTrackToHcalEnergyAlg_Downstr...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "energy (calo) associated to track"             |      1730 |    4621335 |     2671.3 |     5556.5 |      0.0000 |      90279. |
 CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "energy (calo) associated to track"             |     10219 |4.49074e+07 |     4394.5 |     8212.0 |      0.0000 |  1.2332e+05 |
+ | "energy (calo) associated to track"             |      9942 |4.436839e+07 |     4462.7 |     8211.1 |      0.0000 |  1.2332e+05 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12976 |      11234 |( 86.57522 +- 0.2992816)% |
- | "MC particles per ProtoParticle"                |     11234 |      13075 |     1.1639 |
+ |*"Efficiency"                                    |      2432 |       1964 |( 80.75658 +- 0.7993709)% |
+ | "MC particles per ProtoParticle"                |      1964 |       1964 |     1.0000 |
+ChargedProtoParticleAssociator_9...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     12515 |      11207 |( 89.54854 +- 0.2734653)% |
+ | "MC particles per ProtoParticle"                |     11207 |      13011 |     1.1610 |
+ChargedProtoParticleMaker_Downst...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "CreatedProtos"                                 |      2432 |
 ChargedProtoParticleMaker_Long_b...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "CreatedProtos"                                 |     12976 |
+ | "CreatedProtos"                                 |     12515 |
 ClassifyPhotonElectronAlg_5a60ece2     INFO Number of counters : 14
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Electron Delta(E)"                             |     12361 |   -5102324 |    -412.78 |     549.51 |     -5759.4 |      2744.3 |
- | "Electron Delta(X)"                             |     12361 |  -5316.681 |   -0.43012 |     12.284 |     -91.805 |      29.057 |
- | "Electron Delta(Y)"                             |     12361 |  -3346.001 |   -0.27069 |     12.300 |     -72.810 |      22.669 |
- | "Electron Delta(Z)"                             |     12361 |     808253 |     65.387 |     14.046 |     -10.804 |      123.98 |
- | "Electron corrected energy"                     |     12361 |7.610144e+07 |     6156.6 |     7315.4 |      19.715 |  1.2204e+05 |
- | "Electrons pT-rejected after correction"        |       118 |
- | "Photon Delta(E)"                               |     23068 |   -5439614 |    -235.81 |     394.95 |     -4040.0 |      2229.9 |
- | "Photon Delta(X)"                               |     23068 |  -8730.937 |   -0.37849 |     12.697 |     -91.984 |      62.040 |
- | "Photon Delta(Y)"                               |     23068 |  -5262.413 |   -0.22813 |     12.658 |     -91.966 |      61.225 |
- | "Photon Delta(Z)"                               |     23068 |    1275993 |     55.314 |     13.041 |     -3.0947 |      123.98 |
- | "Photon corrected energy"                       |     23068 |7.962504e+07 |     3451.8 |     5803.5 |      33.744 |  1.2653e+05 |
- | "Photons pT-rejected after correction"          |       418 |
- | "electronHypos"                                 |       200 |      12243 |     61.215 |     37.151 |      4.0000 |      217.00 |
- | "photonHypos"                                   |       200 |      22650 |     113.25 |     49.375 |      10.000 |      235.00 |
+ | "Electron Delta(E)"                             |     12345 |   -5099258 |    -413.06 |     549.90 |     -5759.4 |      2744.3 |
+ | "Electron Delta(X)"                             |     12345 |  -5434.138 |   -0.44019 |     12.274 |     -91.805 |      29.057 |
+ | "Electron Delta(Y)"                             |     12345 |  -3326.301 |   -0.26945 |     12.295 |     -72.810 |      22.669 |
+ | "Electron Delta(Z)"                             |     12345 |   807322.1 |     65.397 |     14.037 |     -10.804 |      123.98 |
+ | "Electron corrected energy"                     |     12345 |7.605828e+07 |     6161.1 |     7318.9 |      19.715 |  1.2204e+05 |
+ | "Electrons pT-rejected after correction"        |       116 |
+ | "Photon Delta(E)"                               |     23206 |   -5485869 |    -236.40 |     395.05 |     -4040.0 |      2229.9 |
+ | "Photon Delta(X)"                               |     23206 |  -8461.052 |   -0.36461 |     12.689 |     -91.984 |      62.040 |
+ | "Photon Delta(Y)"                               |     23206 |  -5063.093 |   -0.21818 |     12.649 |     -91.966 |      61.225 |
+ | "Photon Delta(Z)"                               |     23206 |    1284195 |     55.339 |     13.049 |     -3.0947 |      123.98 |
+ | "Photon corrected energy"                       |     23206 |8.025952e+07 |     3458.6 |     5799.6 |      33.744 |  1.2653e+05 |
+ | "Photons pT-rejected after correction"          |       419 |
+ | "electronHypos"                                 |       200 |      12229 |     61.145 |     37.122 |      4.0000 |      220.00 |
+ | "photonHypos"                                   |       200 |      22787 |     113.94 |     49.911 |      10.000 |      237.00 |
 ClassifyPhotonElectronAlg_5a60ec...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "<alpha> Inner"                                 |     10031 |   9975.059 |    0.99442 |   0.019632 |     0.96439 |      1.1318 |
- | "<alpha> Middle"                                |      9321 |   9379.021 |     1.0062 |   0.020792 |     0.97670 |      1.2128 |
- | "<alpha> Outer"                                 |     15989 |   15979.84 |    0.99943 |   0.016327 |     0.97368 |      1.1242 |
- | "Pileup offset"                                 |     35341 |1.302632e+07 |     368.59 |     436.99 |      2.6870 |      4736.9 |
- | "Pileup scale"                                  |     35429 |     200791 |     5.6674 |     2.0043 |      1.0000 |      12.000 |
- | "Pileup subtracted ratio"                       |     35341 |   31084.85 |    0.87957 |    0.12304 |  0.00021643 |     0.99914 |
- | "Skip negative energy correction"               |        88 |
-CloneKillerForward_88e428e1            INFO Number of counters : 2
+ | "<alpha> Inner"                                 |     10077 |    10020.8 |    0.99442 |   0.019610 |     0.96439 |      1.1318 |
+ | "<alpha> Middle"                                |      9360 |   9418.309 |     1.0062 |   0.020798 |     0.97670 |      1.2128 |
+ | "<alpha> Outer"                                 |     16025 |   16016.12 |    0.99945 |   0.016331 |     0.97368 |      1.1242 |
+ | "Pileup offset"                                 |     35462 |1.307935e+07 |     368.83 |     436.91 |      2.6870 |      4736.9 |
+ | "Pileup scale"                                  |     35551 |     201517 |     5.6684 |     2.0043 |      1.0000 |      12.000 |
+ | "Pileup subtracted ratio"                       |     35462 |   31191.79 |    0.87958 |    0.12296 |  0.00021643 |     0.99914 |
+ | "Skip negative energy correction"               |        89 |
+CloneKillerMatch_a528b1df              INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "nTracksInput"                                  |       200 |      13652 |     68.260 |
- | "nTracksSelected"                               |       200 |       2588 |     12.940 |
+ | "nTracksInput"                                  |       200 |      13698 |     68.490 |
+ | "nTracksSelected"                               |       200 |       3167 |     15.835 |
 CopySignalMCParticles_daf3c6a8         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"copy signal"                                   |   1061346 |          0 |( 0.000000 +- 0.000000)% |
  |*"input container present"                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |       400 |     408491 |     1021.2 |     1472.0 |      2.0000 |      7400.0 |
+ | "# of cloned entries"                           |       400 |     413141 |     1032.9 |     1478.9 |      2.0000 |      7433.0 |
  |*"Input container absent"                        |       400 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |    190732 |     190732 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |    101978 |      90845 |( 89.08294 +- 0.09765554)% |
+ |*"MCParticles cloned"                            |    192046 |     192046 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |    104256 |      91472 |( 87.73788 +- 0.1015841)% |
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |       200 |
  | "Nb events removed"                             |        24 |
 FilteredPIDElectrons                   INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        181 |( 90.50000 +- 2.073343)% |
- |*"Cut selection efficiency"                      |     12976 |       1377 |( 10.61190 +- 0.2703747)% |
+ |*"#passed"                                       |       200 |        178 |( 89.00000 +- 2.212465)% |
+ |*"Cut selection efficiency"                      |     12515 |       1254 |( 10.01998 +- 0.2684052)% |
 FilteredPIDMuons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        194 |( 97.00000 +- 1.206234)% |
- |*"Cut selection efficiency"                      |     12976 |       2100 |( 16.18372 +- 0.3233203)% |
+ |*"#passed"                                       |       200 |        192 |( 96.00000 +- 1.385641)% |
+ |*"Cut selection efficiency"                      |     12515 |       2014 |( 16.09269 +- 0.3284723)% |
 FilteredPIDkaons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     12976 |       7726 |( 59.54069 +- 0.4308695)% |
-FunctionalParticleMaker_149889e6       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"Cut selection efficiency"                      |     12515 |       7203 |( 57.55493 +- 0.4418140)% |
+FunctionalParticleMaker_149889e6       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        194 |( 97.00000 +- 1.206234)% |
+ |*"# passed ProtoParticle filter"                 |      2432 |       2173 |( 89.35033 +- 0.6255102)% |
+ |*"# passed Track filter"                         |      2432 |       2432 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1097 |     5.4850 |     4.4755 |      0.0000 |      26.000 |
+ | "Nb created particles"                          |       200 |       1076 |     5.3800 |     4.2350 |      0.0000 |      23.000 |
 FunctionalParticleMaker_2ff3f10f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12290 |( 94.71332 +- 0.1964386)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6149 |     30.745 |     20.977 |      1.0000 |      126.00 |
- | "Nb created particles"                          |       200 |       6141 |     30.705 |     20.126 |      1.0000 |      113.00 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      11982 |( 95.74111 +- 0.1805020)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6017 |     30.085 |     20.026 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       5965 |     29.825 |     18.882 |      1.0000 |      102.00 |
 FunctionalParticleMaker_379cf33a       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6490 |     32.450 |     22.198 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6486 |     32.430 |     21.285 |      1.0000 |      117.00 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6302 |     31.510 |     20.885 |      1.0000 |      118.00 |
+ | "Nb created particles"                          |       200 |       6213 |     31.065 |     19.667 |      1.0000 |      105.00 |
+FunctionalParticleMaker_442c3d96       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         3 |          3 |( 100.0000 +- 0.000000)% |
+ |*"# passed ProtoParticle filter"                 |       183 |        177 |( 96.72131 +- 1.316393)% |
+ |*"# passed Track filter"                         |       183 |        183 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |         3 |         91 |     30.333 |     16.438 |      9.0000 |      49.000 |
+ | "Nb created particles"                          |         3 |         86 |     28.667 |     14.974 |      8.0000 |      43.000 |
 FunctionalParticleMaker_950c4697       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12290 |( 94.71332 +- 0.1964386)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6149 |     30.745 |     20.977 |      1.0000 |      126.00 |
- | "Nb created particles"                          |       200 |       6141 |     30.705 |     20.126 |      1.0000 |      113.00 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      11982 |( 95.74111 +- 0.1805020)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6017 |     30.085 |     20.026 |      1.0000 |      117.00 |
+ | "Nb created particles"                          |       200 |       5965 |     29.825 |     18.882 |      1.0000 |      102.00 |
 FunctionalParticleMaker_9614a368       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6490 |     32.450 |     22.198 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6486 |     32.430 |     21.285 |      1.0000 |      117.00 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6302 |     31.510 |     20.885 |      1.0000 |      118.00 |
+ | "Nb created particles"                          |       200 |       6213 |     31.065 |     19.667 |      1.0000 |      105.00 |
 FunctionalParticleMaker_a90be71f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6490 |     32.450 |     22.198 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6486 |     32.430 |     21.285 |      1.0000 |      117.00 |
-FunctionalParticleMaker_c5ad9787       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6302 |     31.510 |     20.885 |      1.0000 |      118.00 |
+ | "Nb created particles"                          |       200 |       6213 |     31.065 |     19.667 |      1.0000 |      105.00 |
+FunctionalParticleMaker_c5ad9787       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        194 |( 97.00000 +- 1.206234)% |
+ |*"# passed ProtoParticle filter"                 |      2432 |       2432 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |      2432 |       2432 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1223 |     6.1150 |     5.0102 |      0.0000 |      27.000 |
+ | "Nb created particles"                          |       200 |       1209 |     6.0450 |     4.7982 |      0.0000 |      28.000 |
 FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6490 |     32.450 |     22.198 |      1.0000 |      130.00 |
- | "Nb created particles"                          |       200 |       6486 |     32.430 |     21.285 |      1.0000 |      117.00 |
+ |*"# passed ProtoParticle filter"                 |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     12515 |      12515 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       6302 |     31.510 |     20.885 |      1.0000 |      118.00 |
+ | "Nb created particles"                          |       200 |       6213 |     31.065 |     19.667 |      1.0000 |      105.00 |
 FutureNeutralProtoPAlg_70ea5ecd        INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Neutral Protos"                                |       200 |      25002 |     125.01 |     60.345 |      10.000 |      301.00 |
+ | "Neutral Protos"                                |       200 |      25139 |     125.69 |     60.886 |      10.000 |      303.00 |
  | "Neutral Protos from MergedPi0s"                |       200 |        784 |     3.9200 |     4.6102 |      0.0000 |      24.000 |
- | "Neutral Protos from Photons"                   |       200 |      22650 |     113.25 |     49.375 |      10.000 |      235.00 |
+ | "Neutral Protos from Photons"                   |       200 |      22787 |     113.94 |     49.911 |      10.000 |      237.00 |
  | "Neutral Protos from SplitPhotons"              |       200 |       1568 |     7.8400 |     9.2203 |      0.0000 |      48.000 |
 GraphClustering_72971694               INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
@@ -283,13 +309,13 @@ Hlt2Test_Bs0ToJpsiPhi_JPsiToMupM...    INFO Number of counters : 1
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         65 |( 32.50000 +- 3.311910)% |
- |*"# passed CombinationCut"                       |     69390 |        164 |(0.2363453 +- 0.01843364)% |
- |*"# passed CompositeCut"                         |       164 |        160 |( 97.56098 +- 1.204548)% |
+ |*"# passed"                                      |       200 |         64 |( 32.00000 +- 3.298485)% |
+ |*"# passed CombinationCut"                       |     58976 |        164 |(0.2780792 +- 0.02168413)% |
+ |*"# passed CompositeCut"                         |       164 |        157 |( 95.73171 +- 1.578458)% |
  |*"# passed vertex fit"                           |       164 |        164 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       1377 |     6.8850 |
- | "candidate multiplicity"                        |       200 |        160 |    0.80000 |     1.7059 |      0.0000 |      12.000 |
+ | "Input1 size"                                   |       200 |      12515 |     62.575 |
+ | "Input2 size"                                   |       200 |       1254 |     6.2700 |
+ | "candidate multiplicity"                        |       200 |        157 |    0.78500 |     1.5902 |      0.0000 |      10.000 |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
@@ -323,67 +349,65 @@ Hlt2Test_sRTPhotons_Prescaler          INFO Number of counters : 1
 HltDecReportsFilter_895ecf8e           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_d2b05f88         INFO Number of counters : 2
+HltPackedBufferWriter_18f93d32         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |       200 |3.616088e+07 | 1.8080e+05 | 1.1467e+05 |      12764. |  6.4362e+05 |
+ | "Size of serialized data"                       |       200 |     565625 |     2828.1 |     3984.3 |      108.00 |      24585. |
 Hlt__RoutingBitsCombiner_6642b907      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |       200 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Events without Tracks"                   |         1 |          0 |     0.0000 |
- | "Nb of Produced Tracks"                         |       199 |      10378 |     52.151 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |       200 |      12976 |     64.880 |
+ | "Nb of Produced Tracks"                         |       199 |       8576 |     43.095 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
+ | "Nb of Produced Tracks"                         |       200 |      12515 |     62.575 |
+LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
+ | "Nb of Events without Tracks"                   |         6 |          0 |     0.0000 |
+ | "Nb of Produced Tracks"                         |       194 |       2432 |     12.536 |
 LHCb__Phys__ParticleMakers__Phot...    INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- | "Confidence Level"                              |     14699 |   5013.484 |    0.34108 |    0.33104 |  7.0212e-05 |     0.99473 |
- | "Created photons"                               |     22650 |
- | "Selected photons"                              |       200 |      14699 |     73.495 |     38.592 |      4.0000 |      185.00 |
-LHCb__SelectivePacker_c6eaf391         INFO Number of counters : 75
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BremInfos # containers packed"                 |       200 |        200 |     1.0000 |
- | "BremInfos # of packed entries"                 |       200 |       9516 |     47.580 |
- | "BremInfos buffer size"                         |       200 |     404072 |     2020.4 |
+ | "Confidence Level"                              |     14813 |   5030.912 |    0.33963 |    0.33078 |  7.0212e-05 |     0.99473 |
+ | "Created photons"                               |     22787 |
+ | "Selected photons"                              |       200 |      14813 |     74.065 |     39.084 |      4.0000 |      186.00 |
+LHCb__SelectivePacker_e4994c30         INFO Number of counters : 75
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BremInfos # containers packed"                 |       200 |         12 |   0.060000 |
+ | "BremInfos # of packed entries"                 |        12 |         54 |     4.5000 |
+ | "BremInfos buffer size"                         |        12 |       2532 |     211.00 |
  | "BremInfosSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "CaloAdcs # containers packed"                  |       200 |          0 |     0.0000 |
- | "CaloChargedPIDs # containers packed"           |       200 |        200 |     1.0000 |
- | "CaloChargedPIDs # of packed entries"           |       200 |      10973 |     54.865 |
- | "CaloChargedPIDs buffer size"                   |       200 |     662780 |     3313.9 |
+ | "CaloChargedPIDs # containers packed"           |       200 |         12 |   0.060000 |
+ | "CaloChargedPIDs # of packed entries"           |        12 |         58 |     4.8333 |
+ | "CaloChargedPIDs buffer size"                   |        12 |       3744 |     312.00 |
  | "CaloChargedPIDsSelection # containers packed"  |       200 |          0 |     0.0000 |
  | "CaloClusters # containers packed"              |       200 |          0 |     0.0000 |
  | "CaloClustersSelection # containers packed"     |       200 |          0 |     0.0000 |
  | "CaloDigits # containers packed"                |       200 |          0 |     0.0000 |
- | "CaloHypos # containers packed"                 |       200 |        800 |     4.0000 |
- | "CaloHypos # of packed entries"                 |       800 |      37245 |     46.556 |
- | "CaloHypos buffer size"                         |       800 |    2864616 |     3580.8 |
+ | "CaloHypos # containers packed"                 |       200 |        117 |    0.58500 |
+ | "CaloHypos # of packed entries"                 |       117 |        420 |     3.5897 |
+ | "CaloHypos buffer size"                         |       117 |      34962 |     298.82 |
  | "CaloHyposSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "ExtendedPVs # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTags # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTagsSelection # containers packed"      |       200 |          0 |     0.0000 |
- | "GlobalChargedPIDs # containers packed"         |       200 |        200 |     1.0000 |
- | "GlobalChargedPIDs # of packed entries"         |       200 |      12976 |     64.880 |
- | "GlobalChargedPIDs buffer size"                 |       200 |     731056 |     3655.3 |
+ | "GlobalChargedPIDs # containers packed"         |       200 |         12 |   0.060000 |
+ | "GlobalChargedPIDs # of packed entries"         |        12 |         70 |     5.8333 |
+ | "GlobalChargedPIDs buffer size"                 |        12 |       4184 |     348.67 |
  | "GlobalChargedPIDsSelection # containers packed"|       200 |          0 |     0.0000 |
- | "LightPVs # containers packed"                  |       200 |         16 |   0.080000 |
- | "LightPVs # of packed entries"                  |        16 |         26 |     1.6250 |
- | "LightPVs buffer size"                          |        16 |       1548 |     96.750 |
+ | "LightPVs # containers packed"                  |       200 |         18 |   0.090000 |
+ | "LightPVs # of packed entries"                  |        18 |         28 |     1.5556 |
+ | "LightPVs buffer size"                          |        18 |       1684 |     93.556 |
  | "LightPVsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "MuonPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "MuonPIDs # of packed entries"                  |       200 |      12976 |     64.880 |
- | "MuonPIDs buffer size"                          |       200 |     784452 |     3922.3 |
+ | "MuonPIDs # containers packed"                  |       200 |         12 |   0.060000 |
+ | "MuonPIDs # of packed entries"                  |        12 |         70 |     5.8333 |
+ | "MuonPIDs buffer size"                          |        12 |       4524 |     377.00 |
  | "MuonPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "NeutralPIDs # containers packed"               |       200 |        200 |     1.0000 |
- | "NeutralPIDs # of packed entries"               |       200 |      25002 |     125.01 |
- | "NeutralPIDs buffer size"                       |       200 |    1504520 |     7522.6 |
+ | "NeutralPIDs # containers packed"               |       200 |        103 |    0.51500 |
+ | "NeutralPIDs # of packed entries"               |       103 |        355 |     3.4466 |
+ | "NeutralPIDs buffer size"                       |       103 |      23566 |     228.80 |
  | "NeutralPIDsSelection # containers packed"      |       200 |          0 |     0.0000 |
  | "P2InfoRelations # containers packed"           |       200 |          0 |     0.0000 |
  | "P2IntRelations # containers packed"            |       200 |          0 |     0.0000 |
@@ -391,121 +415,151 @@ LHCb__SelectivePacker_c6eaf391         INFO Number of counters : 75
  | "P2PVRelations # containers packed"             |       200 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |       200 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |       200 |        400 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |       400 |     408491 |     1021.2 |
- | "PP2MCPRelations buffer size"                   |       400 |    8194620 |     20487. |
- | "PVs # containers packed"                       |       200 |        200 |     1.0000 |
- | "PVs # of packed entries"                       |       200 |        988 |     4.9400 |
- | "PVs buffer size"                               |       200 |     391724 |     1958.6 |
+ | "PP2MCPRelations # of packed entries"           |       400 |       8852 |     22.130 |
+ | "PP2MCPRelations buffer size"                   |       400 |     199560 |     498.90 |
+ | "PVs # containers packed"                       |       200 |        106 |    0.53000 |
+ | "PVs # of packed entries"                       |       106 |        606 |     5.7170 |
+ | "PVs buffer size"                               |       106 |      38752 |     365.58 |
  | "PVsSelection # containers packed"              |       200 |          0 |     0.0000 |
- | "Particles # containers packed"                 |       200 |        285 |     1.4250 |
- | "Particles # of packed entries"                 |       285 |        685 |     2.4035 |
- | "Particles buffer size"                         |       285 |     143968 |     505.15 |
- | "ParticlesSelection # containers packed"        |       200 |        262 |     1.3100 |
- | "ParticlesSelection # of packed entries"        |       262 |        385 |     1.4695 |
- | "ParticlesSelection buffer size"                |       262 |      10678 |     40.756 |
- | "ProtoParticles # containers packed"            |       200 |        800 |     4.0000 |
- | "ProtoParticles # of packed entries"            |       800 |      37978 |     47.472 |
- | "ProtoParticles buffer size"                    |       800 |    3059416 |     3824.3 |
+ | "Particles # containers packed"                 |       200 |        277 |     1.3850 |
+ | "Particles # of packed entries"                 |       277 |        671 |     2.4224 |
+ | "Particles buffer size"                         |       277 |     140872 |     508.56 |
+ | "ParticlesSelection # containers packed"        |       200 |        261 |     1.3050 |
+ | "ParticlesSelection # of packed entries"        |       261 |        384 |     1.4713 |
+ | "ParticlesSelection buffer size"                |       261 |      10641 |     40.770 |
+ | "ProtoParticles # containers packed"            |       200 |        115 |    0.57500 |
+ | "ProtoParticles # of packed entries"            |       115 |        425 |     3.6957 |
+ | "ProtoParticles buffer size"                    |       115 |      38642 |     336.02 |
  | "ProtoParticlesSelection # containers packed"   |       200 |          0 |     0.0000 |
- | "RecSummary # containers packed"                |       200 |        200 |     1.0000 |
- | "RecSummary # of packed entries"                |       200 |       7600 |     38.000 |
- | "RecSummary buffer size"                        |       200 |      34800 |     174.00 |
- | "RichPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "RichPIDs # of packed entries"                  |       200 |      12290 |     61.450 |
- | "RichPIDs buffer size"                          |       200 |     595120 |     2975.6 |
+ | "RecSummary # containers packed"                |       200 |        106 |    0.53000 |
+ | "RecSummary # of packed entries"                |       106 |       4028 |     38.000 |
+ | "RecSummary buffer size"                        |       106 |      18444 |     174.00 |
+ | "RichPIDs # containers packed"                  |       200 |         12 |   0.060000 |
+ | "RichPIDs # of packed entries"                  |        12 |         70 |     5.8333 |
+ | "RichPIDs buffer size"                          |        12 |       3672 |     306.00 |
  | "RichPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "Tracks # containers packed"                    |       200 |       1173 |     5.8650 |
- | "Tracks # of packed entries"                    |      1173 |      70863 |     60.412 |
- | "Tracks buffer size"                            |      1173 |1.676882e+07 |     14296. |
+ | "Tracks # containers packed"                    |       200 |         15 |   0.075000 |
+ | "Tracks # of packed entries"                    |        15 |         74 |     4.9333 |
+ | "Tracks buffer size"                            |        15 |      32290 |     2152.7 |
  | "TracksSelection # containers packed"           |       200 |          0 |     0.0000 |
  | "TwoProngVertices # containers packed"          |       200 |          0 |     0.0000 |
  | "TwoProngVerticesSelection # containers packed" |       200 |          0 |     0.0000 |
- | "Vertices # containers packed"                  |       200 |         52 |    0.26000 |
- | "Vertices # of packed entries"                  |        52 |         81 |     1.5577 |
- | "Vertices buffer size"                          |        52 |       8690 |     167.12 |
+ | "Vertices # containers packed"                  |       200 |         46 |    0.23000 |
+ | "Vertices # of packed entries"                  |        46 |         70 |     1.5217 |
+ | "Vertices buffer size"                          |        46 |       7556 |     164.26 |
  | "VerticesSelection # containers packed"         |       200 |          0 |     0.0000 |
  | "WeightsVectors # containers packed"            |       200 |          0 |     0.0000 |
+MuonIDHlt2AlgDownstream_81ff20a8       INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BgLL"                                          |       255 |   -227.724 |   -0.89304 |     1.3706 |     -7.8932 |      0.0000 |
+ | "MuLL"                                          |       255 |  -2093.102 |    -8.2082 |     3.7667 |     -11.513 |   -0.021982 |
+ | "muonMVAStat"                                   |       255 |  -89.66325 |   -0.35162 |     1.0516 |     -2.9175 |      4.1566 |
+ |*"nInAcceptance"                                 |      2432 |       1612 |( 66.28289 +- 0.9586147)% |
+ |*"nIsMuon"                                       |      2432 |        255 |( 10.48520 +- 0.6212322)% |
+ |*"nIsMuonTight"                                  |      2432 |        135 |( 5.550987 +- 0.4643036)% |
+ |*"nMomentumCut"                                  |      2432 |       1752 |( 72.03947 +- 0.9100728)% |
 MuonIDHlt2AlgLong_ebde3a89             INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BgLL"                                          |      1285 |  -857.8998 |   -0.66763 |     1.0379 |     -7.2270 |      0.0000 |
- | "MuLL"                                          |      1285 |  -11158.03 |    -8.6833 |     3.3971 |     -11.513 |   -0.046525 |
- | "muonMVAStat"                                   |      1285 |  -669.2733 |   -0.52084 |    0.89012 |     -3.0272 |      4.0084 |
- |*"nInAcceptance"                                 |     12976 |      10225 |( 78.79932 +- 0.3588110)% |
- |*"nIsMuon"                                       |     12976 |       1285 |( 9.902898 +- 0.2622202)% |
- |*"nIsMuonTight"                                  |     12976 |        642 |( 4.947596 +- 0.1903743)% |
- |*"nMomentumCut"                                  |     12976 |      10955 |( 84.42509 +- 0.3183304)% |
+ | "BgLL"                                          |      1189 |  -735.8779 |   -0.61890 |    0.97115 |     -6.5332 |      0.0000 |
+ | "MuLL"                                          |      1189 |  -10482.86 |    -8.8165 |     3.3110 |     -11.513 |   -0.092727 |
+ | "muonMVAStat"                                   |      1189 |  -653.0669 |   -0.54926 |    0.86011 |     -3.0272 |      4.1590 |
+ |*"nInAcceptance"                                 |     12515 |       9993 |( 79.84818 +- 0.3585702)% |
+ |*"nIsMuon"                                       |     12515 |       1189 |( 9.500599 +- 0.2621096)% |
+ |*"nIsMuonTight"                                  |     12515 |        577 |( 4.610467 +- 0.1874595)% |
+ |*"nMomentumCut"                                  |     12515 |      10706 |( 85.54535 +- 0.3143306)% |
+MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of input v2 MuonPIDs"                       |       200 |       2432 |     12.160 |
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of input v2 MuonPIDs"                       |       200 |      12976 |     64.880 |
+ | "Nb of input v2 MuonPIDs"                       |       200 |      12515 |     62.575 |
 NeutralProtoParticleAssociator_9...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     25002 |      23326 |( 93.29654 +- 0.1581594)% |
- | "MC particles per ProtoParticle"                |     23326 |     395416 |     16.952 |
+ |*"Efficiency"                                    |     25139 |      23463 |( 93.33307 +- 0.1573283)% |
+ | "MC particles per ProtoParticle"                |     23463 |     398166 |     16.970 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |       200 |     190732 |     953.66 |     601.36 |      65.000 |      2975.0 |
+ | "#MCParticles"                                  |       200 |     192046 |     960.23 |     602.86 |      65.000 |      2916.0 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |       200 |      90845 |     454.23 |     293.10 |      26.000 |      1441.0 |
+ | "#MCVertices"                                   |       200 |      91472 |     457.36 |     294.14 |      26.000 |      1430.0 |
 ParticleRangeFilter_22f84c5e           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        174 |( 87.00000 +- 2.378024)% |
- |*"Cut selection efficiency"                      |     12976 |       1048 |( 8.076449 +- 0.2391956)% |
+ |*"#passed"                                       |       200 |        175 |( 87.50000 +- 2.338536)% |
+ |*"Cut selection efficiency"                      |     12515 |       1016 |( 8.118258 +- 0.2441353)% |
 ParticleRangeFilter_2cf9c882           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         40 |( 20.00000 +- 2.828427)% |
- |*"Cut selection efficiency"                      |     14699 |         46 |(0.3129465 +- 0.04606918)% |
+ |*"Cut selection efficiency"                      |     14813 |         46 |(0.3105380 +- 0.04571519)% |
 ParticleRangeFilter_2d1c6dde           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         42 |( 21.00000 +- 2.880104)% |
- |*"Cut selection efficiency"                      |     14699 |         48 |(0.3265528 +- 0.04705682)% |
+ |*"Cut selection efficiency"                      |     14813 |         48 |(0.3240397 +- 0.04669526)% |
 ParticleRangeFilter_2dd22701           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         61 |( 30.50000 +- 3.255572)% |
- |*"Cut selection efficiency"                      |     12290 |         88 |(0.7160293 +- 0.07605522)% |
+ |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
+ |*"Cut selection efficiency"                      |     11982 |         90 |(0.7511267 +- 0.07887779)% |
+ParticleRangeFilter_32aaad9e           INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         3 |          2 |( 66.66667 +- 27.21655)% |
+ |*"Cut selection efficiency"                      |       177 |          9 |( 5.084746 +- 1.651262)% |
 ParticleRangeFilter_497ef01a           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         89 |( 44.50000 +- 3.514079)% |
- |*"Cut selection efficiency"                      |     12290 |        169 |( 1.375102 +- 0.1050473)% |
+ |*"#passed"                                       |       200 |         90 |( 45.00000 +- 3.517812)% |
+ |*"Cut selection efficiency"                      |     11982 |        178 |( 1.485562 +- 0.1105174)% |
 ParticleRangeFilter_7c68ac05           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     14699 |       3666 |( 24.94047 +- 0.3568711)% |
+ |*"Cut selection efficiency"                      |     14813 |       3686 |( 24.88355 +- 0.3552239)% |
 ParticleRangeFilter_8ad15fd6           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         9 |          9 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |       783 |        118 |( 15.07024 +- 1.278525)% |
-ParticleRangeFilter_9dfc592f           INFO Number of counters : 1
+ |*"#passed"                                       |        10 |         10 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |       840 |        136 |( 16.19048 +- 1.270975)% |
+ParticleRangeFilter_9dfc592f           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |         72 |( 36.00000 +- 3.394113)% |
+ |*"Cut selection efficiency"                      |      2173 |        104 |( 4.786010 +- 0.4579387)% |
 ParticleRangeFilter_a654d6c9           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
- |*"Cut selection efficiency"                      |     14699 |         92 |(0.6258929 +- 0.06504932)% |
-ParticleRangeFilter_f1423675           INFO Number of counters : 1
+ |*"Cut selection efficiency"                      |     14813 |         92 |(0.6210761 +- 0.06455027)% |
+ParticleRangeFilter_f1423675           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        191 |( 95.50000 +- 1.465862)% |
+ |*"Cut selection efficiency"                      |      2432 |       1646 |( 67.68092 +- 0.9483766)% |
 ParticleRangeFilter_f36346d4           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
 ParticleUnbiasedPVAdder_198323e6       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |        13 |
+ | "PV unbiasing successful"                       |        14 |
 ParticleUnbiasedPVAdder_49026aff       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |        13 |
+ | "PV unbiasing successful"                       |        14 |
 ParticleWithBremMaker_49ed8ce1         INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of particles corrected with brem (including those without change)"|     12976 |
+ | "Nb of particles corrected with brem (including those without change)"|     12515 |
 ParticleWithBremMaker_49ed8ce1.S...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Delta(E)"                                      |       916 |    4051262 |     4422.8 |     7129.2 |      4.1201 |  1.0095e+05 |
- | "Nb photons added to single electrons"          |     12976 |        916 |   0.070592 |    0.25614 |      0.0000 |      1.0000 |
-PrCloneKillerSeed_8e934c5f             INFO Number of counters : 2
+ | "Delta(E)"                                      |       870 |    3742993 |     4302.3 |     6935.0 |      4.1199 |  1.0095e+05 |
+ | "Nb photons added to single electrons"          |     12515 |        870 |   0.069517 |    0.25433 |      0.0000 |      1.0000 |
+PrCloneKillerDown_93e0ec59             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      13806 |     69.030 |
+ | "nTracksSelected"                               |       200 |       3647 |     18.235 |
+PrCloneKillerSeedDown_913c1b16         INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      10904 |     54.520 |
+ | "nTracksSelected"                               |       200 |       8576 |     42.880 |
+PrCloneKillerSeed_cd7a5f5f             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       200 |      22369 |     111.84 |
- | "nTracksSelected"                               |       200 |      10378 |     51.890 |
-PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
+ | "nTracksSelected"                               |       200 |      10904 |     54.520 |
+PrCloneKillerUp_406af2b0               INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       106 |       5362 |     50.585 |
+ | "nTracksSelected"                               |       106 |       1384 |     13.057 |
+PrForwardTrackingVelo_a7f67b46         INFO Number of counters : 10
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Accepted input tracks"                         |       200 |      27631 |     138.16 |
  | "Created long tracks"                           |       200 |      13652 |     68.260 |
@@ -517,6 +571,10 @@ PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
  | "Number of x candidates per track 2nd Loop"     |     12566 |      79049 |     6.2907 |     11.091 |
  | "Percentage second loop execution"              |     23872 |      12566 |    0.52639 |
  | "Removed duplicates"                            |       200 |        781 |     3.9050 |
+PrForwardTrackingVelo_a7f67b46.P...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     12001 |      48452 |     4.0373 |
+ | "#tracks with hits added"                       |     12001 |
 PrHybridSeeding_97242385               INFO Number of counters : 21
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Created T2x1 three-hit combinations in case 0" |    451881 |     283734 |    0.62790 |    0.63420 |      0.0000 |      6.0000 |
@@ -540,30 +598,60 @@ PrHybridSeeding_97242385               INFO Number of counters : 21
  | "Created two-hit combinations in case 0"        |     64817 |    1590410 |     24.537 |     18.401 |      0.0000 |      119.00 |
  | "Created two-hit combinations in case 1"        |     58134 |    2008013 |     34.541 |     22.781 |      0.0000 |      182.00 |
  | "Created two-hit combinations in case 2"        |     49019 |    2612869 |     53.303 |     35.316 |      1.0000 |      252.00 |
-PrKalmanFilterForward_92f61463         INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       350 |
- | "chi2 cut"                                      |       748 |
- | "nIterations"                                   |      2588 |       7075 |     2.7338 |
- | "nOutlierIterations"                            |      2238 |       2376 |     1.0617 |
- | "nTracksInput"                                  |       200 |       2588 |     12.940 |
- | "nTracksOutput"                                 |       200 |       1490 |     7.4500 |
-PrKalmanFilterMatch_fdc68e9f           INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       280 |
- | "chi2 cut"                                      |       982 |
- | "nIterations"                                   |     13698 |      29749 |     2.1718 |
- | "nOutlierIterations"                            |     13418 |       7097 |    0.52892 |
- | "nTracksInput"                                  |       200 |      13698 |     68.490 |
- | "nTracksOutput"                                 |       200 |      12436 |     62.180 |
-PrLHCbID2MCParticleVPFTMU_7d3ccc1b     INFO Number of counters : 1
+PrKalmanFilterForward_907c6c68         INFO Number of counters : 6
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#removed null MCParticles"                     |   1283247 |       2459 |  0.0019162 |
-PrMatchNN_946089ac                     INFO Number of counters : 3
+ | "Pre outlier chi2 cut"                          |       444 |
+ | "chi2 cut"                                      |      1505 |
+ | "nIterations"                                   |     13652 |      31574 |     2.3128 |
+ | "nOutlierIterations"                            |     13208 |       8728 |    0.66081 |
+ | "nTracksInput"                                  |       200 |      13652 |     68.260 |
+ | "nTracksOutput"                                 |       200 |      11703 |     58.515 |
+PrKalmanFilterMatch_8b37c0b3           INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       334 |
+ | "chi2 cut"                                      |      1532 |
+ | "nIterations"                                   |      3167 |       8081 |     2.5516 |
+ | "nOutlierIterations"                            |      2833 |       3094 |     1.0921 |
+ | "nTracksInput"                                  |       200 |       3167 |     15.835 |
+ | "nTracksOutput"                                 |       200 |       1301 |     6.5050 |
+PrKalmanFilter_Downstream_774e4436     INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       560 |
+ | "chi2 cut"                                      |       655 |
+ | "nIterations"                                   |      3647 |       9307 |     2.5520 |
+ | "nOutlierIterations"                            |      3087 |       1826 |    0.59151 |
+ | "nTracksInput"                                  |       200 |       3647 |     18.235 |
+ | "nTracksOutput"                                 |       200 |       2432 |     12.160 |
+PrKalmanFilter_Upstream_1cb85a56       INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |        97 |
+ | "chi2 cut"                                      |       214 |
+ | "nIterations"                                   |      1384 |       2815 |     2.0340 |
+ | "nOutlierIterations"                            |      1287 |        466 |    0.36208 |
+ | "nTracksInput"                                  |       106 |       1384 |     13.057 |
+ | "nTracksOutput"                                 |       106 |       1073 |     10.123 |
+PrLHCbID2MCParticleVPUTFTMU_dc79...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#removed null MCParticles"                     |   1491997 |       2459 |  0.0016481 |
+PrLongLivedTracking_83484006           INFO Number of counters : 8
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Downstream tracks made"                       |       200 |      13806 |     69.030 |
+ | "#Good XUVcand"                                 |     20446 |     100948 |     4.9373 |
+ | "#Good Xcand"                                   |     20446 |     317421 |     15.525 |
+ | "#Presel hits0"                                 |     20446 |     269274 |     13.170 |
+ | "#Presel hits1"                                 |     20446 |     270310 |     13.221 |
+ | "#Presel hits2"                                 |     20446 |     260477 |     12.740 |
+ | "#Presel hits3"                                 |     20446 |     267138 |     13.066 |
+ | "#Seeds"                                        |       200 |      22369 |     111.84 |
+PrMatchNN_915466c5                     INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#MatchingChi2"                                 |       200 |   231766.3 |     1158.8 |
  | "#MatchingMLP"                                  |     13698 |   11446.23 |    0.83561 |
  | "#MatchingTracks"                               |       200 |      13698 |     68.490 |
+PrMatchNN_915466c5.PrAddUTHitsTool     INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11921 |      48156 |     4.0396 |
+ | "#tracks with hits added"                       |     11921 |
 PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Average X in T1U"                              |     65585 |    1832058 |     27.934 |     1214.1 |     -2656.0 |      2656.4 |
@@ -591,13 +679,26 @@ PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  | "Hits in T3X1"                                  |       800 |      68009 |     85.011 |     36.453 |      23.000 |      264.00 |
  | "Hits in T3X2"                                  |       800 |      74560 |     93.200 |     39.732 |      22.000 |      249.00 |
  | "Total number of hits"                          |       200 |     807039 |     4035.2 |     1656.6 |      1290.0 |      9859.0 |
-PrTrackAssociator_fa20e82b             INFO Number of counters : 2
+PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# RawBank::UT banks"                           |       200 |      43200 |     216.00 |
+ | "# RawBank::UTError banks"                      |       200 |          0 |     0.0000 |
+ |*"Non-unique UT clusters in event"               |       200 |          0 |( 0.000000 +- 0.000000)% |
+PrTrackAssociator_1cbc46b9             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12976 |      11234 |( 86.57522 +- 0.2992816)% |
- | "MC particles per track"                        |     11234 |      13075 |     1.1639 |
+ |*"Efficiency"                                    |     12515 |      11207 |( 89.54854 +- 0.2734653)% |
+ | "MC particles per track"                        |     11207 |      13011 |     1.1610 |
+PrTrackAssociator_49a0075c             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |      2432 |       1964 |( 80.75658 +- 0.7993709)% |
+ | "MC particles per track"                        |      1964 |       1964 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
+PrVeloUT_daa62e37                      INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#seeds"                                        |       106 |      19714 |     185.98 |
+ | "#tracks"                                       |       106 |       5362 |     50.585 |
 SelectHlt1HltDecReports                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Number of selected banks"                      |       200 |          0 |( 0.000000 +- 0.000000)% |
@@ -610,105 +711,133 @@ SelectHlt1HltSelReports                INFO Number of counters : 1
 SelectiveCombineRawBanks_for_def...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Empty RawBank::View"                           |      1600 |          0 |     0.0000 |     0.0000 | 1.7977e+308 |-1.7977e+308 |
-TBTCForward_afd7320e                   INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |      1405 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |      1405 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |      1405 |
-TBTC_Match_61db36c4                    INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |     11571 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |     11571 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |     11571 |
+TBTCMatch_239b7419                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1237 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1237 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1237 |
+TBTC_Forward_805a8cb5                  INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |     11278 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |     11278 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |     11278 |
+TBTC_down_a8eb2751                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      2432 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      2432 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      2432 |
+TBTC_up_2250d07b                       INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1070 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1070 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1070 |
 Test_BdsToPhiPhiCombiner               INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       103 |          1 |(0.9708738 +- 0.9661493)% |
- |*"# passed CombinationCut"                       |       560 |         13 |( 2.321429 +- 0.6363313)% |
- |*"# passed CompositeCut"                         |        13 |          1 |( 7.692308 +- 7.390530)% |
- |*"# passed vertex fit"                           |        13 |         13 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       103 |        286 |     2.7767 |
- | "Input2 size"                                   |       103 |        286 |     2.7767 |
- | "candidate multiplicity"                        |       103 |          1 |  0.0097087 |   0.098053 |      0.0000 |      1.0000 |
+ |*"# passed"                                      |        96 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |       574 |         14 |( 2.439024 +- 0.6438581)% |
+ |*"# passed CompositeCut"                         |        14 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |        14 |         14 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        96 |        272 |     2.8333 |
+ | "Input2 size"                                   |        96 |        272 |     2.8333 |
+ | "candidate multiplicity"                        |        96 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Bs2JPsiPhiCombiner_67dc4ee3       INFO Number of counters : 8
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        65 |         10 |( 15.38462 +- 4.475188)% |
- |*"# passed CombinationCut"                       |       716 |        146 |( 20.39106 +- 1.505720)% |
- |*"# passed CompositeCut"                         |       146 |         18 |( 12.32877 +- 2.720896)% |
- |*"# passed vertex fit"                           |       146 |        146 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        65 |        160 |     2.4615 |
- | "Input2 size"                                   |        65 |        174 |     2.6769 |
- | "Lifetime fit did not converge. Aborting."      |         6 |
- | "candidate multiplicity"                        |        65 |         18 |    0.27692 |    0.85048 |      0.0000 |      5.0000 |
+ |*"# passed"                                      |        64 |          8 |( 12.50000 +- 4.133986)% |
+ |*"# passed CombinationCut"                       |       682 |        122 |( 17.88856 +- 1.467565)% |
+ |*"# passed CompositeCut"                         |       122 |         14 |( 11.47541 +- 2.885600)% |
+ |*"# passed vertex fit"                           |       122 |        122 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        64 |        157 |     2.4531 |
+ | "Input2 size"                                   |        64 |        173 |     2.7031 |
+ | "Lifetime fit did not converge. Aborting."      |         2 |
+ | "candidate multiplicity"                        |        64 |         14 |    0.21875 |    0.69527 |      0.0000 |      4.0000 |
 Test_Bs2JPsiPhiCombiner_d1451b3c       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        87 |          8 |( 9.195402 +- 3.097987)% |
- |*"# passed CombinationCut"                       |       705 |        155 |( 21.98582 +- 1.559781)% |
- |*"# passed CompositeCut"                         |       155 |         13 |( 8.387097 +- 2.226477)% |
- |*"# passed vertex fit"                           |       155 |        155 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        87 |        206 |     2.3678 |
- | "Input2 size"                                   |        87 |        199 |     2.2874 |
- | "candidate multiplicity"                        |        87 |         13 |    0.14943 |    0.51481 |      0.0000 |      3.0000 |
+ |*"# passed"                                      |        85 |          9 |( 10.58824 +- 3.337334)% |
+ |*"# passed CombinationCut"                       |       685 |        147 |( 21.45985 +- 1.568606)% |
+ |*"# passed CompositeCut"                         |       147 |         14 |( 9.523810 +- 2.421106)% |
+ |*"# passed vertex fit"                           |       147 |        147 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        85 |        200 |     2.3529 |
+ | "Input2 size"                                   |        85 |        185 |     2.1765 |
+ | "candidate multiplicity"                        |        85 |         14 |    0.16471 |    0.57080 |      0.0000 |      4.0000 |
 Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        40 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |         88 |    0.44000 |
- | "Input2 size"                                   |       200 |         88 |    0.44000 |
+ |*"# passed CombinationCut"                       |        34 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |         90 |    0.45000 |
+ | "Input2 size"                                   |       200 |         90 |    0.45000 |
  | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_LambdaFromHyperon_LL     INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          9 |( 4.500000 +- 1.465862)% |
- |*"# passed CombinationCut"                       |       748 |         17 |( 2.272727 +- 0.5449175)% |
- |*"# passed CompositeCut"                         |        17 |          9 |( 52.94118 +- 12.10578)% |
- |*"# passed vertex fit"                           |        17 |         17 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |        169 |    0.84500 |
- | "Input2 size"                                   |       200 |       1048 |     5.2400 |
- | "candidate multiplicity"                        |       200 |          9 |   0.045000 |    0.20730 |      0.0000 |      1.0000 |
-Test_Hyperons_Lambda_DD                INFO Number of counters : 4
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |          0 |     0.0000 |
- | "Input2 size"                                   |       200 |          0 |     0.0000 |
- | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |       200 |         10 |( 5.000000 +- 1.541104)% |
+ |*"# passed CombinationCut"                       |       730 |         19 |( 2.602740 +- 0.5892876)% |
+ |*"# passed CompositeCut"                         |        19 |         10 |( 52.63158 +- 11.45489)% |
+ |*"# passed vertex fit"                           |        19 |         19 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        178 |    0.89000 |
+ | "Input2 size"                                   |       200 |       1016 |     5.0800 |
+ | "candidate multiplicity"                        |       200 |         10 |   0.050000 |    0.21794 |      0.0000 |      1.0000 |
+Test_Hyperons_Lambda_DD                INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |          3 |( 1.500000 +- 0.8595057)% |
+ |*"# passed CombinationCut"                       |       715 |          9 |( 1.258741 +- 0.4169313)% |
+ |*"# passed CompositeCut"                         |         9 |          3 |( 33.33333 +- 15.71348)% |
+ |*"# passed vertex fit"                           |         9 |          9 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        104 |    0.52000 |
+ | "Input2 size"                                   |       200 |       1646 |     8.2300 |
+ | "candidate multiplicity"                        |       200 |          3 |   0.015000 |    0.12155 |      0.0000 |      1.0000 |
+Test_Hyperons_Xic0ToL0PimPip_DD        INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         3 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed Combination12Cut"                     |         4 |          1 |( 25.00000 +- 21.65064)% |
+ |*"# passed CombinationCut"                       |         2 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         3 |          3 |     1.0000 |
+ | "Input2 size"                                   |         3 |          9 |     3.0000 |
+ | "Input3 size"                                   |         3 |          9 |     3.0000 |
+ | "candidate multiplicity"                        |         3 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_Xim_LLL                  INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |         9 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        62 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |         9 |          9 |     1.0000 |
- | "Input2 size"                                   |         9 |        118 |     13.111 |
- | "candidate multiplicity"                        |         9 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |        10 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |        71 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |        10 |         10 |     1.0000 |
+ | "Input2 size"                                   |        10 |        136 |     13.600 |
+ | "candidate multiplicity"                        |        10 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_MassConstrJpsi2MuMuMaker          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         87 |( 43.50000 +- 3.505531)% |
- |*"# passed CombinationCut"                       |     48507 |        214 |(0.4411734 +- 0.03009140)% |
- |*"# passed CompositeCut"                         |       214 |        206 |( 96.26168 +- 1.296755)% |
- |*"# passed vertex fit"                           |       214 |        214 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       2100 |     10.500 |
- | "candidate multiplicity"                        |       200 |        206 |     1.0300 |     1.6490 |      0.0000 |      11.000 |
+ |*"# passed"                                      |       200 |         85 |( 42.50000 +- 3.495533)% |
+ |*"# passed CombinationCut"                       |     43915 |        209 |(0.4759194 +- 0.03284160)% |
+ |*"# passed CompositeCut"                         |       209 |        200 |( 95.69378 +- 1.404161)% |
+ |*"# passed vertex fit"                           |       209 |        209 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      12515 |     62.575 |
+ | "Input2 size"                                   |       200 |       2014 |     10.070 |
+ | "candidate multiplicity"                        |       200 |        200 |     1.0000 |     1.6340 |      0.0000 |      9.0000 |
 Test_Phi2KKMaker                       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |        103 |( 51.50000 +- 3.533943)% |
- |*"# passed CombinationCut"                       |    188545 |      13014 |( 6.902331 +- 0.05837942)% |
- |*"# passed CompositeCut"                         |     13014 |        286 |( 2.197633 +- 0.1285130)% |
- |*"# passed vertex fit"                           |     13014 |      13014 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       7726 |     38.630 |
- | "candidate multiplicity"                        |       200 |        286 |     1.4300 |     2.2327 |      0.0000 |      13.000 |
+ |*"# passed"                                      |       200 |         96 |( 48.00000 +- 3.532704)% |
+ |*"# passed CombinationCut"                       |    165155 |       9800 |( 5.933820 +- 0.05813505)% |
+ |*"# passed CompositeCut"                         |      9800 |        272 |( 2.775510 +- 0.1659381)% |
+ |*"# passed vertex fit"                           |      9800 |       9800 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      12515 |     62.575 |
+ | "Input2 size"                                   |       200 |       7203 |     36.015 |
+ | "candidate multiplicity"                        |       200 |        272 |     1.3600 |     2.2914 |      0.0000 |      14.000 |
 Test_Pi0ToGammaGamma_Combiner          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |         81 |( 40.50000 +- 3.471131)% |
- |*"# passed CombinationCut"                       |     40326 |        140 |(0.3471706 +- 0.02929029)% |
- |*"# passed CompositeCut"                         |       140 |        140 |( 100.0000 +- 0.000000)% |
- |*"# passed vertex fit"                           |       140 |        140 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |       3666 |     18.330 |
- | "Input2 size"                                   |       200 |       3666 |     18.330 |
- | "candidate multiplicity"                        |       200 |        140 |    0.70000 |     1.0536 |      0.0000 |      4.0000 |
+ |*"# passed CombinationCut"                       |     40795 |        142 |(0.3480819 +- 0.02915950)% |
+ |*"# passed CompositeCut"                         |       142 |        142 |( 100.0000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |       142 |        142 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |       3686 |     18.430 |
+ | "Input2 size"                                   |       200 |       3686 |     18.430 |
+ | "candidate multiplicity"                        |       200 |        142 |    0.71000 |     1.0705 |      0.0000 |      4.0000 |
 TrackBeamLineVertexFinderSoA_609...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fraction of failed PV fits"                    |      1009 |          1 |(0.09910803 +- 0.09905890)% |
  |*"Fraction of unconverged PV fits"               |      1009 |         68 |( 6.739346 +- 0.7892462)% |
  | "Nb PVs"                                        |       200 |        988 |     4.9400 |
+UTHitClustersToPrUTHitsConverter...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
+UTHitClustersToUTHitHandlerConve...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
 VPLightClustersToVPMicroClusters...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# Converted Clusters"                          |       200 |     420481 |     2102.4 |
@@ -731,15 +860,18 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
  | "Nb of Produced Tracks"                         |       200 |      46224 |     231.12 |
-fromPrSeedingTracksV1Tracks_320a...    INFO Number of counters : 1
+fromPrSeedingTracksV1Tracks_8d48...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of converted Tracks"                        |       200 |      10378 |     51.890 |
+ | "Nb of converted Tracks"                        |       200 |       8576 |     42.880 |
 fromPrVeloTracksV1TracksMerger_8...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of converted Tracks"                        |       200 |      46224 |     231.12 |
+fromV2MuonPIDV1MuonPIDDownstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of Produced MuonPIDs"                       |       200 |       2432 |     12.160 |
 fromV2MuonPIDV1MuonPIDLong_e60c416d    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced MuonPIDs"                       |       200 |      12976 |     64.880 |
+ | "Nb of Produced MuonPIDs"                       |       200 |      12515 |     62.575 |
 require_pvs                            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-opt
index a8dac100baa..233dc38ef16 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_test_flagging.ref.x86_64_v3-opt
@@ -4,36 +4,32 @@ ApplicationMgr                         INFO Application Manager Finalized succes
 ApplicationMgr                         INFO Application Manager Terminated successfully
 CaloAcceptanceBremAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.086 |      0.0000 |      61.000 |
+ | "#tracks in acceptance"                         |       200 |       2046 |     10.230 |     7.7651 |      0.0000 |      40.000 |
 CaloAcceptanceBremAlg_Long_142dbbc6    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     42.669 |      2.0000 |      238.00 |
- | "#tracks in acceptance"                         |       200 |       9534 |     47.670 |     31.025 |      1.0000 |      173.00 |
-CaloAcceptanceBremAlg_Upstream_3...    INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |      11847 |     59.235 |     37.791 |      2.0000 |      216.00 |
+ | "#tracks in acceptance"                         |       200 |       9007 |     45.035 |     28.473 |      1.0000 |      166.00 |
 CaloAcceptanceEcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.086 |      0.0000 |      61.000 |
+ | "#tracks in acceptance"                         |       200 |       2301 |     11.505 |     8.8532 |      0.0000 |      52.000 |
 CaloAcceptanceEcalAlg_Long_71599283    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     42.669 |      2.0000 |      238.00 |
- | "#tracks in acceptance"                         |       200 |      10869 |     54.345 |     35.826 |      2.0000 |      195.00 |
+ | "#total tracks"                                 |       200 |      11847 |     59.235 |     37.791 |      2.0000 |      216.00 |
+ | "#tracks in acceptance"                         |       200 |      10093 |     50.465 |     32.301 |      2.0000 |      177.00 |
 CaloAcceptanceEcalAlg_Ttrack_b29...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      10374 |     51.870 |     52.107 |      0.0000 |      480.00 |
- | "#tracks in acceptance"                         |       200 |       8351 |     41.755 |     44.619 |      0.0000 |      420.00 |
+ | "#total tracks"                                 |       200 |       8650 |     43.250 |     47.954 |      0.0000 |      445.00 |
+ | "#tracks in acceptance"                         |       200 |       6933 |     34.665 |     41.057 |      0.0000 |      389.00 |
 CaloAcceptanceHcalAlg_Downstream...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "#tracks in acceptance"                         |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#total tracks"                                 |       200 |       2984 |     14.920 |     11.086 |      0.0000 |      61.000 |
+ | "#tracks in acceptance"                         |       200 |       2101 |     10.505 |     8.0796 |      0.0000 |      48.000 |
 CaloAcceptanceHcalAlg_Long_1fd97970    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#total tracks"                                 |       200 |      12976 |     64.880 |     42.669 |      2.0000 |      238.00 |
- | "#tracks in acceptance"                         |       200 |      10199 |     50.995 |     33.644 |      2.0000 |      186.00 |
+ | "#total tracks"                                 |       200 |      11847 |     59.235 |     37.791 |      2.0000 |      216.00 |
+ | "#tracks in acceptance"                         |       200 |       9481 |     47.405 |     30.399 |      2.0000 |      167.00 |
 CaloClusterMCTruth_f74c042c            INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#CC2MC links"                                  |       200 |     605231 |     3026.2 |
@@ -56,8 +52,8 @@ CaloFutureHypoMCTruth_62e2fa0d         INFO Number of counters : 2
  | "#links/hypo"                                   |       784 |      25172 |     32.107 |
 CaloFutureHypoMCTruth_e86f8ec2         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links"                                        |       200 |     370188 |     1850.9 |
- | "#links/hypo"                                   |     22644 |     370188 |     16.348 |
+ | "#links"                                        |       200 |     373017 |     1865.1 |
+ | "#links/hypo"                                   |     22784 |     373017 |     16.372 |
 CaloFutureMergedPi0_eb4f3a3b           INFO Number of counters : 12
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cluster without 2nd seed found"                |       784 |          0 |( 0.000000 +- 0.000000)% |
@@ -86,163 +82,190 @@ CaloFutureMergedPi0_eb4f3a3b.Eca...    INFO Number of counters : 3
  | "Corrected Clusters: # cells "                  |       184 |       1047 |     5.6902 |     1.6865 |      3.0000 |      9.0000 |
  | "Corrected Clusters: ET"                        |       184 |   165760.6 |     900.87 |     881.52 |      3.6000 |      7563.0 |
  | "Corrected Clusters: size ratio"                |       184 |   86.09101 |    0.46789 |    0.46423 |    0.015364 |      2.2345 |
-CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 1
+CaloSelectiveBremMatchAlg_Downst...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |        662 |     3.3100 |     3.6392 |      0.0000 |      18.000 |
+ | "average chi2"                                  |       662 |   2479.741 |     3.7458 |     4.7409 |   0.0024390 |      40.089 |
+ | "average energy (track based)"                  |      2046 |   123647.9 |     60.434 |     226.37 |      0.0000 |      6121.2 |
 CaloSelectiveBremMatchAlg_Long_e...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       3498 |     17.490 |     16.155 |      0.0000 |      79.000 |
- | "average chi2"                                  |      3498 |   3260.686 |    0.93216 |     1.7941 |  1.8701e-06 |      36.441 |
- | "average energy (track based)"                  |      9534 |   166785.8 |     17.494 |     51.514 |      0.0000 |      1361.1 |
-CaloSelectiveBremMatchAlg_Upstre...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       3275 |     16.375 |     14.746 |      0.0000 |      67.000 |
+ | "average chi2"                                  |      3275 |   3414.509 |     1.0426 |     1.9275 |  2.4497e-06 |      38.309 |
+ | "average energy (track based)"                  |      9007 |   157223.5 |     17.456 |     52.160 |      0.0000 |      1346.8 |
+CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#above threshold"                              |         1 |          1 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#links in table"                               |       200 |       2047 |     10.235 |     8.0876 |      0.0000 |      40.000 |
+ | "average chi2"                                  |      2047 |   40360.57 |     19.717 |     62.134 |   0.0010254 |      2134.2 |
 CaloSelectiveElectronMatchAlg_Lo...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       8933 |     44.665 |     32.269 |      2.0000 |      177.00 |
- | "average chi2"                                  |      8933 |   43246.96 |     4.8413 |     11.434 |  0.00021628 |      410.27 |
-CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 1
+ | "#links in table"                               |       200 |       8269 |     41.345 |     29.188 |      2.0000 |      164.00 |
+ | "average chi2"                                  |      8269 |   41425.39 |     5.0097 |     12.016 |  0.00023863 |      407.46 |
+CaloSelectiveTrackMatchAlg_Downs...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ | "#links in table"                               |       200 |       2058 |     10.290 |     8.0800 |      0.0000 |      40.000 |
+ | "average chi2"                                  |      2058 |   1179.539 |    0.57315 |     1.0963 |  1.5283e-05 |      25.521 |
 CaloSelectiveTrackMatchAlg_Long_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       9037 |     45.185 |     32.401 |      2.0000 |      179.00 |
- | "average chi2"                                  |      9037 |   1336.726 |    0.14792 |    0.28394 |  7.1398e-06 |      8.8313 |
+ | "#links in table"                               |       200 |       8367 |     41.835 |     29.324 |      2.0000 |      166.00 |
+ | "average chi2"                                  |      8367 |   1328.535 |    0.15878 |    0.30283 |  6.9788e-06 |      8.8232 |
 CaloSelectiveTrackMatchAlg_Ttrac...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#links in table"                               |       200 |       6791 |     33.955 |     32.680 |      0.0000 |      295.00 |
- | "average chi2"                                  |      6791 |   430.2002 |   0.063349 |    0.12087 |  2.2326e-06 |      4.0922 |
+ | "#links in table"                               |       200 |       5497 |     27.485 |     29.468 |      0.0000 |      272.00 |
+ | "average chi2"                                  |      5497 |   435.1161 |   0.079155 |    0.14612 |  2.7076e-06 |      4.0922 |
+CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "average DLL"                                   |      2301 |  -339.4285 |   -0.14751 |    0.53834 |     -7.3593 |      3.5996 |
+ | "average E/p"                                   |      2301 |   96.09776 |   0.041763 |   0.066756 |      0.0000 |     0.95009 |
 CaloTrackBasedElectronShowerAlg_...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "average DLL"                                   |     10869 |  -626.2214 |  -0.057615 |    0.10558 |     -2.7206 |     0.58054 |
- | "average E/p"                                   |     10869 |   70.01579 |  0.0064418 |  0.0094182 |      0.0000 |     0.16162 |
+ | "average DLL"                                   |     10093 |  -626.7117 |  -0.062094 |    0.11129 |     -2.6872 |     0.61537 |
+ | "average E/p"                                   |     10093 |   69.93949 |  0.0069295 |   0.010203 |      0.0000 |     0.16357 |
+CaloTrackToHcalEnergyAlg_Downstr...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "energy (calo) associated to track"             |      2101 |1.07307e+07 |     5107.4 |     9952.1 |      0.0000 |  1.0735e+05 |
 CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "energy (calo) associated to track"             |     10199 |4.481356e+07 |     4393.9 |     8191.9 |      0.0000 |  1.2332e+05 |
+ | "energy (calo) associated to track"             |      9481 |3.754561e+07 |     3960.1 |     7363.9 |      0.0000 |  1.2332e+05 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12976 |      11246 |( 86.66769 +- 0.2984083)% |
- | "MC particles per ProtoParticle"                |     11246 |      13093 |     1.1642 |
+ |*"Efficiency"                                    |      2984 |       2503 |( 83.88070 +- 0.6731390)% |
+ | "MC particles per ProtoParticle"                |      2503 |       2503 |     1.0000 |
+ChargedProtoParticleAssociator_9...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     11847 |      10542 |( 88.98455 +- 0.2876432)% |
+ | "MC particles per ProtoParticle"                |     10542 |      12231 |     1.1602 |
+ChargedProtoParticleMaker_Downst...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "CreatedProtos"                                 |      2984 |
 ChargedProtoParticleMaker_Long_f...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "CreatedProtos"                                 |     12976 |
+ | "CreatedProtos"                                 |     11847 |
 ClassifyPhotonElectronAlg_8ec9e29e     INFO Number of counters : 14
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Electron Delta(E)"                             |     12355 |   -5167805 |    -418.28 |     555.35 |     -5757.1 |      2738.6 |
- | "Electron Delta(X)"                             |     12355 |  -5178.227 |   -0.41912 |     12.280 |     -91.805 |      29.057 |
- | "Electron Delta(Y)"                             |     12355 |  -3410.735 |   -0.27606 |     12.297 |     -72.810 |      22.670 |
- | "Electron Delta(Z)"                             |     12355 |   858964.2 |     69.524 |     13.329 |     -10.624 |      123.98 |
- | "Electron corrected energy"                     |     12355 |7.600475e+07 |     6151.7 |     7310.8 |      19.963 |  1.2205e+05 |
- | "Electrons pT-rejected after correction"        |       121 |
- | "Photon Delta(E)"                               |     23070 |   -5507958 |    -238.75 |     399.12 |     -4036.0 |      2229.9 |
- | "Photon Delta(X)"                               |     23070 |  -8771.599 |   -0.38022 |     12.698 |     -91.984 |      62.040 |
- | "Photon Delta(Y)"                               |     23070 |  -5194.705 |   -0.22517 |     12.658 |     -91.966 |      61.225 |
- | "Photon Delta(Z)"                               |     23070 |    1374583 |     59.583 |     13.024 |     -8.7578 |      123.98 |
- | "Photon corrected energy"                       |     23070 |7.952326e+07 |     3447.0 |     5799.8 |      22.782 |  1.2636e+05 |
- | "Photons pT-rejected after correction"          |       426 |
- | "electronHypos"                                 |       200 |      12234 |     61.170 |     36.979 |      4.0000 |      216.00 |
- | "photonHypos"                                   |       200 |      22644 |     113.22 |     49.386 |      10.000 |      235.00 |
+ | "Electron Delta(E)"                             |     12340 |   -5165670 |    -418.61 |     555.77 |     -5757.1 |      2738.6 |
+ | "Electron Delta(X)"                             |     12340 |  -5333.346 |   -0.43220 |     12.270 |     -91.805 |      29.057 |
+ | "Electron Delta(Y)"                             |     12340 |  -3349.581 |   -0.27144 |     12.292 |     -72.810 |      22.670 |
+ | "Electron Delta(Z)"                             |     12340 |   857942.7 |     69.525 |     13.322 |     -10.624 |      123.98 |
+ | "Electron corrected energy"                     |     12340 |7.594037e+07 |     6154.0 |     7313.2 |      19.963 |  1.2205e+05 |
+ | "Electrons pT-rejected after correction"        |       119 |
+ | "Photon Delta(E)"                               |     23211 |   -5560357 |    -239.56 |     399.65 |     -4036.0 |      2229.9 |
+ | "Photon Delta(X)"                               |     23211 |  -8553.458 |   -0.36851 |     12.688 |     -91.984 |      62.040 |
+ | "Photon Delta(Y)"                               |     23211 |  -5091.385 |   -0.21935 |     12.648 |     -91.966 |      61.225 |
+ | "Photon Delta(Z)"                               |     23211 |    1383802 |     59.618 |     13.027 |     -8.7578 |      123.98 |
+ | "Photon corrected energy"                       |     23211 |8.019459e+07 |     3455.0 |     5796.6 |      22.782 |  1.2636e+05 |
+ | "Photons pT-rejected after correction"          |       427 |
+ | "electronHypos"                                 |       200 |      12221 |     61.105 |     36.980 |      4.0000 |      218.00 |
+ | "photonHypos"                                   |       200 |      22784 |     113.92 |     49.940 |      10.000 |      237.00 |
 ClassifyPhotonElectronAlg_8ec9e2...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "<alpha> Inner"                                 |     10032 |   9976.227 |    0.99444 |   0.019645 |     0.96438 |      1.1318 |
- | "<alpha> Middle"                                |      9319 |   9376.979 |     1.0062 |   0.020773 |     0.97670 |      1.2128 |
- | "<alpha> Outer"                                 |     15985 |   15975.82 |    0.99943 |   0.016326 |     0.97368 |      1.1242 |
- | "Pileup offset"                                 |     35336 |1.315912e+07 |     372.40 |     442.32 |      2.6870 |      4736.9 |
- | "Pileup scale"                                  |     35425 |     202995 |     5.7303 |     2.0576 |      1.0000 |      12.000 |
- | "Pileup subtracted ratio"                       |     35336 |    31039.1 |    0.87840 |    0.12424 |  0.00047684 |     0.99914 |
- | "Skip negative energy correction"               |        89 |
-CloneKillerForward_4991e24b            INFO Number of counters : 2
+ | "<alpha> Inner"                                 |     10080 |   10023.86 |    0.99443 |   0.019621 |     0.96438 |      1.1318 |
+ | "<alpha> Middle"                                |      9362 |   9420.229 |     1.0062 |   0.020782 |     0.97670 |      1.2128 |
+ | "<alpha> Outer"                                 |     16019 |   16010.11 |    0.99944 |   0.016330 |     0.97368 |      1.1242 |
+ | "Pileup offset"                                 |     35461 |1.321874e+07 |     372.77 |     442.45 |      2.6870 |      4736.9 |
+ | "Pileup scale"                                  |     35551 |     203773 |     5.7319 |     2.0580 |      1.0000 |      12.000 |
+ | "Pileup subtracted ratio"                       |     35461 |   31149.57 |    0.87842 |    0.12413 |  0.00047684 |     0.99914 |
+ | "Skip negative energy correction"               |        90 |
+CloneKillerMatch_2d6666d0              INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "nTracksInput"                                  |       200 |      13632 |     68.160 |
- | "nTracksSelected"                               |       200 |       2616 |     13.080 |
+ | "nTracksInput"                                  |       200 |      13628 |     68.140 |
+ | "nTracksSelected"                               |       200 |       3801 |     19.005 |
 CopySignalMCParticles_daf3c6a8         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"copy signal"                                   |   1061346 |          0 |( 0.000000 +- 0.000000)% |
  |*"input container present"                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |       400 |     408453 |     1021.1 |     1472.0 |      2.0000 |      7462.0 |
+ | "# of cloned entries"                           |       400 |     412923 |     1032.3 |     1480.2 |      2.0000 |      7476.0 |
  |*"Input container absent"                        |       400 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |    190732 |     190732 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |    101983 |      90838 |( 89.07171 +- 0.09769721)% |
+ |*"MCParticles cloned"                            |    191888 |     191888 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |    104055 |      91370 |( 87.80933 +- 0.1014268)% |
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |       200 |
  | "Nb events removed"                             |        24 |
 FilteredPIDElectrons                   INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        180 |( 90.00000 +- 2.121320)% |
- |*"Cut selection efficiency"                      |     12976 |       1359 |( 10.47318 +- 0.2688100)% |
+ |*"#passed"                                       |       200 |        178 |( 89.00000 +- 2.212465)% |
+ |*"Cut selection efficiency"                      |     11847 |       1126 |( 9.504516 +- 0.2694476)% |
 FilteredPIDMuons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        193 |( 96.50000 +- 1.299519)% |
- |*"Cut selection efficiency"                      |     12976 |       2123 |( 16.36097 +- 0.3247421)% |
+ |*"#passed"                                       |       200 |        195 |( 97.50000 +- 1.103970)% |
+ |*"Cut selection efficiency"                      |     11847 |       1861 |( 15.70862 +- 0.3343154)% |
 FilteredPIDkaons                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     12976 |       7917 |( 61.01264 +- 0.4281554)% |
-FunctionalParticleMaker_149889e6       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"Cut selection efficiency"                      |     11847 |       7256 |( 61.24757 +- 0.4475996)% |
+FunctionalParticleMaker_149889e6       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        197 |( 98.50000 +- 0.8595057)% |
+ |*"# passed ProtoParticle filter"                 |      2984 |       2711 |( 90.85121 +- 0.5277738)% |
+ |*"# passed Track filter"                         |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1315 |     6.5750 |     5.0144 |      0.0000 |      25.000 |
+ | "Nb created particles"                          |       200 |       1396 |     6.9800 |     5.4074 |      0.0000 |      30.000 |
 FunctionalParticleMaker_2ff3f10f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12269 |( 94.55148 +- 0.1992522)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6118 |     30.590 |     19.778 |      1.0000 |      105.00 |
- | "Nb created particles"                          |       200 |       6151 |     30.755 |     20.757 |      1.0000 |      121.00 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11303 |( 95.40812 +- 0.1923020)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5658 |     28.290 |     17.835 |      1.0000 |      99.000 |
+ | "Nb created particles"                          |       200 |       5645 |     28.225 |     18.715 |      1.0000 |      110.00 |
 FunctionalParticleMaker_379cf33a       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6489 |     32.445 |     21.140 |      1.0000 |      112.00 |
- | "Nb created particles"                          |       200 |       6487 |     32.435 |     21.986 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5925 |     29.625 |     18.727 |      1.0000 |      104.00 |
+ | "Nb created particles"                          |       200 |       5922 |     29.610 |     19.567 |      1.0000 |      112.00 |
+FunctionalParticleMaker_442c3d96       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         5 |          5 |( 100.0000 +- 0.000000)% |
+ |*"# passed ProtoParticle filter"                 |       403 |        378 |( 93.79653 +- 1.201596)% |
+ |*"# passed Track filter"                         |       403 |        403 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |         5 |        192 |     38.400 |     18.018 |      8.0000 |      61.000 |
+ | "Nb created particles"                          |         5 |        186 |     37.200 |     18.745 |      8.0000 |      65.000 |
 FunctionalParticleMaker_950c4697       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12269 |( 94.55148 +- 0.1992522)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6118 |     30.590 |     19.778 |      1.0000 |      105.00 |
- | "Nb created particles"                          |       200 |       6151 |     30.755 |     20.757 |      1.0000 |      121.00 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11303 |( 95.40812 +- 0.1923020)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5658 |     28.290 |     17.835 |      1.0000 |      99.000 |
+ | "Nb created particles"                          |       200 |       5645 |     28.225 |     18.715 |      1.0000 |      110.00 |
 FunctionalParticleMaker_9614a368       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6489 |     32.445 |     21.140 |      1.0000 |      112.00 |
- | "Nb created particles"                          |       200 |       6487 |     32.435 |     21.986 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5925 |     29.625 |     18.727 |      1.0000 |      104.00 |
+ | "Nb created particles"                          |       200 |       5922 |     29.610 |     19.567 |      1.0000 |      112.00 |
 FunctionalParticleMaker_a90be71f       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6489 |     32.445 |     21.140 |      1.0000 |      112.00 |
- | "Nb created particles"                          |       200 |       6487 |     32.435 |     21.986 |      1.0000 |      126.00 |
-FunctionalParticleMaker_c5ad9787       INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
- | "Nb created particles"                          |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5925 |     29.625 |     18.727 |      1.0000 |      104.00 |
+ | "Nb created particles"                          |       200 |       5922 |     29.610 |     19.567 |      1.0000 |      112.00 |
+FunctionalParticleMaker_c5ad9787       INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |        197 |( 98.50000 +- 0.8595057)% |
+ |*"# passed ProtoParticle filter"                 |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |      2984 |       2984 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       1454 |     7.2700 |     5.5612 |      0.0000 |      29.000 |
+ | "Nb created particles"                          |       200 |       1530 |     7.6500 |     6.0164 |      0.0000 |      32.000 |
 FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- |*"# passed ProtoParticle filter"                 |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- |*"# passed Track filter"                         |     12976 |      12976 |( 100.0000 +- 0.000000)% |
- | "Nb created anti-particles"                     |       200 |       6489 |     32.445 |     21.140 |      1.0000 |      112.00 |
- | "Nb created particles"                          |       200 |       6487 |     32.435 |     21.986 |      1.0000 |      126.00 |
+ |*"# passed ProtoParticle filter"                 |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ |*"# passed Track filter"                         |     11847 |      11847 |( 100.0000 +- 0.000000)% |
+ | "Nb created anti-particles"                     |       200 |       5925 |     29.625 |     18.727 |      1.0000 |      104.00 |
+ | "Nb created particles"                          |       200 |       5922 |     29.610 |     19.567 |      1.0000 |      112.00 |
 FutureNeutralProtoPAlg_8a4fb7d2        INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Neutral Protos"                                |       200 |      24996 |     124.98 |     60.357 |      10.000 |      301.00 |
+ | "Neutral Protos"                                |       200 |      25136 |     125.68 |     60.924 |      10.000 |      303.00 |
  | "Neutral Protos from MergedPi0s"                |       200 |        784 |     3.9200 |     4.6102 |      0.0000 |      24.000 |
- | "Neutral Protos from Photons"                   |       200 |      22644 |     113.22 |     49.386 |      10.000 |      235.00 |
+ | "Neutral Protos from Photons"                   |       200 |      22784 |     113.92 |     49.940 |      10.000 |      237.00 |
  | "Neutral Protos from SplitPhotons"              |       200 |       1568 |     7.8400 |     9.2203 |      0.0000 |      48.000 |
 GraphClustering_72971694               INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
@@ -282,13 +305,13 @@ Hlt2Test_Bs0ToJpsiPhi_JPsiToMupM...    INFO Number of counters : 1
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         60 |( 30.00000 +- 3.240370)% |
- |*"# passed CombinationCut"                       |     68325 |        164 |(0.2400293 +- 0.01872063)% |
- |*"# passed CompositeCut"                         |       164 |        158 |( 96.34146 +- 1.466015)% |
- |*"# passed vertex fit"                           |       164 |        164 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       1359 |     6.7950 |
- | "candidate multiplicity"                        |       200 |        158 |    0.79000 |     1.7765 |      0.0000 |      14.000 |
+ |*"# passed"                                      |       200 |         43 |( 21.50000 +- 2.904953)% |
+ |*"# passed CombinationCut"                       |     50049 |         95 |(0.1898140 +- 0.01945601)% |
+ |*"# passed CompositeCut"                         |        95 |         88 |( 92.63158 +- 2.680433)% |
+ |*"# passed vertex fit"                           |        95 |         95 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11847 |     59.235 |
+ | "Input2 size"                                   |       200 |       1126 |     5.6300 |
+ | "candidate multiplicity"                        |       200 |         88 |    0.44000 |     1.0800 |      0.0000 |      6.0000 |
 Hlt2Test_BsToJpsiPhi_JPsi2ee_Phi...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       200 |        200 |( 100.0000 +- 0.000000)% |
@@ -322,67 +345,65 @@ Hlt2Test_sRTPhotons_Prescaler          INFO Number of counters : 1
 HltDecReportsFilter_895ecf8e           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_9a845e76         INFO Number of counters : 2
+HltPackedBufferWriter_baee4457         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |       200 |3.617018e+07 | 1.8085e+05 | 1.1451e+05 |      12764. |  6.4153e+05 |
+ | "Size of serialized data"                       |       200 |     482542 |     2412.7 |     3038.3 |      108.00 |      13284. |
 Hlt__RoutingBitsCombiner_6642b907      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |       200 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Events without Tracks"                   |         1 |          0 |     0.0000 |
- | "Nb of Produced Tracks"                         |       199 |      10374 |     52.131 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |       200 |      12976 |     64.880 |
+ | "Nb of Produced Tracks"                         |       199 |       8650 |     43.467 |
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
-LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
+ | "Nb of Produced Tracks"                         |       200 |      11847 |     59.235 |
+LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Events without Tracks"                   |       200 |          0 |     0.0000 |
+ | "Nb of Events without Tracks"                   |         3 |          0 |     0.0000 |
+ | "Nb of Produced Tracks"                         |       197 |       2984 |     15.147 |
 LHCb__Phys__ParticleMakers__Phot...    INFO Number of counters : 4
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |        200 |( 100.0000 +- 0.000000)% |
- | "Confidence Level"                              |     14680 |   5006.871 |    0.34107 |    0.33095 |  7.0212e-05 |     0.99473 |
- | "Created photons"                               |     22644 |
- | "Selected photons"                              |       200 |      14680 |     73.400 |     38.462 |      4.0000 |      185.00 |
-LHCb__SelectivePacker_bce9f7c6         INFO Number of counters : 75
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BremInfos # containers packed"                 |       200 |        200 |     1.0000 |
- | "BremInfos # of packed entries"                 |       200 |       9534 |     47.670 |
- | "BremInfos buffer size"                         |       200 |     404828 |     2024.1 |
+ | "Confidence Level"                              |     14798 |   5027.215 |    0.33972 |    0.33078 |  7.0212e-05 |     0.99473 |
+ | "Created photons"                               |     22784 |
+ | "Selected photons"                              |       200 |      14798 |     73.990 |     38.982 |      4.0000 |      186.00 |
+LHCb__SelectivePacker_68fc5b26         INFO Number of counters : 75
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BremInfos # containers packed"                 |       200 |          5 |   0.025000 |
+ | "BremInfos # of packed entries"                 |         5 |         20 |     4.0000 |
+ | "BremInfos buffer size"                         |         5 |        950 |     190.00 |
  | "BremInfosSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "CaloAdcs # containers packed"                  |       200 |          0 |     0.0000 |
- | "CaloChargedPIDs # containers packed"           |       200 |        200 |     1.0000 |
- | "CaloChargedPIDs # of packed entries"           |       200 |      10963 |     54.815 |
- | "CaloChargedPIDs buffer size"                   |       200 |     662180 |     3310.9 |
+ | "CaloChargedPIDs # containers packed"           |       200 |          5 |   0.025000 |
+ | "CaloChargedPIDs # of packed entries"           |         5 |         19 |     3.8000 |
+ | "CaloChargedPIDs buffer size"                   |         5 |       1250 |     250.00 |
  | "CaloChargedPIDsSelection # containers packed"  |       200 |          0 |     0.0000 |
  | "CaloClusters # containers packed"              |       200 |          0 |     0.0000 |
  | "CaloClustersSelection # containers packed"     |       200 |          0 |     0.0000 |
  | "CaloDigits # containers packed"                |       200 |          0 |     0.0000 |
- | "CaloHypos # containers packed"                 |       200 |        800 |     4.0000 |
- | "CaloHypos # of packed entries"                 |       800 |      37230 |     46.538 |
- | "CaloHypos buffer size"                         |       800 |    2863476 |     3579.3 |
+ | "CaloHypos # containers packed"                 |       200 |        108 |    0.54000 |
+ | "CaloHypos # of packed entries"                 |       108 |        372 |     3.4444 |
+ | "CaloHypos buffer size"                         |       108 |      31080 |     287.78 |
  | "CaloHyposSelection # containers packed"        |       200 |          0 |     0.0000 |
  | "ExtendedPVs # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTags # containers packed"               |       200 |          0 |     0.0000 |
  | "FlavourTagsSelection # containers packed"      |       200 |          0 |     0.0000 |
- | "GlobalChargedPIDs # containers packed"         |       200 |        200 |     1.0000 |
- | "GlobalChargedPIDs # of packed entries"         |       200 |      12976 |     64.880 |
- | "GlobalChargedPIDs buffer size"                 |       200 |     731056 |     3655.3 |
+ | "GlobalChargedPIDs # containers packed"         |       200 |          5 |   0.025000 |
+ | "GlobalChargedPIDs # of packed entries"         |         5 |         23 |     4.6000 |
+ | "GlobalChargedPIDs buffer size"                 |         5 |       1398 |     279.60 |
  | "GlobalChargedPIDsSelection # containers packed"|       200 |          0 |     0.0000 |
- | "LightPVs # containers packed"                  |       200 |         12 |   0.060000 |
- | "LightPVs # of packed entries"                  |        12 |         16 |     1.3333 |
- | "LightPVs buffer size"                          |        12 |       1000 |     83.333 |
+ | "LightPVs # containers packed"                  |       200 |          8 |   0.040000 |
+ | "LightPVs # of packed entries"                  |         8 |         10 |     1.2500 |
+ | "LightPVs buffer size"                          |         8 |        636 |     79.500 |
  | "LightPVsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "MuonPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "MuonPIDs # of packed entries"                  |       200 |      12976 |     64.880 |
- | "MuonPIDs buffer size"                          |       200 |     784432 |     3922.2 |
+ | "MuonPIDs # containers packed"                  |       200 |          5 |   0.025000 |
+ | "MuonPIDs # of packed entries"                  |         5 |         23 |     4.6000 |
+ | "MuonPIDs buffer size"                          |         5 |       1518 |     303.60 |
  | "MuonPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "NeutralPIDs # containers packed"               |       200 |        200 |     1.0000 |
- | "NeutralPIDs # of packed entries"               |       200 |      24996 |     124.98 |
- | "NeutralPIDs buffer size"                       |       200 |    1504160 |     7520.8 |
+ | "NeutralPIDs # containers packed"               |       200 |        103 |    0.51500 |
+ | "NeutralPIDs # of packed entries"               |       103 |        350 |     3.3981 |
+ | "NeutralPIDs buffer size"                       |       103 |      23266 |     225.88 |
  | "NeutralPIDsSelection # containers packed"      |       200 |          0 |     0.0000 |
  | "P2InfoRelations # containers packed"           |       200 |          0 |     0.0000 |
  | "P2IntRelations # containers packed"            |       200 |          0 |     0.0000 |
@@ -390,121 +411,151 @@ LHCb__SelectivePacker_bce9f7c6         INFO Number of counters : 75
  | "P2PVRelations # containers packed"             |       200 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |       200 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |       200 |        400 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |       400 |     408453 |     1021.1 |
- | "PP2MCPRelations buffer size"                   |       400 |    8193860 |     20485. |
- | "PVs # containers packed"                       |       200 |        200 |     1.0000 |
- | "PVs # of packed entries"                       |       200 |        997 |     4.9850 |
- | "PVs buffer size"                               |       200 |     395786 |     1978.9 |
+ | "PP2MCPRelations # of packed entries"           |       400 |       8661 |     21.652 |
+ | "PP2MCPRelations buffer size"                   |       400 |     195684 |     489.21 |
+ | "PVs # containers packed"                       |       200 |        103 |    0.51500 |
+ | "PVs # of packed entries"                       |       103 |        598 |     5.8058 |
+ | "PVs buffer size"                               |       103 |      38186 |     370.74 |
  | "PVsSelection # containers packed"              |       200 |          0 |     0.0000 |
- | "Particles # containers packed"                 |       200 |        247 |     1.2350 |
- | "Particles # of packed entries"                 |       247 |        603 |     2.4413 |
- | "Particles buffer size"                         |       247 |     126208 |     510.96 |
- | "ParticlesSelection # containers packed"        |       200 |        249 |     1.2450 |
- | "ParticlesSelection # of packed entries"        |       249 |        358 |     1.4378 |
- | "ParticlesSelection buffer size"                |       249 |      10085 |     40.502 |
- | "ProtoParticles # containers packed"            |       200 |        800 |     4.0000 |
- | "ProtoParticles # of packed entries"            |       800 |      37972 |     47.465 |
- | "ProtoParticles buffer size"                    |       800 |    3059112 |     3823.9 |
+ | "Particles # containers packed"                 |       200 |        220 |     1.1000 |
+ | "Particles # of packed entries"                 |       220 |        540 |     2.4545 |
+ | "Particles buffer size"                         |       220 |     112628 |     511.95 |
+ | "ParticlesSelection # containers packed"        |       200 |        240 |     1.2000 |
+ | "ParticlesSelection # of packed entries"        |       240 |        341 |     1.4208 |
+ | "ParticlesSelection buffer size"                |       240 |       9688 |     40.367 |
+ | "ProtoParticles # containers packed"            |       200 |        108 |    0.54000 |
+ | "ProtoParticles # of packed entries"            |       108 |        373 |     3.4537 |
+ | "ProtoParticles buffer size"                    |       108 |      34052 |     315.30 |
  | "ProtoParticlesSelection # containers packed"   |       200 |          0 |     0.0000 |
- | "RecSummary # containers packed"                |       200 |        200 |     1.0000 |
- | "RecSummary # of packed entries"                |       200 |       7600 |     38.000 |
- | "RecSummary buffer size"                        |       200 |      34800 |     174.00 |
- | "RichPIDs # containers packed"                  |       200 |        200 |     1.0000 |
- | "RichPIDs # of packed entries"                  |       200 |      12269 |     61.345 |
- | "RichPIDs buffer size"                          |       200 |     594112 |     2970.6 |
+ | "RecSummary # containers packed"                |       200 |        103 |    0.51500 |
+ | "RecSummary # of packed entries"                |       103 |       3914 |     38.000 |
+ | "RecSummary buffer size"                        |       103 |      17922 |     174.00 |
+ | "RichPIDs # containers packed"                  |       200 |          5 |   0.025000 |
+ | "RichPIDs # of packed entries"                  |         5 |         23 |     4.6000 |
+ | "RichPIDs buffer size"                          |         5 |       1234 |     246.80 |
  | "RichPIDsSelection # containers packed"         |       200 |          0 |     0.0000 |
- | "Tracks # containers packed"                    |       200 |       1168 |     5.8400 |
- | "Tracks # of packed entries"                    |      1168 |      70960 |     60.753 |
- | "Tracks buffer size"                            |      1168 |1.679985e+07 |     14383. |
+ | "Tracks # containers packed"                    |       200 |          7 |   0.035000 |
+ | "Tracks # of packed entries"                    |         7 |         26 |     3.7143 |
+ | "Tracks buffer size"                            |         7 |      10822 |     1546.0 |
  | "TracksSelection # containers packed"           |       200 |          0 |     0.0000 |
  | "TwoProngVertices # containers packed"          |       200 |          0 |     0.0000 |
  | "TwoProngVerticesSelection # containers packed" |       200 |          0 |     0.0000 |
- | "Vertices # containers packed"                  |       200 |         31 |    0.15500 |
- | "Vertices # of packed entries"                  |        31 |         49 |     1.5806 |
- | "Vertices buffer size"                          |        31 |       5240 |     169.03 |
+ | "Vertices # containers packed"                  |       200 |         17 |   0.085000 |
+ | "Vertices # of packed entries"                  |        17 |         19 |     1.1176 |
+ | "Vertices buffer size"                          |        17 |       2228 |     131.06 |
  | "VerticesSelection # containers packed"         |       200 |          0 |     0.0000 |
  | "WeightsVectors # containers packed"            |       200 |          0 |     0.0000 |
+MuonIDHlt2AlgDownstream_81ff20a8       INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "BgLL"                                          |       226 |  -118.6299 |   -0.52491 |     1.0766 |     -6.6799 |      0.0000 |
+ | "MuLL"                                          |       226 |   -2141.29 |    -9.4747 |     3.2315 |     -11.513 |   -0.081445 |
+ | "muonMVAStat"                                   |       226 |  -121.5595 |   -0.53787 |    0.98314 |     -2.9175 |      4.0010 |
+ |*"nInAcceptance"                                 |      2984 |       2154 |( 72.18499 +- 0.8202829)% |
+ |*"nIsMuon"                                       |      2984 |        226 |( 7.573727 +- 0.4843431)% |
+ |*"nIsMuonTight"                                  |      2984 |         96 |( 3.217158 +- 0.3230249)% |
+ |*"nMomentumCut"                                  |      2984 |       2323 |( 77.84853 +- 0.7601987)% |
 MuonIDHlt2AlgLong_ebde3a89             INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "BgLL"                                          |      1135 |   -489.732 |   -0.43148 |    0.78257 |     -6.0884 |      0.0000 |
- | "MuLL"                                          |      1135 |  -10773.37 |    -9.4920 |     2.8996 |     -11.513 |    -0.13418 |
- | "muonMVAStat"                                   |      1135 |  -718.9394 |   -0.63343 |    0.81479 |     -3.0272 |      4.1483 |
- |*"nInAcceptance"                                 |     12976 |      10217 |( 78.73767 +- 0.3591917)% |
- |*"nIsMuon"                                       |     12976 |       1135 |( 8.746917 +- 0.2480167)% |
- |*"nIsMuonTight"                                  |     12976 |        490 |( 3.776202 +- 0.1673395)% |
- |*"nMomentumCut"                                  |     12976 |      10946 |( 84.35573 +- 0.3189073)% |
+ | "BgLL"                                          |      1066 |  -456.3371 |   -0.42808 |    0.77511 |     -6.1719 |      0.0000 |
+ | "MuLL"                                          |      1066 |  -10126.95 |    -9.4999 |     2.9025 |     -11.513 |    -0.12512 |
+ | "muonMVAStat"                                   |      1066 |  -683.6448 |   -0.64132 |    0.79149 |     -3.0272 |      4.2048 |
+ |*"nInAcceptance"                                 |     11847 |       9362 |( 79.02423 +- 0.3740545)% |
+ |*"nIsMuon"                                       |     11847 |       1066 |( 8.998059 +- 0.2629030)% |
+ |*"nIsMuonTight"                                  |     11847 |        459 |( 3.874399 +- 0.1773036)% |
+ |*"nMomentumCut"                                  |     11847 |      10043 |( 84.77252 +- 0.3300938)% |
+MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of input v2 MuonPIDs"                       |       200 |       2984 |     14.920 |
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of input v2 MuonPIDs"                       |       200 |      12976 |     64.880 |
+ | "Nb of input v2 MuonPIDs"                       |       200 |      11847 |     59.235 |
 NeutralProtoParticleAssociator_a...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     24996 |      23320 |( 93.29493 +- 0.1581960)% |
- | "MC particles per ProtoParticle"                |     23320 |     395360 |     16.954 |
+ |*"Efficiency"                                    |     25136 |      23460 |( 93.33227 +- 0.1573464)% |
+ | "MC particles per ProtoParticle"                |     23460 |     398189 |     16.973 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |       200 |     190732 |     953.66 |     601.13 |      65.000 |      2974.0 |
+ | "#MCParticles"                                  |       200 |     191888 |     959.44 |     602.61 |      65.000 |      2925.0 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |       200 |      90838 |     454.19 |     293.04 |      26.000 |      1440.0 |
+ | "#MCVertices"                                   |       200 |      91370 |     456.85 |     294.00 |      26.000 |      1437.0 |
 ParticleRangeFilter_22f84c5e           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |        175 |( 87.50000 +- 2.338536)% |
- |*"Cut selection efficiency"                      |     12976 |       1047 |( 8.068742 +- 0.2390915)% |
+ |*"#passed"                                       |       200 |        178 |( 89.00000 +- 2.212465)% |
+ |*"Cut selection efficiency"                      |     11847 |        991 |( 8.364987 +- 0.2543661)% |
 ParticleRangeFilter_2cf9c882           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         40 |( 20.00000 +- 2.828427)% |
- |*"Cut selection efficiency"                      |     14680 |         46 |(0.3133515 +- 0.04612872)% |
+ |*"Cut selection efficiency"                      |     14798 |         46 |(0.3108528 +- 0.04576146)% |
 ParticleRangeFilter_2d1c6dde           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         42 |( 21.00000 +- 2.880104)% |
- |*"Cut selection efficiency"                      |     14680 |         48 |(0.3269755 +- 0.04711762)% |
+ |*"Cut selection efficiency"                      |     14798 |         48 |(0.3243682 +- 0.04674252)% |
 ParticleRangeFilter_2dd22701           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |         68 |( 34.00000 +- 3.349627)% |
- |*"Cut selection efficiency"                      |     12269 |         99 |(0.8069117 +- 0.08076982)% |
+ |*"#passed"                                       |       200 |         65 |( 32.50000 +- 3.311910)% |
+ |*"Cut selection efficiency"                      |     11303 |         93 |(0.8227904 +- 0.08496767)% |
+ParticleRangeFilter_32aaad9e           INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         5 |          4 |( 80.00000 +- 17.88854)% |
+ |*"Cut selection efficiency"                      |       378 |         15 |( 3.968254 +- 1.004064)% |
 ParticleRangeFilter_497ef01a           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        101 |( 50.50000 +- 3.535357)% |
- |*"Cut selection efficiency"                      |     12269 |        199 |( 1.621974 +- 0.1140424)% |
+ |*"Cut selection efficiency"                      |     11303 |        192 |( 1.698664 +- 0.1215449)% |
 ParticleRangeFilter_7c68ac05           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |        199 |( 99.50000 +- 0.4987484)% |
- |*"Cut selection efficiency"                      |     14680 |       3660 |( 24.93188 +- 0.3570609)% |
+ |*"Cut selection efficiency"                      |     14798 |       3681 |( 24.87498 +- 0.3553630)% |
 ParticleRangeFilter_8ad15fd6           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         9 |          9 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |       784 |        118 |( 15.05102 +- 1.277039)% |
-ParticleRangeFilter_9dfc592f           INFO Number of counters : 1
+ |*"#passed"                                       |         6 |          6 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |       524 |         79 |( 15.07634 +- 1.563135)% |
+ParticleRangeFilter_9dfc592f           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        125 |( 62.50000 +- 3.423266)% |
+ |*"Cut selection efficiency"                      |      2711 |        236 |( 8.705275 +- 0.5414387)% |
 ParticleRangeFilter_a654d6c9           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |         63 |( 31.50000 +- 3.284623)% |
- |*"Cut selection efficiency"                      |     14680 |         92 |(0.6267030 +- 0.06513324)% |
-ParticleRangeFilter_f1423675           INFO Number of counters : 1
+ |*"Cut selection efficiency"                      |     14798 |         92 |(0.6217056 +- 0.06461549)% |
+ParticleRangeFilter_f1423675           INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
+ |*"#passed"                                       |       200 |        196 |( 98.00000 +- 0.9899495)% |
+ |*"Cut selection efficiency"                      |      2984 |       2225 |( 74.56434 +- 0.7972374)% |
 ParticleRangeFilter_f36346d4           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |       200 |          0 |( 0.000000 +- 0.000000)% |
 ParticleUnbiasedPVAdder_198323e6       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         8 |
+ | "PV unbiasing successful"                       |         5 |
 ParticleUnbiasedPVAdder_49026aff       INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "PV unbiasing successful"                       |         8 |
+ | "PV unbiasing successful"                       |         5 |
 ParticleWithBremMaker_49ed8ce1         INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of particles corrected with brem (including those without change)"|     12976 |
+ | "Nb of particles corrected with brem (including those without change)"|     11847 |
 ParticleWithBremMaker_49ed8ce1.S...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Delta(E)"                                      |       933 |    4123930 |     4420.1 |     7012.4 |      4.1164 |  1.0097e+05 |
- | "Nb photons added to single electrons"          |     12976 |        933 |   0.071902 |    0.25833 |      0.0000 |      1.0000 |
-PrCloneKillerSeed_c6b4ed23             INFO Number of counters : 2
+ | "Delta(E)"                                      |       847 |    3635096 |     4291.7 |     6915.7 |      4.1117 |  1.0097e+05 |
+ | "Nb photons added to single electrons"          |     11847 |        847 |   0.071495 |    0.25765 |      0.0000 |      1.0000 |
+PrCloneKillerDown_a5a3e1f1             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      13761 |     68.805 |
+ | "nTracksSelected"                               |       200 |       4198 |     20.990 |
+PrCloneKillerSeedDown_72eca869         INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       200 |      11529 |     57.645 |
+ | "nTracksSelected"                               |       200 |       8650 |     43.250 |
+PrCloneKillerSeed_ab132ee2             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       200 |      22369 |     111.84 |
- | "nTracksSelected"                               |       200 |      10374 |     51.870 |
-PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
+ | "nTracksSelected"                               |       200 |      11529 |     57.645 |
+PrCloneKillerUp_ac3bf235               INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "nTracksInput"                                  |       103 |       4844 |     47.029 |
+ | "nTracksSelected"                               |       103 |       1664 |     16.155 |
+PrForwardTrackingVelo_a7f67b46         INFO Number of counters : 10
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Accepted input tracks"                         |       200 |      27615 |     138.07 |
  | "Created long tracks"                           |       200 |      13632 |     68.160 |
@@ -516,6 +567,10 @@ PrForwardTrackingVelo_6f363eca         INFO Number of counters : 10
  | "Number of x candidates per track 2nd Loop"     |     12535 |      78472 |     6.2602 |     11.010 |
  | "Percentage second loop execution"              |     23827 |      12535 |    0.52608 |
  | "Removed duplicates"                            |       200 |        776 |     3.8800 |
+PrForwardTrackingVelo_a7f67b46.P...    INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11730 |      47026 |     4.0090 |
+ | "#tracks with hits added"                       |     11730 |
 PrHybridSeeding_97242385               INFO Number of counters : 21
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Created T2x1 three-hit combinations in case 0" |    451881 |     283734 |    0.62790 |    0.63420 |      0.0000 |      6.0000 |
@@ -539,30 +594,60 @@ PrHybridSeeding_97242385               INFO Number of counters : 21
  | "Created two-hit combinations in case 0"        |     64817 |    1590410 |     24.537 |     18.401 |      0.0000 |      119.00 |
  | "Created two-hit combinations in case 1"        |     58134 |    2008013 |     34.541 |     22.781 |      0.0000 |      182.00 |
  | "Created two-hit combinations in case 2"        |     49019 |    2612869 |     53.303 |     35.316 |      1.0000 |      252.00 |
-PrKalmanFilterForward_630360b9         INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       334 |
- | "chi2 cut"                                      |       772 |
- | "nIterations"                                   |      2616 |       7099 |     2.7137 |
- | "nOutlierIterations"                            |      2282 |       2409 |     1.0557 |
- | "nTracksInput"                                  |       200 |       2616 |     13.080 |
- | "nTracksOutput"                                 |       200 |       1510 |     7.5500 |
-PrKalmanFilterMatch_5b2d4ece           INFO Number of counters : 6
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Pre outlier chi2 cut"                          |       278 |
- | "chi2 cut"                                      |       948 |
- | "nIterations"                                   |     13628 |      29578 |     2.1704 |
- | "nOutlierIterations"                            |     13350 |       7068 |    0.52944 |
- | "nTracksInput"                                  |       200 |      13628 |     68.140 |
- | "nTracksOutput"                                 |       200 |      12402 |     62.010 |
-PrLHCbID2MCParticleVPFTMU_7d3ccc1b     INFO Number of counters : 1
+PrKalmanFilterForward_2db16361         INFO Number of counters : 6
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#removed null MCParticles"                     |   1283247 |       2153 |  0.0016778 |
-PrMatchNN_946089ac                     INFO Number of counters : 3
+ | "Pre outlier chi2 cut"                          |       434 |
+ | "chi2 cut"                                      |      2234 |
+ | "nIterations"                                   |     13632 |      31566 |     2.3156 |
+ | "nOutlierIterations"                            |     13198 |      10672 |    0.80861 |
+ | "nTracksInput"                                  |       200 |      13632 |     68.160 |
+ | "nTracksOutput"                                 |       200 |      10964 |     54.820 |
+PrKalmanFilterMatch_6c041d56           INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       335 |
+ | "chi2 cut"                                      |      2126 |
+ | "nIterations"                                   |      3801 |       9329 |     2.4544 |
+ | "nOutlierIterations"                            |      3466 |       4119 |     1.1884 |
+ | "nTracksInput"                                  |       200 |       3801 |     19.005 |
+ | "nTracksOutput"                                 |       200 |       1340 |     6.7000 |
+PrKalmanFilter_Downstream_8fd8655a     INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       551 |
+ | "chi2 cut"                                      |       663 |
+ | "nIterations"                                   |      4198 |      10419 |     2.4819 |
+ | "nOutlierIterations"                            |      3647 |       2171 |    0.59528 |
+ | "nTracksInput"                                  |       200 |       4198 |     20.990 |
+ | "nTracksOutput"                                 |       200 |       2984 |     14.920 |
+PrKalmanFilter_Upstream_202d0d3b       INFO Number of counters : 6
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Pre outlier chi2 cut"                          |       103 |
+ | "chi2 cut"                                      |       606 |
+ | "nIterations"                                   |      1664 |       3374 |     2.0276 |
+ | "nOutlierIterations"                            |      1561 |       1189 |    0.76169 |
+ | "nTracksInput"                                  |       103 |       1664 |     16.155 |
+ | "nTracksOutput"                                 |       103 |        955 |     9.2718 |
+PrLHCbID2MCParticleVPUTFTMU_dc79...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#removed null MCParticles"                     |   1491997 |       2153 |  0.0014430 |
+PrLongLivedTracking_83484006           INFO Number of counters : 8
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Downstream tracks made"                       |       200 |      13761 |     68.805 |
+ | "#Good XUVcand"                                 |     20446 |     100707 |     4.9255 |
+ | "#Good Xcand"                                   |     20446 |     309575 |     15.141 |
+ | "#Presel hits0"                                 |     20446 |     266217 |     13.020 |
+ | "#Presel hits1"                                 |     20446 |     266750 |     13.047 |
+ | "#Presel hits2"                                 |     20446 |     257397 |     12.589 |
+ | "#Presel hits3"                                 |     20446 |     264191 |     12.921 |
+ | "#Seeds"                                        |       200 |      22369 |     111.84 |
+PrMatchNN_915466c5                     INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#MatchingChi2"                                 |       200 |     231599 |     1158.0 |
  | "#MatchingMLP"                                  |     13628 |   11369.91 |    0.83430 |
  | "#MatchingTracks"                               |       200 |      13628 |     68.140 |
+PrMatchNN_915466c5.PrAddUTHitsTool     INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#UT hits added"                                |     11661 |      46784 |     4.0120 |
+ | "#tracks with hits added"                       |     11661 |
 PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Average X in T1U"                              |     65585 |    1832058 |     27.934 |     1214.1 |     -2656.0 |      2656.4 |
@@ -590,13 +675,26 @@ PrStoreSciFiHits_fb0eba02              INFO Number of counters : 25
  | "Hits in T3X1"                                  |       800 |      68009 |     85.011 |     36.453 |      23.000 |      264.00 |
  | "Hits in T3X2"                                  |       800 |      74560 |     93.200 |     39.732 |      22.000 |      249.00 |
  | "Total number of hits"                          |       200 |     807039 |     4035.2 |     1656.6 |      1290.0 |      9859.0 |
-PrTrackAssociator_fa20e82b             INFO Number of counters : 2
+PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |     12976 |      11246 |( 86.66769 +- 0.2984083)% |
- | "MC particles per track"                        |     11246 |      13093 |     1.1642 |
+ | "# RawBank::UT banks"                           |       200 |      43200 |     216.00 |
+ | "# RawBank::UTError banks"                      |       200 |          0 |     0.0000 |
+ |*"Non-unique UT clusters in event"               |       200 |          0 |( 0.000000 +- 0.000000)% |
+PrTrackAssociator_1cbc46b9             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |     11847 |      10542 |( 88.98455 +- 0.2876432)% |
+ | "MC particles per track"                        |     10542 |      12231 |     1.1602 |
+PrTrackAssociator_49a0075c             INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"Efficiency"                                    |      2984 |       2503 |( 83.88070 +- 0.6731390)% |
+ | "MC particles per track"                        |      2503 |       2503 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
+PrVeloUT_daa62e37                      INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#seeds"                                        |       103 |      19321 |     187.58 |
+ | "#tracks"                                       |       103 |       4844 |     47.029 |
 SelectHlt1HltDecReports                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Number of selected banks"                      |       200 |          0 |( 0.000000 +- 0.000000)% |
@@ -609,107 +707,134 @@ SelectHlt1HltSelReports                INFO Number of counters : 1
 SelectiveCombineRawBanks_for_def...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Empty RawBank::View"                           |      1600 |          0 |     0.0000 |     0.0000 | 1.7977e+308 |-1.7977e+308 |
-TBTCForward_ccc11d9d                   INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |      1437 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |      1437 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |      1437 |
-TBTC_Match_20eca874                    INFO Number of counters : 3
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"BadInput"                                      |     11539 |          0 |( 0.000000 +- 0.000000)% |
- |*"FitFailed"                                     |     11539 |          0 |( 0.000000 +- 0.000000)% |
- | "FittedBefore"                                  |     11539 |
+TBTCMatch_c12345b8                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      1275 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      1275 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      1275 |
+TBTC_Forward_4b913e5a                  INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |     10572 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |     10572 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |     10572 |
+TBTC_down_6d7029eb                     INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |      2984 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |      2984 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |      2984 |
+TBTC_up_36fd2653                       INFO Number of counters : 3
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"BadInput"                                      |       954 |          0 |( 0.000000 +- 0.000000)% |
+ |*"FitFailed"                                     |       954 |          0 |( 0.000000 +- 0.000000)% |
+ | "FittedBefore"                                  |       954 |
 Test_BdsToPhiPhiCombiner               INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       107 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |       705 |         22 |( 3.120567 +- 0.6548442)% |
- |*"# passed CompositeCut"                         |        22 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed vertex fit"                           |        22 |         22 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       107 |        322 |     3.0093 |
- | "Input2 size"                                   |       107 |        322 |     3.0093 |
- | "candidate multiplicity"                        |       107 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-Test_Bs2JPsiPhiCombiner_67dc4ee3       INFO Number of counters : 8
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        60 |          5 |( 8.333333 +- 3.568120)% |
- |*"# passed CombinationCut"                       |       696 |        125 |( 17.95977 +- 1.454987)% |
- |*"# passed CompositeCut"                         |       125 |         11 |( 8.800000 +- 2.533867)% |
- |*"# passed vertex fit"                           |       125 |        125 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        60 |        158 |     2.6333 |
- | "Input2 size"                                   |        60 |        176 |     2.9333 |
- | "Lifetime fit did not converge. Aborting."      |         1 |
- | "candidate multiplicity"                        |        60 |         11 |    0.18333 |    0.74143 |      0.0000 |      4.0000 |
+ |*"# passed"                                      |        99 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |       606 |         15 |( 2.475248 +- 0.6311469)% |
+ |*"# passed CompositeCut"                         |        15 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |        15 |         15 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        99 |        280 |     2.8283 |
+ | "Input2 size"                                   |        99 |        280 |     2.8283 |
+ | "candidate multiplicity"                        |        99 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+Test_Bs2JPsiPhiCombiner_67dc4ee3       INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |        43 |          2 |( 4.651163 +- 3.211473)% |
+ |*"# passed CombinationCut"                       |       391 |         55 |( 14.06650 +- 1.758271)% |
+ |*"# passed CompositeCut"                         |        55 |          2 |( 3.636364 +- 2.524114)% |
+ |*"# passed vertex fit"                           |        55 |         55 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        43 |         88 |     2.0465 |
+ | "Input2 size"                                   |        43 |        123 |     2.8605 |
+ | "candidate multiplicity"                        |        43 |          2 |   0.046512 |    0.21059 |      0.0000 |      1.0000 |
 Test_Bs2JPsiPhiCombiner_d1451b3c       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |        83 |          6 |( 7.228916 +- 2.842522)% |
- |*"# passed CombinationCut"                       |       769 |        126 |( 16.38492 +- 1.334754)% |
- |*"# passed CompositeCut"                         |       126 |          8 |( 6.349206 +- 2.172352)% |
- |*"# passed vertex fit"                           |       126 |        126 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |        83 |        210 |     2.5301 |
- | "Input2 size"                                   |        83 |        224 |     2.6988 |
- | "candidate multiplicity"                        |        83 |          8 |   0.096386 |    0.36782 |      0.0000 |      2.0000 |
-Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 5
+ |*"# passed"                                      |        68 |          4 |( 5.882353 +- 2.853360)% |
+ |*"# passed CombinationCut"                       |       569 |         98 |( 17.22320 +- 1.582906)% |
+ |*"# passed CompositeCut"                         |        98 |          5 |( 5.102041 +- 2.222733)% |
+ |*"# passed vertex fit"                           |        98 |         98 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |        68 |        156 |     2.2941 |
+ | "Input2 size"                                   |        68 |        175 |     2.5735 |
+ | "candidate multiplicity"                        |        68 |          5 |   0.073529 |    0.31231 |      0.0000 |      2.0000 |
+Test_D0ToKpKm_Builder_e1dcbc5c         INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        42 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |         99 |    0.49500 |
- | "Input2 size"                                   |       200 |         99 |    0.49500 |
+ |*"# passed CombinationCut"                       |        46 |          2 |( 4.347826 +- 3.006800)% |
+ |*"# passed CompositeCut"                         |         2 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |         2 |          2 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |         93 |    0.46500 |
+ | "Input2 size"                                   |       200 |         93 |    0.46500 |
  | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_Hyperons_LambdaFromHyperon_LL     INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          9 |( 4.500000 +- 1.465862)% |
- |*"# passed CombinationCut"                       |       879 |         19 |( 2.161547 +- 0.4905042)% |
- |*"# passed CompositeCut"                         |        19 |         11 |( 57.89474 +- 11.32690)% |
- |*"# passed vertex fit"                           |        19 |         19 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |        199 |    0.99500 |
- | "Input2 size"                                   |       200 |       1047 |     5.2350 |
- | "candidate multiplicity"                        |       200 |         11 |   0.055000 |    0.28631 |      0.0000 |      3.0000 |
-Test_Hyperons_Lambda_DD                INFO Number of counters : 4
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |          0 |( 0.000000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |          0 |     0.0000 |
- | "Input2 size"                                   |       200 |          0 |     0.0000 |
- | "candidate multiplicity"                        |       200 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
-Test_Hyperons_Xim_LLL                  INFO Number of counters : 7
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |         9 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed CombinationCut"                       |        71 |          2 |( 2.816901 +- 1.963595)% |
- |*"# passed CompositeCut"                         |         2 |          0 |( 0.000000 +- 0.000000)% |
- |*"# passed vertex fit"                           |         2 |          2 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |         9 |         11 |     1.2222 |
- | "Input2 size"                                   |         9 |        118 |     13.111 |
- | "candidate multiplicity"                        |         9 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+ |*"# passed"                                      |       200 |          6 |( 3.000000 +- 1.206234)% |
+ |*"# passed CombinationCut"                       |       773 |         13 |( 1.681759 +- 0.4624973)% |
+ |*"# passed CompositeCut"                         |        13 |          6 |( 46.15385 +- 13.82642)% |
+ |*"# passed vertex fit"                           |        13 |         13 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        192 |    0.96000 |
+ | "Input2 size"                                   |       200 |        991 |     4.9550 |
+ | "candidate multiplicity"                        |       200 |          6 |   0.030000 |    0.17059 |      0.0000 |      1.0000 |
+Test_Hyperons_Lambda_DD                INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |       200 |          5 |( 2.500000 +- 1.103970)% |
+ |*"# passed CombinationCut"                       |      2023 |         17 |(0.8403361 +- 0.2029533)% |
+ |*"# passed CompositeCut"                         |        17 |          6 |( 35.29412 +- 11.59040)% |
+ |*"# passed vertex fit"                           |        17 |         17 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |        236 |     1.1800 |
+ | "Input2 size"                                   |       200 |       2225 |     11.125 |
+ | "candidate multiplicity"                        |       200 |          6 |   0.030000 |    0.19774 |      0.0000 |      2.0000 |
+Test_Hyperons_Xic0ToL0PimPip_DD        INFO Number of counters : 7
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         5 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed Combination12Cut"                     |         9 |          1 |( 11.11111 +- 10.47566)% |
+ |*"# passed CombinationCut"                       |         2 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         5 |          6 |     1.2000 |
+ | "Input2 size"                                   |         5 |         15 |     3.0000 |
+ | "Input3 size"                                   |         5 |         15 |     3.0000 |
+ | "candidate multiplicity"                        |         5 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
+Test_Hyperons_Xim_LLL                  INFO Number of counters : 5
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"# passed"                                      |         6 |          0 |( 0.000000 +- 0.000000)% |
+ |*"# passed CombinationCut"                       |        46 |          0 |( 0.000000 +- 0.000000)% |
+ | "Input1 size"                                   |         6 |          6 |     1.0000 |
+ | "Input2 size"                                   |         6 |         79 |     13.167 |
+ | "candidate multiplicity"                        |         6 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 Test_MassConstrJpsi2MuMuMaker          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |         83 |( 41.50000 +- 3.484071)% |
- |*"# passed CombinationCut"                       |     51089 |        213 |(0.4169195 +- 0.02850724)% |
- |*"# passed CompositeCut"                         |       213 |        210 |( 98.59155 +- 0.8074225)% |
- |*"# passed vertex fit"                           |       213 |        213 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       2123 |     10.615 |
- | "candidate multiplicity"                        |       200 |        210 |     1.0500 |     1.7486 |      0.0000 |      12.000 |
+ |*"# passed"                                      |       200 |         68 |( 34.00000 +- 3.349627)% |
+ |*"# passed CombinationCut"                       |     41480 |        160 |(0.3857281 +- 0.03043561)% |
+ |*"# passed CompositeCut"                         |       160 |        156 |( 97.50000 +- 1.234276)% |
+ |*"# passed vertex fit"                           |       160 |        160 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11847 |     59.235 |
+ | "Input2 size"                                   |       200 |       1861 |     9.3050 |
+ | "candidate multiplicity"                        |       200 |        156 |    0.78000 |     1.5816 |      0.0000 |      12.000 |
 Test_Phi2KKMaker                       INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"# passed"                                      |       200 |        107 |( 53.50000 +- 3.526861)% |
- |*"# passed CombinationCut"                       |    192687 |      13212 |( 6.856716 +- 0.05757151)% |
- |*"# passed CompositeCut"                         |     13212 |        322 |( 2.437178 +- 0.1341534)% |
- |*"# passed vertex fit"                           |     13212 |      13212 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |      12976 |     64.880 |
- | "Input2 size"                                   |       200 |       7917 |     39.585 |
- | "candidate multiplicity"                        |       200 |        322 |     1.6100 |     2.4633 |      0.0000 |      14.000 |
+ |*"# passed"                                      |       200 |         99 |( 49.50000 +- 3.535357)% |
+ |*"# passed CombinationCut"                       |    157077 |       9783 |( 6.228156 +- 0.06097610)% |
+ |*"# passed CompositeCut"                         |      9783 |        280 |( 2.862108 +- 0.1685782)% |
+ |*"# passed vertex fit"                           |      9783 |       9783 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |      11847 |     59.235 |
+ | "Input2 size"                                   |       200 |       7256 |     36.280 |
+ | "candidate multiplicity"                        |       200 |        280 |     1.4000 |     2.3452 |      0.0000 |      15.000 |
 Test_Pi0ToGammaGamma_Combiner          INFO Number of counters : 7
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"# passed"                                      |       200 |         81 |( 40.50000 +- 3.471131)% |
- |*"# passed CombinationCut"                       |     40164 |        137 |(0.3411015 +- 0.02909252)% |
- |*"# passed CompositeCut"                         |       137 |        137 |( 100.0000 +- 0.000000)% |
- |*"# passed vertex fit"                           |       137 |        137 |( 100.0000 +- 0.000000)% |
- | "Input1 size"                                   |       200 |       3660 |     18.300 |
- | "Input2 size"                                   |       200 |       3660 |     18.300 |
- | "candidate multiplicity"                        |       200 |        137 |    0.68500 |     1.0324 |      0.0000 |      4.0000 |
+ |*"# passed CombinationCut"                       |     40617 |        138 |(0.3397592 +- 0.02887305)% |
+ |*"# passed CompositeCut"                         |       138 |        138 |( 100.0000 +- 0.000000)% |
+ |*"# passed vertex fit"                           |       138 |        138 |( 100.0000 +- 0.000000)% |
+ | "Input1 size"                                   |       200 |       3681 |     18.405 |
+ | "Input2 size"                                   |       200 |       3681 |     18.405 |
+ | "candidate multiplicity"                        |       200 |        138 |    0.69000 |     1.0363 |      0.0000 |      4.0000 |
 TrackBeamLineVertexFinderSoA_609...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fraction of failed PV fits"                    |      1019 |          0 |( 0.000000 +- 0.000000)% |
  |*"Fraction of unconverged PV fits"               |      1019 |         71 |( 6.967615 +- 0.7975760)% |
  | "Nb PVs"                                        |       200 |        997 |     4.9850 |
+UTHitClustersToPrUTHitsConverter...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
+UTHitClustersToUTHitHandlerConve...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "# Converted Clusters"                          |       200 |     208750 |     1043.8 |
 VPLightClustersToVPMicroClusters...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# Converted Clusters"                          |       200 |     420481 |     2102.4 |
@@ -732,15 +857,18 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |       200 |     420481 |     2102.4 |
  | "Nb of Produced Tracks"                         |       200 |      46475 |     232.38 |
-fromPrSeedingTracksV1Tracks_4ebf...    INFO Number of counters : 1
+fromPrSeedingTracksV1Tracks_1499...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of converted Tracks"                        |       200 |      10374 |     51.870 |
+ | "Nb of converted Tracks"                        |       200 |       8650 |     43.250 |
 fromPrVeloTracksV1TracksMerger_8...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of converted Tracks"                        |       200 |      46475 |     232.38 |
+fromV2MuonPIDV1MuonPIDDownstream...    INFO Number of counters : 1
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "Nb of Produced MuonPIDs"                       |       200 |       2984 |     14.920 |
 fromV2MuonPIDV1MuonPIDLong_e60c416d    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced MuonPIDs"                       |       200 |      12976 |     64.880 |
+ | "Nb of Produced MuonPIDs"                       |       200 |      11847 |     59.235 |
 require_pvs                            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |       200 |        200 |( 100.0000 +- 0.000000)% |
-- 
GitLab


From 2e1af4c69641a9df0ad0b00c45d004aaa75c821d Mon Sep 17 00:00:00 2001
From: Miroslav Saur <miroslav.saur@cern.ch>
Date: Wed, 25 Dec 2024 12:29:01 +0100
Subject: [PATCH 10/31] Adding MC job configurations for HLT2 and Sprucing into
 `2024-patches`

---
 ...allen_hlt1_pp_2024_production_options.yaml |   4 +-
 .../options/hlt2_pp_2024_flagging_mc.yaml     |  25 ++++
 .../hlt2_pp_2024_flagging_persistreco_mc.yaml |  21 +++
 .../hlt2_pp_2024_flagging_reco_only_mc.yaml   |  20 +++
 .../options/hlt2_pp_2024_noflagging_mc.yaml   |  20 +++
 .../hlt2_pp_2024_production_options.yaml      |   1 +
 ...production_options_2024_hlt1_filtered.yaml |  12 +-
 Hlt/Hlt2Conf/options/hlt2_test_flagging.py    |   6 +-
 .../options/spruce_pp_2024_flagging_mc.yaml   |  23 ++++
 ...pruce_pp_2024_flagging_persistreco_mc.yaml |  19 +++
 .../options/spruce_pp_2024_noflagging_mc.yaml |  20 +++
 .../spruce_pp_2024_production_options.yaml    |   6 -
 .../python/Hlt2Conf/lines/mc/mc_lines.py      |  79 ++++++++++--
 Hlt/Moore/CMakeLists.txt                      |   1 +
 Hlt/Moore/python/Moore/LbExec.py              |   7 +-
 Hlt/Moore/python/Moore/production.py          | 120 +++++++++++++++---
 Hlt/Moore/tests/qmtest/test_lbexec_hlt2.qmt   |   1 +
 ... test_lbexec_hlt2_pp_2024_flagging_mc.qmt} |  14 +-
 ...test_lbexec_hlt2_pp_2024_noflagging_mc.qmt |  39 ++++++
 ...lbexec_hlt2_pp_flagging_persistreco_mc.qmt |  44 +++++++
 ...t_lbexec_hlt2_pp_flagging_reco_only_mc.qmt |  52 ++++++++
 ...hlt2_pp_flagging_reco_only_rawbanks_mc.qmt |  45 +++++++
 ...ault_mc.qmt => test_lbexec_hlt2_pp_mc.qmt} |  22 ++--
 ...lbexec_hlt2_pp_no_ut_2024_flagging_mc.qmt} |   0
 ...est_lbexec_spruce_pp_2024_flagging_mc.qmt} |  23 +++-
 ...st_lbexec_spruce_pp_2024_noflagging_mc.qmt |  46 +++++++
 ...uce_pp_default_flagging_persistreco_mc.qmt |  45 +++++++
 27 files changed, 639 insertions(+), 76 deletions(-)
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_persistreco_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_reco_only_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/hlt2_pp_2024_noflagging_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_persistreco_mc.yaml
 create mode 100644 Hlt/Hlt2Conf/options/spruce_pp_2024_noflagging_mc.yaml
 rename Hlt/Moore/tests/qmtest/{test_lbexec_hlt2_pp_2024_mc.qmt => test_lbexec_hlt2_pp_2024_flagging_mc.qmt} (83%)
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_persistreco_mc.qmt
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_mc.qmt
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_rawbanks_mc.qmt
 rename Hlt/Moore/tests/qmtest/{test_lbexec_spruce_pp_default_mc.qmt => test_lbexec_hlt2_pp_mc.qmt} (67%)
 rename Hlt/Moore/tests/qmtest/{test_lbexec_hlt2_pp_no_ut_2024_mc.qmt => test_lbexec_hlt2_pp_no_ut_2024_flagging_mc.qmt} (100%)
 rename Hlt/Moore/tests/qmtest/{test_lbexec_spruce_pp_2024_mc.qmt => test_lbexec_spruce_pp_2024_flagging_mc.qmt} (60%)
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_noflagging_mc.qmt
 create mode 100644 Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_flagging_persistreco_mc.qmt

diff --git a/Hlt/Hlt1Conf/options/allen_hlt1_pp_2024_production_options.yaml b/Hlt/Hlt1Conf/options/allen_hlt1_pp_2024_production_options.yaml
index fe60659fa25..2660813a990 100644
--- a/Hlt/Hlt1Conf/options/allen_hlt1_pp_2024_production_options.yaml
+++ b/Hlt/Hlt1Conf/options/allen_hlt1_pp_2024_production_options.yaml
@@ -8,10 +8,10 @@ geometry_version: run3/trunk
 conditions_version: jonrob/all-pmts-active
 
 input_files:
-  - root://eoslhcb.cern.ch//eos/lhcb/grid/prod/lhcb/MC/Dev/XDIGI/00212962/0000/00212962_00000010_1.xdigi
+  - root://eoslhcb.cern.ch//eos/lhcb/cern-swtest/lhcb/swtest/expected_2024_BdToKstgamma_xdigi/00212962_00000010_1.xdigi
 
 input_type: "ROOT"
 input_raw_format: 0.5
 evt_max: 20
 
-output_type: 'ROOT'
\ No newline at end of file
+output_type: 'ROOT'
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_mc.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_mc.yaml
new file mode 100644
index 00000000000..3eb359d2857
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_mc.yaml
@@ -0,0 +1,25 @@
+data_type: Upgrade
+simulation: True
+# As dddb_tag a branch with a newer particle table version is used here,
+# as some new hlt2 lines rely on new/renamed particles only introduced in dddb-20240427.
+# This workaround is temporary and can be removed, once newer simulation samples,
+# based on dddb-20240427 directly, are available for these tests.
+dddb_tag: 'upgrade/dddb-20221004-new-particle-table'
+conddb_tag: 'sim-20220929-vc-md100'
+
+# from the test Hlt/Moore/tests/qmtest/test_lbexec_allen_hlt1_pp_mc_2024.qmt
+input_files:
+  - LFN:allen_hlt1_pp_2024_production.dst
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+xml_summary_file: hlt2_pp_2024_summary.xml
+xml_file_catalog: hlt1_pool_xml_catalog.xml
+
+scheduler_legacy_mode: False
+
+output_file: hlt2_pp_2024_flagging_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_persistreco_mc.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_persistreco_mc.yaml
new file mode 100644
index 00000000000..a561b96ab28
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_persistreco_mc.yaml
@@ -0,0 +1,21 @@
+data_type: Upgrade
+simulation: True
+# As dddb_tag a branch with a newer particle table version is used here,
+# as some new hlt2 lines rely on new/renamed particles only introduced in dddb-20240427.
+# This workaround is temporary and can be removed, once newer simulation samples,
+# based on dddb-20240427 directly, are available for these tests.
+dddb_tag: 'upgrade/dddb-20221004-new-particle-table'
+conddb_tag: 'sim-20220929-vc-md100'
+
+
+# from the test Hlt/Moore/tests/qmtest/test_lbexec_allen_hlt1_pp_mc_2024.qmt
+input_files:
+  - allen_hlt1_pp_2024_production.dst
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+output_file: hlt2_pp_2024_flagging_persistreco_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_reco_only_mc.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_reco_only_mc.yaml
new file mode 100644
index 00000000000..aa6fde41d1e
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_flagging_reco_only_mc.yaml
@@ -0,0 +1,20 @@
+data_type: Upgrade
+simulation: True
+# As dddb_tag a branch with a newer particle table version is used here,
+# as some new hlt2 lines rely on new/renamed particles only introduced in dddb-20240427.
+# This workaround is temporary and can be removed, once newer simulation samples,
+# based on dddb-20240427 directly, are available for these tests.
+dddb_tag: 'upgrade/dddb-20221004-new-particle-table'
+conddb_tag: 'sim-20220929-vc-md100'
+
+# from the test Hlt/Moore/tests/qmtest/test_lbexec_allen_hlt1_pp_mc_2024.qmt
+input_files:
+  - allen_hlt1_pp_2024_production.dst
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+output_file: hlt2_pp_2024_flagging_reco_only_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_noflagging_mc.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_2024_noflagging_mc.yaml
new file mode 100644
index 00000000000..c77bafea806
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_noflagging_mc.yaml
@@ -0,0 +1,20 @@
+data_type: Upgrade
+simulation: True
+# As dddb_tag a branch with a newer particle table version is used here,
+# as some new hlt2 lines rely on new/renamed particles only introduced in dddb-20240427.
+# This workaround is temporary and can be removed, once newer simulation samples,
+# based on dddb-20240427 directly, are available for these tests.
+dddb_tag: 'upgrade/dddb-20221004-new-particle-table'
+conddb_tag: 'sim-20220929-vc-md100'
+
+# from the test Hlt/Moore/tests/qmtest/test_lbexec_allen_hlt1_pp_mc_2024.qmt
+input_files:
+  - allen_hlt1_pp_2024_production.dst
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+output_file: hlt2_pp_2024_noflagging_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_2024_production_options.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_2024_production_options.yaml
index c5f587b37f8..9d3004d2f02 100644
--- a/Hlt/Hlt2Conf/options/hlt2_pp_2024_production_options.yaml
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_2024_production_options.yaml
@@ -7,6 +7,7 @@ simulation: True
 dddb_tag: 'upgrade/dddb-20221004-new-particle-table'
 conddb_tag: 'sim-20220929-vc-md100'
 
+
 # from the test Hlt/Moore/tests/qmtest/test_lbexec_allen_hlt1_pp_mc_2024.qmt
 input_files:
   - LFN:allen_hlt1_pp_2024_production.dst
diff --git a/Hlt/Hlt2Conf/options/hlt2_production_options_2024_hlt1_filtered.yaml b/Hlt/Hlt2Conf/options/hlt2_production_options_2024_hlt1_filtered.yaml
index 188cda30217..ed64191ff13 100644
--- a/Hlt/Hlt2Conf/options/hlt2_production_options_2024_hlt1_filtered.yaml
+++ b/Hlt/Hlt2Conf/options/hlt2_production_options_2024_hlt1_filtered.yaml
@@ -1,22 +1,14 @@
-data_type: Upgrade
-simulation: True
 # As dddb_tag a branch with a newer particle table version is used here,
 # as some new hlt2 lines rely on new/renamed particles only introduced in dddb-20240427.
 # This workaround is temporary and can be removed, once newer simulation samples,
 # based on dddb-20240427 directly, are available for these tests.
 dddb_tag: 'upgrade/dddb-20231017-new-particle-table'
-conddb_tag: 'sim-20231017-vc-md100'
-geometry_version: run3/trunk
-conditions_version: jonrob/all-pmts-active
 
-#testfiledb_key: expected_2024_min_bias_hlt1_filtered_v2
-input_files:
-  - mdf:root://eoslhcb.cern.ch//eos/lhcb/wg/rta/WP3/bandwidth_division/Beam6800GeV-expected-2024-MagDown-Nu7.6/hlt1_filtered/v2/30000000/input_0.mdf
-
-input_type: "RAW"
+testfiledb_key: 'expected_2024_min_bias_hlt1_filtered_v2'
 input_raw_format: 0.0
 evt_max: 20
 
+
 xml_summary_file: "hlt2_summary_2024.xml"
 xml_file_catalog: "hlt2_pool_xml_catalog_2024.xml"
 
diff --git a/Hlt/Hlt2Conf/options/hlt2_test_flagging.py b/Hlt/Hlt2Conf/options/hlt2_test_flagging.py
index 582b8b8a090..8ac79950fc1 100644
--- a/Hlt/Hlt2Conf/options/hlt2_test_flagging.py
+++ b/Hlt/Hlt2Conf/options/hlt2_test_flagging.py
@@ -17,7 +17,7 @@ Run like any other options file:
 from Moore import options
 from Moore.production import hlt2
 from RecoConf.reconstruction_objects import reconstruction
-from RecoConf.hlt2_global_reco import reconstruction as hlt2_reconstruction, make_light_reco_pr_kf_without_UT
+from RecoConf.hlt2_global_reco import reconstruction as hlt2_reconstruction, make_light_reco_pr_kf
 from Hlt2Conf.lines.test.hlt2_test import hlt2_test_lines
 
 options.evt_max = 200
@@ -35,8 +35,8 @@ def make_lines(make_lines=None):
 options.lines_maker = make_lines
 
 #find all arguments in Moore.production module
-hlt2_mc_args = ("--flagging", "--without-ut")
+hlt2_mc_args = ("--flagging", "--velo-source=VPRetinaCluster")
 
 with reconstruction.bind(from_file=False), hlt2_reconstruction.bind(
-        make_reconstruction=make_light_reco_pr_kf_without_UT):
+        make_reconstruction=make_light_reco_pr_kf):
     config = hlt2(options, *hlt2_mc_args)
diff --git a/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_mc.yaml b/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_mc.yaml
new file mode 100644
index 00000000000..437f6ce3967
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_mc.yaml
@@ -0,0 +1,23 @@
+data_type: Upgrade
+simulation: True
+dddb_tag: 'dddb-20221004'
+conddb_tag: 'sim-20220929-vc-md100'
+
+input_files: ["hlt2_pp_2024_flagging_mc.dst"]
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+
+xml_summary_file: spruce_pp_2024_summary.xml
+xml_file_catalog: hlt2_pool_xml_catalog.xml
+
+scheduler_legacy_mode: False
+
+output_file: spruce_pp_2024_flagging_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
+
+input_process: Hlt2
+process: Spruce
diff --git a/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_persistreco_mc.yaml b/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_persistreco_mc.yaml
new file mode 100644
index 00000000000..37fde7ba825
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/spruce_pp_2024_flagging_persistreco_mc.yaml
@@ -0,0 +1,19 @@
+data_type: Upgrade
+simulation: True
+dddb_tag: 'dddb-20221004'
+conddb_tag: 'sim-20220929-vc-md100'
+
+input_files: ["hlt2_pp_2024_flagging_persistreco_mc.dst"]
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+scheduler_legacy_mode: False
+
+output_file: spruce_pp_2024_flagging_persistreco_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
+
+input_process: Hlt2
+process: Spruce
diff --git a/Hlt/Hlt2Conf/options/spruce_pp_2024_noflagging_mc.yaml b/Hlt/Hlt2Conf/options/spruce_pp_2024_noflagging_mc.yaml
new file mode 100644
index 00000000000..8ecd091f2e7
--- /dev/null
+++ b/Hlt/Hlt2Conf/options/spruce_pp_2024_noflagging_mc.yaml
@@ -0,0 +1,20 @@
+data_type: Upgrade
+simulation: True
+dddb_tag: 'dddb-20221004'
+conddb_tag: 'sim-20220929-vc-md100'
+
+input_files: ["hlt2_pp_2024_noflagging_mc.dst"]
+input_type: "ROOT"
+input_raw_format: 0.5
+evt_max: -1
+
+
+scheduler_legacy_mode: False
+
+output_file: spruce_pp_2024_noflagging_mc.dst
+output_type: 'ROOT'
+geometry_version: run3/trunk
+conditions_version: jonrob/all-pmts-active
+
+input_process: Hlt2
+process: Spruce
diff --git a/Hlt/Hlt2Conf/options/spruce_pp_2024_production_options.yaml b/Hlt/Hlt2Conf/options/spruce_pp_2024_production_options.yaml
index 88d350f4a3a..f30cfc8dffc 100644
--- a/Hlt/Hlt2Conf/options/spruce_pp_2024_production_options.yaml
+++ b/Hlt/Hlt2Conf/options/spruce_pp_2024_production_options.yaml
@@ -3,17 +3,11 @@ simulation: True
 dddb_tag: 'dddb-20221004'
 conddb_tag: 'sim-20220929-vc-md100'
 
-# from the test Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_mc.qmt
 input_files: ["hlt2_pp_2024_output.dst"]
 input_type: "ROOT"
 input_raw_format: 0.5
 evt_max: -1
 
-xml_summary_file: spruce_pp_2024_summary.xml
-xml_file_catalog: hlt2_pool_xml_catalog.xml
-
-scheduler_legacy_mode: False
-
 output_file: spruce_pp_2024_output.dst
 output_type: 'ROOT'
 geometry_version: run3/trunk
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/mc/mc_lines.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/mc/mc_lines.py
index 1afc918d187..c82646c7c86 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/mc/mc_lines.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/mc/mc_lines.py
@@ -9,34 +9,91 @@
 # or submit itself to any jurisdiction.                                       #
 ###############################################################################
 from Moore.lines import Hlt2Line, SpruceLine
+from Moore.streams import DETECTORS
 
 MC_HLT2_PASSTHROUGH_LINE_NAME = "Hlt2MCPassThrough"
+MC_HLT2_PASSTHROUGH_PERSISTRECO_LINE_NAME = "Hlt2MCPassThroughPersistReco"
+MC_HLT2_PASSTHROUGH_RAWBANKS_LINE_NAME = "Hlt2MCPassThroughRawBanks"
+MC_HLT2_PASSTHROUGH_PERSISTRECO_RAWBANKS_LINE_NAME = "Hlt2MCPassThroughPersistRecoRawBanks"
+
 MC_SPRUCE_PASSTHROUGH_LINE_NAME = "SpruceMCPassThrough"
+MC_SPRUCE_PASSTHROUGH_PERSISTRECO_LINE_NAME = "SpruceMCPassThroughPersistReco"
+MC_SPRUCE_PASSTHROUGH_RAWBANKS_LINE_NAME = "SpruceMCPassThroughRawBanks"
+MC_SPRUCE_PASSTHROUGH_PERSISTRECO_RAWBANKS_LINE_NAME = "SpruceMCPassThroughPersistRecoRawBanks"
 
 
 def make_hlt2_passthrough_line(name=MC_HLT2_PASSTHROUGH_LINE_NAME):
+    """Line to select all events in flagging mode.
+    """
+    print(f"Adding {name} for simulation")
+    return Hlt2Line(name=name, algs=[], prescale=1)
+
+
+def make_hlt2_passthrough_persistreco_line(
+        name=MC_HLT2_PASSTHROUGH_PERSISTRECO_LINE_NAME):
+    """Line to select all events in flagging mode.
+
+        persistreco=True emulates Brunel.
+
+    """
+    print(f"Adding {name} for simulation")
+    return Hlt2Line(name=name, algs=[], prescale=1, persistreco=True)
+
+
+def make_hlt2_passthrough_rawbanks_line(
+        name=MC_HLT2_PASSTHROUGH_RAWBANKS_LINE_NAME):
+    """Line to select all events in flagging mode.
+
+        persistreco=True emulates Brunel.
+
+    """
+    print(f"Adding {name} for simulation")
+    return Hlt2Line(name=name, algs=[], prescale=1, raw_banks=DETECTORS)
+
+
+def make_hlt2_passthrough_persistreco_rawbanks_line(
+        name=MC_HLT2_PASSTHROUGH_PERSISTRECO_RAWBANKS_LINE_NAME):
     """Line to select all events in flagging mode.
 
         persistreco=True emulates Brunel.
 
     """
-    print(f"Adding {MC_HLT2_PASSTHROUGH_LINE_NAME} for simulation")
+    print(f"Adding {name} for simulation")
     return Hlt2Line(
-        name=MC_HLT2_PASSTHROUGH_LINE_NAME,
-        algs=[],
-        prescale=1,
-        persistreco=True)
+        name=name, algs=[], prescale=1, persistreco=True, raw_banks=DETECTORS)
 
 
 def make_spruce_passthrough_line(name=MC_SPRUCE_PASSTHROUGH_LINE_NAME):
     """Line to select all events in flagging mode.
 
-        persistreco=True emulates Brunel.
+    """
+    print(f"Adding {name} for simulation")
+    return SpruceLine(name=name, algs=[], prescale=1)
+
+
+def make_spruce_passthrough_persistreco_line(
+        name=MC_SPRUCE_PASSTHROUGH_PERSISTRECO_LINE_NAME):
+    """Line to select all events in flagging mode.
+
+    """
+    print(f"Adding {name} for simulation")
+    return SpruceLine(name=name, algs=[], prescale=1, persistreco=True)
+
+
+def make_spruce_passthrough_rawbanks_line(
+        name=MC_SPRUCE_PASSTHROUGH_RAWBANKS_LINE_NAME):
+    """Line to select all events in flagging mode.
+
+    """
+    print(f"Adding {name} for simulation")
+    return SpruceLine(name=name, algs=[], prescale=1, raw_banks=DETECTORS)
+
+
+def make_spruce_passthrough_persistreco_rawbanks_line(
+        name=MC_SPRUCE_PASSTHROUGH_PERSISTRECO_RAWBANKS_LINE_NAME):
+    """Line to select all events in flagging mode.
 
     """
-    print(f"Adding {MC_SPRUCE_PASSTHROUGH_LINE_NAME} for simulation")
+    print(f"Adding {name} for simulation")
     return SpruceLine(
-        name=MC_SPRUCE_PASSTHROUGH_LINE_NAME,
-        algs=[],
-        prescale=1,
-        persistreco=True)
+        name=name, algs=[], prescale=1, persistreco=True, raw_banks=DETECTORS)
diff --git a/Hlt/Moore/CMakeLists.txt b/Hlt/Moore/CMakeLists.txt
index d1a9eae5d8e..4c168c40456 100644
--- a/Hlt/Moore/CMakeLists.txt
+++ b/Hlt/Moore/CMakeLists.txt
@@ -27,6 +27,7 @@ if(NOT USE_DD4HEP)
             Moore.test_lbexec_hlt2_pp_2022_reprocessing_data
             Moore.test_lbexec_hlt2_pp_2022_reprocessing_data_check
             Moore.test_lbexec_hlt2_pp_2022_reprocessing_data_check_output
+            Moore.test_lbexec_spruce_pp_2024_noflagging_mc
         PROPERTY
             DISABLED TRUE
     )
diff --git a/Hlt/Moore/python/Moore/LbExec.py b/Hlt/Moore/python/Moore/LbExec.py
index 24c76c3a042..398902584d3 100644
--- a/Hlt/Moore/python/Moore/LbExec.py
+++ b/Hlt/Moore/python/Moore/LbExec.py
@@ -12,7 +12,7 @@ from typing import Optional
 from contextlib import contextmanager
 from enum import Enum
 
-from GaudiConf.LbExec import Options as DefaultOptions
+from GaudiConf.LbExec import Options as DefaultOptions, TestOptionsBase
 from PyConf.application import ROOT_KEY
 
 from PyConf.packing import persistreco_version
@@ -68,3 +68,8 @@ class Options(DefaultOptions):
 
         with super().apply_binds():
             yield
+
+
+class TestOptions(Options, TestOptionsBase):
+    """Specialized Options class for Moore Tests"""
+    pass
diff --git a/Hlt/Moore/python/Moore/production.py b/Hlt/Moore/python/Moore/production.py
index 073e5b30fcb..3945a9059ae 100644
--- a/Hlt/Moore/python/Moore/production.py
+++ b/Hlt/Moore/python/Moore/production.py
@@ -44,6 +44,10 @@ def hlt2(options: Options, *raw_args):
        settings(default=None, will run all lines in one stream): to set the streams and reconstruction options
        flagging(default=False): to run MC in flagging mode
        require_deployed_trigger_key(default=False)
+       flagging(default=False): to run MC in flagging mode
+       persistreco(default=False): to run MC in persistreco mode (with flaggging only)
+       rawbanks(default=None): to run MC persisting rawbanks (with flaggging only)
+       reco_only(default=False): to run MC in reconstruction only mode (with flaggging only)
        line_regex(default=None): to select lines based on regex match
        velo_source(default="VPRetinaCluster"): Velo bank type, either VPRetinaCluster or VeloSP
     """
@@ -61,9 +65,18 @@ def hlt2(options: Options, *raw_args):
         from Hlt2Conf.settings.defaults import make_all_lines
         make_streams = make_all_lines
 
-    return _hlt2(options, make_streams, args.lines_regex,
-                 args.require_deployed_trigger_key, args.flagging,
-                 args.velo_source, args.without_ut)
+    return _hlt2(
+        options,
+        make_streams,
+        args.lines_regex,
+        args.require_deployed_trigger_key,
+        args.flagging,
+        args.persistreco,
+        args.rawbanks,
+        args.reco_only,
+        args.velo_source,
+        args.without_ut,
+    )
 
 
 def _parse_args(raw_args):
@@ -90,9 +103,28 @@ def _parse_args(raw_args):
         help="AllenSequence to import")
 
     parser.add_argument(
-        "--flagging",
+        "--flagging", action="store_true", help="Run MC in flagging mode")
+
+    parser.add_argument(
+        "--persistreco",
+        action="store_true",
+        help=
+        "To save reconstruction of all events. Only to be used with --flagging"
+    )
+
+    parser.add_argument(
+        "--rawbanks",
+        action="store_true",
+        help=
+        "To keep all detector banks of all events. Only to be used with --flagging"
+    )
+
+    parser.add_argument(
+        "--reco-only",
         action="store_true",
-        help="Run MC is flagging mode or not")
+        help=
+        "To run only the reconstruction for all events. Only to be used with --flagging"
+    )
 
     parser.add_argument(
         "--velo-source", default=None, help="Velo cluster type")
@@ -110,6 +142,9 @@ def _hlt2(options,
           lines_regex,
           require_deployed_trigger_key=False,
           flagging=False,
+          persistreco=False,
+          rawbanks=False,
+          reco_only=False,
           velo_source=None,
           without_ut=False):
     from Moore import run_moore
@@ -143,7 +178,14 @@ def _hlt2(options,
 
     def _my_line_maker():
         return _line_maker(
-            options, make_lines, lines_regex, flagging, process="Hlt2")
+            options,
+            make_lines,
+            lines_regex,
+            flagging,
+            persistreco,
+            rawbanks,
+            reco_only,
+            process="Hlt2")
 
     with reconstruction.bind(from_file=False), _apply_track_binds():
         config = run_moore(options, _my_line_maker, public_tools)
@@ -181,6 +223,9 @@ def _line_maker(options,
                 make_lines,
                 lines_regex,
                 flagging=False,
+                persistreco=False,
+                rawbanks=None,
+                reco_only=False,
                 process="Hlt2"):
 
     streams = make_lines()
@@ -202,15 +247,37 @@ def _line_maker(options,
     if options.simulation:
         streams = _flatten_and_deduplicate_lines(streams)
         if flagging:
-            from Hlt2Conf.lines.mc.mc_lines import (
-                make_hlt2_passthrough_line as make_passthrough_line,
-                make_spruce_passthrough_line as make_spruce_passthrough_line,
-            )
 
-            if process == "Hlt2":
-                streams += [make_lines(make_passthrough_line)]
+            if persistreco and rawbanks:
+                from Hlt2Conf.lines.mc.mc_lines import make_hlt2_passthrough_persistreco_rawbanks_line as hlt2passline
+                from Hlt2Conf.lines.mc.mc_lines import make_spruce_passthrough_persistreco_rawbanks_line as sprucepassline
+            elif persistreco:
+                from Hlt2Conf.lines.mc.mc_lines import make_hlt2_passthrough_persistreco_line as hlt2passline
+                from Hlt2Conf.lines.mc.mc_lines import make_spruce_passthrough_persistreco_line as sprucepassline
+            elif rawbanks:
+                from Hlt2Conf.lines.mc.mc_lines import make_hlt2_passthrough_rawbanks_line as hlt2passline
+                from Hlt2Conf.lines.mc.mc_lines import make_spruce_passthrough_rawbanks_line as sprucepassline
+            else:
+                from Hlt2Conf.lines.mc.mc_lines import make_hlt2_passthrough_line as hlt2passline
+                from Hlt2Conf.lines.mc.mc_lines import make_spruce_passthrough_line as sprucepassline
+
+            if process == "Spruce":
+                streams += [sprucepassline()]
             else:
-                streams += [make_spruce_passthrough_line()]
+                if not reco_only:
+                    streams += [make_lines(hlt2passline)]
+                else:
+                    if reco_only and not persistreco:
+                        raise ConfigurationError(
+                            "You have requested reco_only but not persistreco. This will not give you what you want"
+                        )
+
+                    streams = [make_lines(hlt2passline)]
+
+        if (persistreco or rawbanks or reco_only) and not flagging:
+            raise ConfigurationError(
+                "You have requested to use persistreco and/or rawbanks and/or reco_only but you are not running in flagging mode"
+            )
 
     if isinstance(streams, list):
         streams = make_default_streams(streams)
@@ -238,6 +305,9 @@ def spruce(options: Options, *raw_args):
        flagging(default=False): to run MC in flagging mode
        require_deployed_trigger_key(default=False)
        line_regex(default=None): to select lines based on regex match
+       persistreco(default=False): to run MC in persistreco mode (with flaggging only)
+       rawbanks(default=None): to run MC persisting rawbanks (with flaggging only)
+       reco_only(default=False): to run MC in reconstruction only mode (with flaggging onl
     """
 
     args = _parse_args(raw_args)
@@ -282,7 +352,8 @@ def spruce(options: Options, *raw_args):
 
     return _spruce(options, make_streams, full_lines_for_TISTOS,
                    args.lines_regex, args.require_deployed_trigger_key,
-                   args.flagging)
+                   args.flagging, args.persistreco, args.rawbanks,
+                   args.reco_only)
 
 
 def _spruce(options,
@@ -290,7 +361,10 @@ def _spruce(options,
             full_hlt2_lines,
             lines_regex,
             require_deployed_trigger_key=False,
-            flagging=False):
+            flagging=False,
+            persistreco=False,
+            rawbanks=None,
+            reco_only=False):
 
     from Moore import run_moore, moore_control_flow
     from PyConf.application import metainfo_repos, retrieve_encoding_dictionary
@@ -311,13 +385,18 @@ def _spruce(options,
 
     def _my_line_maker():
         return _line_maker(
-            options, make_lines, lines_regex, flagging, process="Spruce")
+            options,
+            make_lines,
+            lines_regex,
+            flagging,
+            persistreco,
+            rawbanks,
+            reco_only,
+            process="Spruce")
 
     if options.simulation:
-
         config = configure_input(options)
         ## Implement a filter such that exclusive Sprucing only runs on FULL stream HLT2 lines
-        ## Add this filter before `moore_control_node` using `LAZY_AND` logic
 
         line_regex = "|".join(
             line for line in [line + "Decision" for line in full_hlt2_lines])
@@ -337,12 +416,15 @@ def _spruce(options,
             moore_control_node = moore_control_flow(
                 options, _my_line_maker(), process="spruce")
 
-            moore_control_node = CompositeNode(
+            ## Add this filter before `moore_control_node` using `LAZY_AND` logic IF flagging
+            moore_withfilter_node = CompositeNode(
                 'MC_spruce_control_node',
                 combine_logic=NodeLogic.LAZY_AND,
                 children=[full_stream_filter] + [moore_control_node],
                 force_order=True)
 
+            if not flagging:
+                moore_control_node = moore_withfilter_node
             config.update(
                 configure(
                     options, moore_control_node, public_tools=public_tools))
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2.qmt
index d9d65caa450..a48e07de241 100644
--- a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2.qmt
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2.qmt
@@ -19,6 +19,7 @@ Test that HLT2 can run from LHCbDirac and that it produces the expected outputs
 <argument name="program"><text>lbexec</text></argument>
 <argument name="timeout"><integer>1800</integer></argument>
 <argument name="args"><set>
+  <text>--override-option-class=Moore.LbExec:TestOptions</text>		
   <text>Moore.production:hlt2</text>
   <text>$HLT2CONFROOT/options/hlt2_production_options_2024_hlt1_filtered.yaml</text>
    <text>--</text>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_flagging_mc.qmt
similarity index 83%
rename from Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_mc.qmt
rename to Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_flagging_mc.qmt
index ebce02b04ae..332dec0344a 100644
--- a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_mc.qmt
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_flagging_mc.qmt
@@ -10,7 +10,7 @@
     or submit itself to any jurisdiction.
 -->
 <!--
-Test that HLT2 can run from LHCbDirac and that it produces the expected outputs
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for flagging mode
 -->
 <extension class="GaudiTest.GaudiExeTest" kind="test">
 <argument name="prerequisites"><set>
@@ -20,18 +20,20 @@ Test that HLT2 can run from LHCbDirac and that it produces the expected outputs
 <argument name="timeout"><integer>1000</integer></argument>
 <argument name="args"><set>
   <text>Moore.production:hlt2</text>
-  <text>$HLT2CONFROOT/options/hlt2_pp_2024_production_options.yaml</text>
+  <text>$HLT2CONFROOT/options/hlt2_pp_2024_flagging_mc.yaml</text>
   <text>--</text>
   <text>--settings=hlt2_pp_2024</text>
   <text>--flagging</text>
 </set></argument>
 <argument name="use_temp_dir"><enumeral>true</enumeral></argument>
 <argument name="validator"><text>
+findReferenceBlock("""Adding Hlt2MCPassThrough for simulation""")
 
 from Moore.qmtest.exclusions import remove_known_warnings
 countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
                 stdout=remove_known_warnings(stdout))
 
+
 import xml.etree.ElementTree as ET
 from pathlib import Path
 
@@ -40,13 +42,13 @@ tree = ET.parse(Path.cwd() / "hlt2_pp_2024_summary.xml")
 out_files = tree.findall("./output/file")
 assert len(out_files) == 1, out_files
 out_file = out_files[0]
-assert int(out_file.text) &gt; 0, "at least one event should be selected"
-assert int(out_file.text) &lt; 30, "at least one event should be rejected"
-assert out_file.attrib["name"] == "PFN:hlt2_pp_2024_output.dst"
+print(f"sizes : {int(out_file.text)}")
+assert int(out_file.text) == 20, "flagged jobs should keep all events"
+assert out_file.attrib["name"] == "PFN:hlt2_pp_2024_flagging_mc.dst"
 
 # Ensure the pool XML was updated to contain the new output file
 tree = ET.parse(Path.cwd() / "hlt1_pool_xml_catalog.xml")
-catalog_output = tree.findall(f'./File/physical/pfn[@name="hlt2_pp_2024_output.dst"]')
+catalog_output = tree.findall(f'./File/physical/pfn[@name="hlt2_pp_2024_flagging_mc.dst"]')
 assert len(catalog_output) == 1, catalog_output
 
 </text></argument>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
new file mode 100644
index 00000000000..910697dda0d
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
@@ -0,0 +1,39 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+-->
+<!--
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for non flagging mode
+-->
+
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_lbexec_allen_hlt1_pp_mc_2024</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1000</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:hlt2</text>
+  <text>$HLT2CONFROOT/options/hlt2_pp_2024_noflagging_mc.yaml</text>
+  <text>--</text>
+  <text>--settings=hlt2_pp_2024</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+findReferenceBlock("""# WARNING: Unsupported type &lt;class 'PrFilters.PrFiltersConf.PrFilter__PV'&gt; for line output PrFilter__PV/PrFilter__PV_6a9ee3b3 for line ('Hlt2IFTFull_SMOG2Passthrough_PV_in_SMOG2',); this will not be persisted. Only Particles are persisted as line outputs.
+ApplicationMgr    SUCCESS""")
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+</text></argument>
+</extension>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_persistreco_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_persistreco_mc.qmt
new file mode 100644
index 00000000000..f420c0a41c3
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_persistreco_mc.qmt
@@ -0,0 +1,44 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+-->
+<!--
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for flagging and persistreco mode
+-->
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_prepare_lbexec_hlt</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1800</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:hlt2</text>
+  <text>--export</text>
+  <text>job_opts</text>
+  <text>$HLT2CONFROOT/options/hlt2_pp_2024_flagging_persistreco_mc.yaml</text>
+   <text>--</text>
+   <text>--flagging</text>
+   <text>--persistreco</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+findReferenceBlock("""
+   LAZY_AND: Hlt2MCPassThroughPersistRecoDecisionWithOutput                                                            #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+    LAZY_AND: Hlt2MCPassThroughPersistReco                                                                             #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+     DeterministicPrescaler/Hlt2MCPassThroughPersistReco_Prescaler                                                     #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+""")
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+</text></argument>
+</extension>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_mc.qmt
new file mode 100644
index 00000000000..b10ae616eff
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_mc.qmt
@@ -0,0 +1,52 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+
+    if '.ModifyLocations = ' in result['job_opts_dump']:
+    causes.append("Found configured DVCommonBase algorithm in job_opts_dump")
+    https://gitlab.cern.ch/lhcb/LHCb/-/blob/master/Kernel/LHCbAlgs/tests/qmtest/lhcbalgs.qms/error_stream.qmt#L23
+
+-->
+<!--
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for flagging, persistreco and reco_only mode
+-->
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_prepare_lbexec_hlt</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1800</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:hlt2</text>
+  <text>$HLT2CONFROOT/options/hlt2_pp_2024_flagging_reco_only_mc.yaml</text>
+   <text>--</text>
+   <text>--flagging</text>
+   <text>--reco-only</text>
+   <text>--persistreco</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+findReferenceBlock("""
+HLTControlFlowMgr                      INFO StateTree: CFNode   #executed  #passed
+LAZY_AND: moore                                                                                                        #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+ NONLAZY_OR: lines                                                                                                     #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+  NONLAZY_OR: hlt_decision                                                                                             #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+   LAZY_AND: Hlt2MCPassThroughPersistRecoDecisionWithOutput                                                            #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+    LAZY_AND: Hlt2MCPassThroughPersistReco                                                                             #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+""")
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+
+</text></argument>
+</extension>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_rawbanks_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_rawbanks_mc.qmt
new file mode 100644
index 00000000000..f0d21a3dd51
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_flagging_reco_only_rawbanks_mc.qmt
@@ -0,0 +1,45 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2022 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+
+    if '.ModifyLocations = ' in result['job_opts_dump']:
+    causes.append("Found configured DVCommonBase algorithm in job_opts_dump")
+    https://gitlab.cern.ch/lhcb/LHCb/-/blob/master/Kernel/LHCbAlgs/tests/qmtest/lhcbalgs.qms/error_stream.qmt#L23
+
+-->
+<!--
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for flagging, persistreco, reco_only and rawbanks mode
+-->
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_prepare_lbexec_hlt</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1800</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:hlt2</text>
+  <text>--dry-run</text>
+  <text>$HLT2CONFROOT/options/hlt2_pp_2024_flagging_reco_only_mc.yaml</text>
+   <text>--</text>
+   <text>--flagging</text>
+   <text>--reco-only</text>
+   <text>--persistreco</text>
+   <text>--rawbanks</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+</text></argument>
+</extension>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_mc.qmt
similarity index 67%
rename from Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_mc.qmt
rename to Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_mc.qmt
index 4294578beb7..826e399ac09 100644
--- a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_mc.qmt
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_mc.qmt
@@ -1,6 +1,6 @@
 <?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
 <!--
-    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+    (c) Copyright 2022 CERN for the benefit of the LHCb Collaboration
 
     This software is distributed under the terms of the GNU General Public
     Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
@@ -8,23 +8,21 @@
     In applying this licence, CERN does not waive the privileges and immunities
     granted to it by virtue of its status as an Intergovernmental Organization
     or submit itself to any jurisdiction.
-
-    Test that Spruce can run from LHCbDirac and that it produces the expected outputs. Dry-run only!
 -->
-
-
+<!--
+Test that HLT2 can run from LHCbDirac and that it produces the expected outputs for default (mDST)
+-->
 <extension class="GaudiTest.GaudiExeTest" kind="test">
 <argument name="prerequisites"><set>
-  <tuple><text>test_lbexec_hlt2_pp_2024_mc</text><enumeral>PASS</enumeral></tuple>
+  <tuple><text>test_prepare_lbexec_hlt</text><enumeral>PASS</enumeral></tuple>
 </set></argument>
 <argument name="program"><text>lbexec</text></argument>
-<argument name="timeout"><integer>1000</integer></argument>
+<argument name="timeout"><integer>1800</integer></argument>
 <argument name="args"><set>
-  <text>Moore.production:spruce</text>
-  <text>--dry-run</text>
-  <text>$HLT2CONFROOT/options/spruce_pp_2024_production_options.yaml</text>
-  <text>--</text>
-  <text>--flagging</text>
+  <text>--override-option-class=Moore.LbExec:TestOptions</text>
+  <text>Moore.production:hlt2</text>
+  <text>$HLT2CONFROOT/options/hlt2_production_options_2024_hlt1_filtered.yaml</text>
+   <text>--</text>
 </set></argument>
 <argument name="use_temp_dir"><enumeral>true</enumeral></argument>
 <argument name="validator"><text>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_no_ut_2024_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_no_ut_2024_flagging_mc.qmt
similarity index 100%
rename from Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_no_ut_2024_mc.qmt
rename to Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_no_ut_2024_flagging_mc.qmt
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_flagging_mc.qmt
similarity index 60%
rename from Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_mc.qmt
rename to Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_flagging_mc.qmt
index 7c7ead5c60c..ca0672517af 100644
--- a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_mc.qmt
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_flagging_mc.qmt
@@ -10,17 +10,17 @@
     or submit itself to any jurisdiction.
 -->
 <!--
-Test that Spruce can run from LHCbDirac and that it produces the expected outputs
+Test that Spruce can run from LHCbDirac and that it produces the expected outputs in flagging mode
 -->
 <extension class="GaudiTest.GaudiExeTest" kind="test">
 <argument name="prerequisites"><set>
-  <tuple><text>test_lbexec_hlt2_pp_2024_mc</text><enumeral>PASS</enumeral></tuple>
+  <tuple><text>test_lbexec_hlt2_pp_2024_flagging_mc</text><enumeral>PASS</enumeral></tuple>
 </set></argument>
 <argument name="program"><text>lbexec</text></argument>
 <argument name="timeout"><integer>1000</integer></argument>
 <argument name="args"><set>
   <text>Moore.production:spruce</text>
-  <text>$HLT2CONFROOT/options/spruce_pp_2024_production_options.yaml</text>
+  <text>$HLT2CONFROOT/options/spruce_pp_2024_flagging_mc.yaml</text>
   <text>--</text>
   <text>--settings=Sprucing_production_physics_pp_Collision24c2</text>
   <text>--flagging</text>
@@ -32,6 +32,17 @@ from Moore.qmtest.exclusions import remove_known_warnings
 countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
                 stdout=remove_known_warnings(stdout))
 
+
+findReferenceBlock("""
+HLTControlFlowMgr                      INFO StateTree: CFNode   #executed  #passed
+LAZY_AND: moore                                                                                                   #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+ NONLAZY_OR: lines                                                                                                #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+  NONLAZY_OR: hlt_decision                                                                                        #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+   LAZY_AND: SpruceB2CC_BsToJpsiKstarWideDecisionWithOutput                                                       #=20      Sum=0           Eff=|( 0.000000 +- 0.00000 )%|
+    LAZY_AND: SpruceB2CC_BsToJpsiKstarWide                                                                        #=20      Sum=0           Eff=|( 0.000000 +- 0.00000 )%|
+ """)
+
+
 import xml.etree.ElementTree as ET
 from pathlib import Path
 
@@ -44,12 +55,12 @@ assert len(out_files) == 1, out_files
 in_file = in_files[0]
 out_file = out_files[0]
 print(f"sizes : {int(in_file.text)}, {int(out_file.text)}")
-assert 0.5*int(in_file.text) &lt;=  int(out_file.text), "Would expect at least half events retained from HLT2 step (given total event share of FULL stream lines)"
-assert out_file.attrib["name"] == "PFN:spruce_pp_2024_output.dst"
+assert int(in_file.text) ==  int(out_file.text), "Should retain all events"
+assert out_file.attrib["name"] == "PFN:spruce_pp_2024_flagging_mc.dst"
 
 # Ensure the pool XML was updated to contain the new output file
 tree = ET.parse(Path.cwd() / "hlt2_pool_xml_catalog.xml")
-catalog_output = tree.findall(f'./File/physical/pfn[@name="spruce_pp_2024_output.dst"]')
+catalog_output = tree.findall(f'./File/physical/pfn[@name="spruce_pp_2024_flagging_mc.dst"]')
 assert len(catalog_output) == 1, catalog_output
 
 </text></argument>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_noflagging_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_noflagging_mc.qmt
new file mode 100644
index 00000000000..190aa6bfe4d
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_2024_noflagging_mc.qmt
@@ -0,0 +1,46 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+-->
+<!--
+Test that Spruce can run from LHCbDirac and that it produces the expected outputs in non flagging mode
+-->
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_lbexec_hlt2_pp_2024_noflagging_mc</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1000</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:spruce</text>
+  <text>$HLT2CONFROOT/options/spruce_pp_2024_noflagging_mc.yaml</text>
+  <text>--</text>
+  <text>--settings=Sprucing_production_physics_pp_Collision24c2</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+findReferenceBlock("""
+HLTControlFlowMgr                      INFO StateTree: CFNode   #executed  #passed
+LAZY_AND: MC_spruce_control_node                                                                                   #=20      Sum=1           Eff=|( 5.000000 +- 4.87340 )%|
+ VoidFilter/full_stream_filter                                                                                     #=20      Sum=10          Eff=|( 50.00000 +- 11.1803 )%|
+ LAZY_AND: moore                                                                                                   #=10      Sum=1           Eff=|( 10.00000 +- 9.48683 )%|
+  NONLAZY_OR: lines                                                                                                #=10      Sum=1           Eff=|( 10.00000 +- 9.48683 )%|
+   NONLAZY_OR: hlt_decision                                                                                        #=10      Sum=1           Eff=|( 10.00000 +- 9.48683 )%|
+""")
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+
+
+</text></argument>
+</extension>
diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_flagging_persistreco_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_flagging_persistreco_mc.qmt
new file mode 100644
index 00000000000..a433bc5fafc
--- /dev/null
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_spruce_pp_default_flagging_persistreco_mc.qmt
@@ -0,0 +1,45 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+
+    Test that Spruce can run from LHCbDirac and that it produces the expected outputs in flagging and persistreco modes
+-->
+
+
+
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="prerequisites"><set>
+  <tuple><text>test_lbexec_hlt2_pp_flagging_persistreco_mc</text><enumeral>PASS</enumeral></tuple>
+</set></argument>
+<argument name="program"><text>lbexec</text></argument>
+<argument name="timeout"><integer>1000</integer></argument>
+<argument name="args"><set>
+  <text>Moore.production:spruce</text>
+  <text>$HLT2CONFROOT/options/spruce_pp_2024_flagging_persistreco_mc.yaml</text>
+  <text>--</text>
+  <text>--flagging</text>
+  <text>--persistreco</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="validator"><text>
+
+findReferenceBlock("""   LAZY_AND: SpruceMCPassThroughPersistRecoDecisionWithOutput                                                     #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+    LAZY_AND: SpruceMCPassThroughPersistReco                                                                      #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+     DeterministicPrescaler/SpruceMCPassThroughPersistReco_Prescaler                                              #=20      Sum=20          Eff=|( 100.0000 +- 0.00000 )%|
+""")
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+
+
+</text></argument>
+</extension>
-- 
GitLab


From 4074cf3c0fce210c17cb813521bfd8d5311c868a Mon Sep 17 00:00:00 2001
From: Yingrui Hou <yingrui.hou@cern.ch>
Date: Tue, 4 Feb 2025 11:39:03 +0100
Subject: [PATCH 11/31] Ft pseudo hiteff

---
 .../options/FT_pseudo_hit_efficiency.py       | 29 ++++++++---------
 .../tests/qmtest/FT_pseudo_hit_efficiency.qmt | 31 +++++++++++++++++++
 2 files changed, 46 insertions(+), 14 deletions(-)
 create mode 100644 Hlt/RecoConf/tests/qmtest/FT_pseudo_hit_efficiency.qmt

diff --git a/Hlt/RecoConf/options/FT_pseudo_hit_efficiency.py b/Hlt/RecoConf/options/FT_pseudo_hit_efficiency.py
index f007da398b0..99a701245a7 100644
--- a/Hlt/RecoConf/options/FT_pseudo_hit_efficiency.py
+++ b/Hlt/RecoConf/options/FT_pseudo_hit_efficiency.py
@@ -10,6 +10,7 @@
 ###############################################################################
 from PyConf.Algorithms import (
     FTHitEfficiencyMonitor,
+    FTPseudoHitEfficiencyMonitor,
     PrKalmanFilter_noUT,
     PrKalmanFilter_Seed,
     PrKalmanFilter_Velo,
@@ -24,7 +25,9 @@ from RecoConf.muonid import make_muon_hits
 from RecoConf.options import options
 
 # save output file with histograms
-options.histo_file = options.getProp("histo_file") or "bias_hlt2_FT_hit_efficiency.root"
+options.histo_file = (
+    options.getProp("histo_file") or "bias_hlt2_FT_pseudo_hit_efficiency.root"
+)
 
 
 def hit_efficiency_sequence():
@@ -43,21 +46,19 @@ def hit_efficiency_sequence():
             HitsLocation=make_FTRawBankDecoder_clusters()
         ).Output
 
-        for layer_under_study in range(12):  # histograms for the first station
-            my_ft_efficiency_alg = FTHitEfficiencyMonitor(
-                name="FTHitEfficiencyLayer{}".format(layer_under_study),
-                TrackLocation=hlt2_tracks["BestLong"]["v1"],
-                ExpertMode=True,
-                PrFTHitsLocation=all_FT_pr_hits,
-                LayerUnderStudy=layer_under_study,
-                MaxDoca=2.0,
-                MinTrackP=3000,
-                MinTrackPT=300,
-            )
+        my_ft_efficiency_alg = FTPseudoHitEfficiencyMonitor(
+            name="FTPseudoHitEfficiency",
+            TrackLocation=hlt2_tracks["BestLong"]["v1"],
+            PrFTHitsLocation=all_FT_pr_hits,
+            LayersUnderStudy=list(range(12)),
+            MaxDoca=2.0,
+            MinTrackP=3000,
+            MinTrackPT=300,
+        )
 
-            data += [my_ft_efficiency_alg]
+        data += [my_ft_efficiency_alg]
 
-    return Reconstruction("hlt2_hit_eff_reco", data, [])
+    return Reconstruction("hlt2_pseudo_hit_eff_reco", data, [])
 
 
 with (
diff --git a/Hlt/RecoConf/tests/qmtest/FT_pseudo_hit_efficiency.qmt b/Hlt/RecoConf/tests/qmtest/FT_pseudo_hit_efficiency.qmt
new file mode 100644
index 00000000000..56a5a85b7c4
--- /dev/null
+++ b/Hlt/RecoConf/tests/qmtest/FT_pseudo_hit_efficiency.qmt
@@ -0,0 +1,31 @@
+<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
+<!--
+    (c) Copyright 2024 CERN for the benefit of the LHCb Collaboration
+
+    This software is distributed under the terms of the GNU General Public
+    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
+
+    In applying this licence, CERN does not waive the privileges and immunities
+    granted to it by virtue of its status as an Intergovernmental Organization
+    or submit itself to any jurisdiction.
+-->
+<!--
+Check FT pseudo hit efficiency
+-->
+<extension class="GaudiTest.GaudiExeTest" kind="test">
+<argument name="program"><text>gaudirun.py</text></argument>
+<argument name="args"><set>
+  <text>$MOOREROOT/tests/options/default_input_and_conds_hlt2.py</text>
+  <text>$RECOCONFROOT/options/FT_pseudo_hit_efficiency.py</text>
+</set></argument>
+<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
+<argument name="reference"><text>../refs/FT_pseudo_hit_efficiency.ref</text></argument>
+<argument name="error_reference"><text>../../../RecoConf/tests/refs/empty.ref</text></argument>
+<argument name="validator"><text>
+
+from Moore.qmtest.exclusions import remove_known_warnings
+countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
+                stdout=remove_known_warnings(stdout))
+
+</text></argument>
+</extension>
-- 
GitLab


From e4f2ae597d29cd7dd9098864f25f6eeddb0a4abd Mon Sep 17 00:00:00 2001
From: Thomas Julian Boettcher <thboettc@n4050101.lbdaq.cern.ch>
Date: Thu, 31 Oct 2024 20:23:47 +0100
Subject: [PATCH 12/31] Fix monitoring of single jet lines

---
 Hlt/Moore/python/Moore/monitoring.py | 2 ++
 1 file changed, 2 insertions(+)

diff --git a/Hlt/Moore/python/Moore/monitoring.py b/Hlt/Moore/python/Moore/monitoring.py
index 94656d00330..acd2800fa26 100644
--- a/Hlt/Moore/python/Moore/monitoring.py
+++ b/Hlt/Moore/python/Moore/monitoring.py
@@ -57,6 +57,8 @@ def monitoring(algs, name, mon_vars):
                 last_combiner = filter_input
             elif "ParticleMaker" in filter_input.typename:
                 last_combiner = input_producer
+            elif "FastJetBuilder" in filter_input.typename:
+                last_combiner = input_producer
             elif "Filter" in filter_input.typename and "Input" in input_producer.inputs:
                 producer_output, last_combiner = get_producer_with_selection(
                     filter_input
-- 
GitLab


From cc449ee2312f093295c75b201945b7b8deb47701 Mon Sep 17 00:00:00 2001
From: Laurent Dufour <laurent.dufour@cern.ch>
Date: Wed, 5 Feb 2025 08:07:08 +0000
Subject: [PATCH 13/31] Update track_refitting module to include PV coordinate
 shift helper function

---
 .../python/RecoConf/track_refitting.py        | 24 +++++++++++++++++++
 1 file changed, 24 insertions(+)

diff --git a/Hlt/RecoConf/python/RecoConf/track_refitting.py b/Hlt/RecoConf/python/RecoConf/track_refitting.py
index 071b1381e87..62925665060 100644
--- a/Hlt/RecoConf/python/RecoConf/track_refitting.py
+++ b/Hlt/RecoConf/python/RecoConf/track_refitting.py
@@ -14,6 +14,7 @@ import logging
 
 import Functors as F
 
+## Algorithms for PV translations / rotations
 # Algorithms to get the Pr hits
 # Algorithms to take care of decay-tree refitting
 ## Algorithms for PV refitting
@@ -31,6 +32,7 @@ from PyConf.Algorithms import (
     SelectUTClustersFromTracks,
     SelectVPMicroClustersFromTracks,
     SharedTrackEventFitter,
+    UpdateVertexCoordinatesOffline,
     UTHitClustersToPrUTHitsConverter,
     UTHitClustersToUTHitHandlerConverter,
     V1V1PrKalmanFilter,
@@ -40,6 +42,8 @@ from PyConf.Algorithms import (
 
 from RecoConf.algorithms_thor import ParticleFilter
 
+# Uncomment when Rec!587 is merged
+# from PyConf.Algorithms import VeloKalmanTrackV1
 # Algotihms to perform the fit
 from RecoConf.hlt2_tracking import (
     get_global_measurement_provider,
@@ -274,3 +278,23 @@ def refit_pvs(
         InputTrackRelations=relation_table_match_by_veloid_to_track,
         OnlyKeepConvergedFits=(not keep_unconverged_fits),
     )
+
+
+def update_vertex_positions(*, input_pvs):
+    """Takes as input the DataHandle of RecVertices, and applies
+    a coordinate transform as defined in the conditions (and
+    accessible via in `DeLHCb::offlineCoordinateTransformation`).
+
+    These vertices are *not* fitted again, but merely shifted / rotated
+    around to account for a change in global coordinate transformation.
+
+    This is safe to be used on all data types, including those without
+    the PV tracks persisted.
+
+    The output contains the new vertices and a relation table between
+    the old particles and the new ones (2-way).
+    """
+
+    return UpdateVertexCoordinatesOffline(
+        name="UpdateVertexCoordinatesOffline_{hash}", InputVertices=input_pvs
+    )
-- 
GitLab


From cfa36c3f64f0a1fcf11b2c18c85ad3218bc72321 Mon Sep 17 00:00:00 2001
From: RefBot <lhcbsoft@cern.ch>
Date: Wed, 5 Feb 2025 13:09:08 +0100
Subject: [PATCH 14/31] Update References for: Rec!3813 based on
 lhcb-master-mr/12440

[skip ci]
---
 Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref     | 3 ++-
 .../tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a    | 3 ++-
 .../tests/refs/hlt2_reco_2024_with_mcchecking.ref.detdesc      | 3 ++-
 .../hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt   | 3 ++-
 .../refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt      | 3 ++-
 ..._reco_track_master_fitter_full_geometry_with_mcchecking.ref | 3 ++-
 ...k_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a | 3 ++-
 ...ack_master_fitter_full_geometry_with_mcchecking.ref.detdesc | 3 ++-
 ...ter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt | 3 ++-
 ...ster_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt | 3 ++-
 .../hlt2_default_reco_track_master_fitter_with_mcchecking.ref  | 3 ++-
 ...ault_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a | 3 ++-
 ...efault_reco_track_master_fitter_with_mcchecking.ref.detdesc | 3 ++-
 ...ack_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt | 3 ++-
 ..._reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt | 3 ++-
 Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref     | 3 ++-
 .../tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a    | 3 ++-
 .../tests/refs/hlt2_fast_reco_with_mcchecking.ref.detdesc      | 3 ++-
 .../hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt   | 3 ++-
 .../refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt      | 3 ++-
 Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref  | 3 ++-
 .../tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a | 3 ++-
 .../tests/refs/hlt2_fastest_reco_with_mcchecking.ref.detdesc   | 3 ++-
 ...hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt | 3 ++-
 .../refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-opt   | 3 ++-
 .../tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref       | 3 ++-
 .../refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a   | 3 ++-
 .../refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.detdesc     | 3 ++-
 ..._light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt | 3 ++-
 .../hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-opt    | 3 ++-
 .../refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref  | 3 ++-
 ...2_light_reco_pr_kf_without_UT_with_mcchecking.ref.armv8.1_a | 3 ++-
 ...lt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.detdesc | 3 ++-
 ..._pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-detdesc-opt | 3 ++-
 ...ght_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-opt | 3 ++-
 .../hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref  | 3 ++-
 ...ht_reco_pr_kf_without_UT_with_monitoring_2022.ref.armv8.1_a | 3 ++-
 ...ight_reco_pr_kf_without_UT_with_monitoring_2022.ref.detdesc | 3 ++-
 ...f_without_UT_with_monitoring_2022.ref.x86_64_v3-detdesc-opt | 3 ++-
 ...eco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-opt | 3 ++-
 Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref    | 3 ++-
 .../tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a   | 3 ++-
 .../tests/refs/hlt2_light_reco_with_mcchecking.ref.detdesc     | 3 ++-
 .../hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt  | 3 ++-
 .../refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt     | 3 ++-
 .../hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref     | 3 ++-
 ...reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a | 3 ++-
 ...2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.detdesc | 3 ++-
 ...e_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt | 3 ++-
 ..._baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt | 3 ++-
 50 files changed, 100 insertions(+), 50 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
index 66c682ae6a6..527f9bd94c9 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
@@ -3277,13 +3277,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pullx                                         | "pull x"                                      |        400 |    -0.0325 | 1.0927     |  -0.060335 |   -0.15088 |
  | pully                                         | "pull y"                                      |        400 |     -0.025 | 1.1272     |   -0.20488 |    0.39211 |
  | pullz                                         | "pull z"                                      |        400 |    0.08875 | 1.1340     |  -0.062377 |     1.2267 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     206495 |    -378.43 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      68394 |     30.954 | 17.620     |    0.85269 |    0.39455 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      68977 |    -1.2187 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      69124 |     59.544 | 26.895     |   -0.76621 |   -0.60493 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     206495 |    -71.663 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     154389 |     3.5038 | 0.95272    |   -0.17102 |     -1.558 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     206499 |    -469.83 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      68398 |     31.394 | 19.158     |    0.77519 |  -0.014988 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      68977 |   -0.80201 | 0.0000     |          0 |          0 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
index ef648e01583..34259e34421 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
@@ -3277,13 +3277,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pullx                                         | "pull x"                                      |        400 |   -0.03125 | 1.0933     |  -0.062791 |    -0.1563 |
  | pully                                         | "pull y"                                      |        400 |    -0.0225 | 1.1251     |   -0.20234 |    0.39567 |
  | pullz                                         | "pull z"                                      |        400 |       0.09 | 1.1328     |  -0.062774 |     1.2408 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     206520 |    -371.06 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      68405 |     31.113 | 17.815     |    0.85208 |    0.34859 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      68986 |   -0.60058 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      69129 |     59.948 | 26.754     |   -0.78997 |     -0.546 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     206520 |    -70.246 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     154431 |     3.4911 | 0.94491    |    -0.1361 |    -1.5465 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     206524 |    -450.28 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      68409 |     31.518 | 19.308     |    0.76938 |  -0.055118 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      68986 |   -0.45738 | 0.0000     |          0 |          0 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.detdesc b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.detdesc
index 869a8361f98..038240726b8 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.detdesc
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.detdesc
@@ -3392,13 +3392,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pullx                                         | "pull x"                                      |        399 |  -0.029449 | 1.1038     |  -0.042225 |    0.19119 |
  | pully                                         | "pull y"                                      |        399 |  -0.025689 | 1.1213     |  -0.092388 |     0.6263 |
  | pullz                                         | "pull z"                                      |        399 |    0.10464 | 1.1521     | -0.0046462 |     1.1822 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     206498 |    -607.35 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      68433 |      38.53 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      68954 |    -88.396 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      69111 |     99.273 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     206498 |    -109.96 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     154355 |     2.5671 | 0.75674    |     2.5356 |     5.0619 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     206501 |      -1030 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      68436 |     40.248 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      68954 |    -97.497 | 0.0000     |          0 |          0 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 825128033ff..988ed21f0c6 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3391,13 +3391,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pullx                                         | "pull x"                                      |        399 |  -0.030702 | 1.0900     |   0.012646 |  -0.019732 |
  | pully                                         | "pull y"                                      |        399 |  -0.016917 | 1.1387     |    -0.1414 |    0.46835 |
  | pullz                                         | "pull z"                                      |        399 |    0.08584 | 1.1361     |  -0.067055 |     1.1798 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     206543 |    -685.29 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      68450 |     38.801 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      68969 |    -83.072 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      69124 |      99.14 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     206543 |    -124.21 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     154430 |     2.5635 | 0.76906    |     2.5498 |     4.9932 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     206546 |      -1162 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      68453 |     40.492 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      68969 |    -91.961 | 0.0000     |          0 |          0 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
index 1fa9f1aca29..d0135e5c284 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
@@ -3279,13 +3279,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pullx                                         | "pull x"                                      |        403 |   -0.01799 | 1.0914     |   -0.12318 |   -0.15156 |
  | pully                                         | "pull y"                                      |        403 |  -0.041563 | 1.1238     |   -0.19042 |     0.3141 |
  | pullz                                         | "pull z"                                      |        403 |   0.080025 | 1.1453     |   -0.14717 |     1.2128 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     206577 |    -357.79 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      68424 |      31.19 | 17.754     |    0.86324 |    0.37141 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      69005 |    -1.3824 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      69148 |     60.121 | 26.554     |   -0.78525 |   -0.52844 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     206577 |    -67.707 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     154479 |     3.4688 | 0.93460    |  -0.095651 |     -1.541 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     206581 |    -434.13 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      68428 |     31.602 | 19.262     |    0.77846 |  -0.036874 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      69005 |    -0.9163 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref
index a391137211e..0c19d18809f 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref
@@ -3180,13 +3180,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      89717 |     893.96 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      29632 |     119.61 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      30063 |     13.707 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      30022 |     137.94 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      89717 |     162.22 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      63976 |     2.9733 | 0.35687    |     -8.033 |    -71.681 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      89717 |     893.96 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      29632 |     97.118 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      30063 |     11.898 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
index e95638e8ed9..e8de9be1cd5 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
@@ -3182,13 +3182,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      89727 |     1145.8 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      29637 |     119.32 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      30067 |     13.269 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      30023 |     139.34 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      89727 |     207.35 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      63985 |     2.9608 | 0.34038    |    -9.5066 |    -92.359 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      89727 |     1145.8 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      29637 |     96.093 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      30067 |     11.301 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.detdesc
index eeb3c27b809..8347356e844 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.detdesc
@@ -3283,13 +3283,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96164 |     208.08 | 53.269     |    -3.3914 |      10.45 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31800 |     86.466 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32270 |    -669.12 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32094 |     828.33 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96164 |     39.473 | 9.3339     |    -2.6908 |     6.3526 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78212 |     3.4458 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96164 |     208.08 | 53.269     |    -3.3914 |      10.45 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31800 |     75.104 | 18.440     |    -9.1925 |     51.082 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32270 |     2247.4 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
index f1bfb77bc90..2d98e07cd52 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3283,13 +3283,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96210 |     199.87 | 49.376     |    -2.9569 |     9.6119 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31816 |     88.456 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32288 |    -1932.8 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32106 |     4978.3 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96210 |     38.127 | 8.4109     |    -2.0614 |     4.6718 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78272 |     3.4541 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96210 |     199.87 | 49.376     |    -2.9569 |     9.6119 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31816 |     76.821 | 16.564     |    -12.484 |     84.325 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32288 |     782.45 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
index 15e2effe56c..a182ac43eb7 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
@@ -3182,13 +3182,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      89728 |      976.3 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      29636 |     114.64 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      30069 |     15.205 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      30023 |     136.51 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      89728 |     176.76 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      63977 |     2.9737 | 0.35983    |    -7.1819 |    -67.204 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      89728 |      976.3 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      29636 |      93.89 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      30069 |     13.485 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
index c5ece8e3981..25c4fc3648d 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
@@ -3605,13 +3605,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95786 |     434.74 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31668 |     411.93 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32136 |     149.94 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31982 |    -162.04 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95786 |     84.381 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      77987 |     2.7632 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95786 |     434.74 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31668 |        214 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32136 |     120.76 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
index 0e545ff3e3c..81b1a04d734 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
@@ -3607,13 +3607,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95827 |     438.06 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31682 |     416.05 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32149 |     157.42 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31996 |    -180.89 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95827 |     85.102 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78028 |     2.8789 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95827 |     438.06 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31682 |     215.75 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32149 |     124.96 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.detdesc
index 1a62166181d..da0b2777f0f 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.detdesc
@@ -3716,13 +3716,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96054 |     264.38 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31757 |     86.627 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32226 |    -170.77 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32071 |    -325.91 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96054 |     49.328 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78119 |     3.3455 | 0.11591    |    -255.61 |      -6668 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96054 |     264.38 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31757 |     72.296 | 19.955     |    -6.7657 |     30.961 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32226 |    -605.03 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 69f010f91e4..f5acb372ec7 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3716,13 +3716,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96112 |     258.59 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31775 |      88.85 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32250 |    -269.87 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32087 |    -250.84 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96112 |     48.394 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78213 |     3.3279 | 0.19032    |    -56.114 |     -932.6 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96112 |     258.59 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31775 |     72.396 | 21.617     |    -6.0434 |     24.507 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32250 |     5069.1 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
index bceaf28e92c..6d8d32fb3d5 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
@@ -3607,13 +3607,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95838 |      413.1 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31685 |     396.93 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32156 |     152.93 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31997 |    -207.83 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95838 |     80.241 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78064 |     2.9042 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95838 |      413.1 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31685 |     208.62 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32156 |     121.79 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
index c2dd4c2da75..da0941f57db 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
@@ -3194,13 +3194,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      94520 |     449.02 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31264 |     387.16 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      31694 |      212.6 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31562 |    -420.91 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      94520 |     87.175 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      76262 |     3.2146 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      94520 |     449.02 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31264 |     215.86 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      31694 |     133.67 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
index cec02aec03b..bb1c265ffd8 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
@@ -3196,13 +3196,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      94561 |     441.22 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31278 |     383.04 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      31707 |      236.4 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31576 |    -834.67 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      94561 |     85.735 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      76303 |     3.3036 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      94561 |     441.22 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31278 |     217.93 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      31707 |      141.1 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.detdesc
index 9c1cfc03209..b9caf1ebda7 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.detdesc
@@ -3253,13 +3253,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      94664 |     226.45 | 67.947     |    -3.5441 |     8.4229 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31306 |     80.271 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      31735 |    -248.87 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31623 |    -489.93 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      94664 |       42.6 | 12.074     |    -3.0629 |     5.2205 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      76245 |     3.4653 | 0.55046    |    0.20497 |    -5.5535 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      94664 |     226.45 | 67.947     |    -3.5441 |     8.4229 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31306 |     68.296 | 21.683     |    -4.5897 |     15.626 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      31735 |    -999.36 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index f2fa1eb32f9..3ab7971de6a 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3253,13 +3253,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      94712 |     223.57 | 74.743     |    -3.2811 |     7.0539 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31321 |     79.059 | 11.474     |    -33.093 |     378.63 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      31755 |    -256.19 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31636 |    -422.28 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      94712 |     42.054 | 13.434     |    -2.9665 |     5.2819 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      76317 |     3.4953 | 0.55540    |    0.26808 |    -5.6119 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      94712 |     223.57 | 74.743     |    -3.2811 |     7.0539 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31321 |      66.57 | 24.693     |    -3.5476 |     8.8349 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      31755 |    -1222.7 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
index c7a1d29bf0b..b39d56ab517 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
@@ -3196,13 +3196,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      94561 |     411.35 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31277 |     365.82 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      31710 |     232.68 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31574 |       9262 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      94561 |     79.844 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      76304 |     3.3172 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      94561 |     411.35 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31277 |     208.66 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      31710 |     137.67 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref
index 48db0cfe9c3..8e56efa9887 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref
@@ -3448,13 +3448,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     146092 |    -205.47 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      48433 |      33.52 | 17.612     |    0.94007 |    0.39839 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      48875 |     19.501 | 12.470     |      -1.43 |    -9.8306 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      48784 |     67.265 | 21.267     |   -0.48026 |    -1.7256 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     146092 |    -38.966 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     108663 |     3.3863 | 0.79817    |   0.040694 |    -1.0703 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     146093 |    -173.96 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      48434 |     33.474 | 18.878     |    0.79314 |   0.011613 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      48875 |     20.193 | 14.861     |   -0.11292 |    -3.4736 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
index d947b2eced6..76f6deb074e 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
@@ -3448,13 +3448,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     146110 |    -210.16 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      48439 |     33.489 | 17.626     |    0.93494 |    0.39917 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      48881 |     20.179 | 13.254     |   -0.89407 |    -6.7083 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      48790 |     66.471 | 22.230     |   -0.56653 |     -1.335 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     146110 |    -39.884 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     108681 |     3.3595 | 0.78737    |   0.047838 |    -1.0692 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     146111 |    -174.28 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      48440 |      33.43 | 18.898     |    0.79149 |   0.013992 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      48881 |     20.881 | 15.517     |   0.050725 |    -2.6378 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.detdesc
index 31e9410c19b..249fd2e5341 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.detdesc
@@ -3569,13 +3569,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     148720 |    -279.19 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      49321 |     44.027 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      49734 |    -7.2547 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      49665 |      110.8 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     148720 |    -50.851 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     111198 |     2.8394 | 0.73055    |     1.9939 |     4.2878 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     148721 |    -175.58 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      49322 |     45.869 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      49734 |    -6.0017 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index e27e3742d35..942eb7fb4f2 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3569,13 +3569,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     148745 |    -259.06 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      49329 |     44.145 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      49744 |    -8.6278 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      49672 |     111.33 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     148745 |    -47.083 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     111238 |     2.8634 | 0.73662    |     1.8646 |     3.7178 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     148746 |    -165.58 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      49330 |     46.035 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      49744 |    -7.3982 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-opt
index 65f5cbc3f62..7a5e4a87a5e 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-opt
@@ -3450,13 +3450,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     146114 |    -216.47 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      48441 |      33.33 | 17.637     |    0.94543 |     0.4187 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      48883 |     19.939 | 13.543     |   -0.80527 |    -6.6897 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      48790 |     66.728 | 22.214     |   -0.51648 |     -1.609 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     146114 |    -41.062 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     108688 |     3.3532 | 0.79077    |   0.073088 |    -1.0743 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     146115 |    -182.18 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      48442 |     33.283 | 18.889     |    0.80586 |   0.033096 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      48883 |     20.687 | 15.753     |     0.0714 |     -2.776 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref
index 08e5a50f85f..8f2a51ff3c0 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref
@@ -3221,13 +3221,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     152945 |     -237.9 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      50672 |     33.981 | 17.437     |    0.95579 |    0.54129 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      51246 |     18.278 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51027 |     69.023 | 18.952     |   -0.29178 |    -3.2135 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     152945 |    -44.956 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     115285 |     3.5033 | 0.85078    |   -0.09351 |    -1.0609 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     152946 |     -257.4 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      50673 |     34.089 | 18.848     |    0.79103 |   0.070905 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      51246 |     18.163 | 4.6301     |    -111.25 |    -1599.3 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
index 2acc978fa53..9b5849f706b 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
@@ -3223,13 +3223,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     152964 |    -243.88 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      50678 |     33.922 | 17.470     |    0.94545 |    0.52637 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      51253 |     18.742 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51033 |     68.145 | 20.047     |   -0.45754 |    -2.2422 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     152964 |    -46.116 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     115304 |     3.4699 | 0.84316    |  -0.067944 |    -1.0573 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     152965 |    -258.69 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      50679 |     34.032 | 18.888     |    0.78462 |   0.058566 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      51253 |     18.651 | 6.1959     |    -43.029 |    -459.75 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.detdesc
index da1ccfc3657..e53b7b95d98 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.detdesc
@@ -3293,13 +3293,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     153077 |    -729.96 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      50724 |     43.769 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      51280 |     -11.93 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51073 |     115.92 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     153077 |    -133.14 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     115388 |     2.3288 | 0.69742    |     7.1349 |      34.99 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     153078 |    -710.55 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      50725 |     45.703 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      51280 |    -14.944 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 8ca8a0d6168..e523b9085f2 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3293,13 +3293,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     153105 |    -774.35 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      50732 |     44.428 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      51292 |    -12.728 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51081 |     117.23 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     153105 |    -141.09 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     115419 |     2.3141 | 0.68972    |       7.43 |     37.525 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     153106 |    -783.99 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      50733 |     46.362 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      51292 |    -15.405 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-opt
index a116d01c304..458acdda633 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-opt
@@ -3223,13 +3223,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     152953 |    -236.12 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      50673 |     34.028 | 17.370     |    0.98865 |    0.57899 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      51251 |     17.942 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51029 |     68.947 | 18.984     |   -0.18024 |    -3.7143 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     152953 |    -44.593 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     115308 |     3.4558 | 0.84552    |  -0.029469 |    -1.0882 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     152954 |    -255.81 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      50674 |     34.142 | 18.796     |    0.81558 |   0.094335 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      51251 |     17.981 | 4.5731     |    -112.51 |    -1659.1 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref
index 0b7d5298143..b2b5400ce75 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref
@@ -2394,13 +2394,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |         96 |   0.020833 | 1.0431     |   -0.22053 |   0.054391 |
  | pullz                                         | "pull z"                                      |        382 |   0.066754 | 1.1270     |  -0.073487 |     1.3753 |
  | pullz_Monitoring                              | "pull z"                                      |         96 |   0.088542 | 0.97226    |  -0.068176 |  -0.089507 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     181648 |    -204.33 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60228 |     29.401 | 28.838     |    0.17543 |    -1.9521 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      60678 |     62.455 | 9.5885     |     7.5519 |    -63.846 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      60742 |    -19.269 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     181648 |    -41.683 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     134226 |     5.5437 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     181650 |    -154.57 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60230 |     29.582 | 27.432     |    0.16724 |    -1.8648 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      60678 |      61.56 | 11.649     |     2.9886 |    -22.948 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.armv8.1_a
index de3eac0f4da..0e829a7dcb7 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.armv8.1_a
@@ -2394,13 +2394,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |         96 |   0.015625 | 1.0332     |   -0.26762 |   0.024117 |
  | pullz                                         | "pull z"                                      |        382 |   0.068063 | 1.1257     |  -0.074029 |     1.3908 |
  | pullz_Monitoring                              | "pull z"                                      |         96 |   0.088542 | 0.97226    |  -0.068176 |  -0.089507 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     181629 |    -206.23 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60224 |     29.302 | 28.826     |     0.1818 |    -1.9509 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      60671 |     62.022 | 11.294     |     2.9919 |    -24.361 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      60734 |    -19.587 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     181629 |    -42.087 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     134224 |     5.5541 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     181631 |    -163.88 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60226 |     29.565 | 27.403     |    0.16812 |    -1.8632 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      60671 |     61.049 | 12.980     |     1.2628 |    -10.998 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.detdesc
index b28d765cc8d..2a85dfb0110 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.detdesc
@@ -2441,13 +2441,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |         96 |  -0.010417 | 0.99995    |   -0.16474 |   -0.15143 |
  | pullz                                         | "pull z"                                      |        381 |   0.079396 | 1.1438     |  -0.030288 |     1.2695 |
  | pullz_Monitoring                              | "pull z"                                      |         96 |   0.057292 | 1.0139     |    0.05861 | -0.0012131 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     181305 |     -973.4 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60131 |     61.946 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      60555 |     253.11 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      60619 |     158.33 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     181305 |    -164.06 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     133910 |     2.7281 | 1.2652     |     1.5977 |  -0.021717 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     181307 |    -887.24 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60133 |     81.857 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      60555 |     204.81 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 1c6c13773fa..267377a2ec0 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -2441,13 +2441,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |         96 |  0.0052083 | 0.98688    |   -0.21464 |   -0.20009 |
  | pullz                                         | "pull z"                                      |        381 |   0.063648 | 1.1344     |  -0.068682 |     1.2763 |
  | pullz_Monitoring                              | "pull z"                                      |         96 |    0.10417 | 1.0204     |  -0.058535 |   -0.12991 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     181260 |    -1619.3 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60120 |      62.04 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      60539 |     304.17 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      60601 |      158.2 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     181260 |    -275.07 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     133918 |     2.6231 | 1.2064     |     1.9966 |     1.1274 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     181262 |    -1228.7 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60122 |     82.056 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      60539 |     229.04 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-opt
index cb38742f47b..51db81bbdaa 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_mcchecking.ref.x86_64_v3-opt
@@ -2394,13 +2394,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |         96 |   0.036458 | 0.99411    |   -0.10775 |   -0.12318 |
  | pullz                                         | "pull z"                                      |        385 |   0.053896 | 1.1378     |   -0.16571 |     1.3417 |
  | pullz_Monitoring                              | "pull z"                                      |         96 |    0.13021 | 1.0071     |  -0.030253 |   -0.24483 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     181581 |    -185.32 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60210 |     28.974 | 28.542     |    0.19792 |    -1.9381 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      60655 |     62.725 | 8.1480     |     15.285 |    -143.85 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      60716 |    -23.285 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     181581 |    -37.951 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     134214 |     5.4088 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     181583 |    -140.45 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60212 |     29.233 | 27.179     |    0.18388 |    -1.8546 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      60655 |     61.864 | 10.327     |     5.8286 |    -45.018 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref
index 3506464a987..5723aae8262 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref
@@ -1930,13 +1930,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |        393 |    0.11573 | 1.4863     |  -0.097196 |   -0.11531 |
  | pullz                                         | "pull z"                                      |        704 |   0.067472 | 2.3924     |   0.018807 |    -0.9073 |
  | pullz_Monitoring                              | "pull z"                                      |        393 |   0.048982 | 2.3803     |  -0.015526 |   -0.93153 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     185808 |     260.61 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60850 |     962.86 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      62349 |      141.7 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      62609 |      53.38 | 28.738     |   -0.24478 |    -1.5483 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     185808 |     47.011 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     169480 |      3.263 | 1.0120     |   -0.88995 |    -1.8375 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     185808 |     361.82 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60850 |     383.92 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      62349 |     160.85 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.armv8.1_a
index dcb1425b1e7..ddcacb0c284 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.armv8.1_a
@@ -1929,13 +1929,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |        393 |    0.11573 | 1.4863     |  -0.097196 |   -0.11531 |
  | pullz                                         | "pull z"                                      |        704 |   0.067472 | 2.3924     |   0.018807 |    -0.9073 |
  | pullz_Monitoring                              | "pull z"                                      |        393 |   0.048982 | 2.3803     |  -0.015526 |   -0.93153 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     185823 |     261.54 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60849 |     996.49 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      62358 |     141.47 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      62616 |     53.388 | 28.781     |   -0.24599 |    -1.5484 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     185823 |     47.169 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     169495 |     3.2826 | 1.0170     |   -0.91668 |     -1.766 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     185823 |     363.27 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60849 |      387.2 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      62358 |     160.54 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.detdesc
index 9e5f0906242..dad56dbb271 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.detdesc
@@ -1880,13 +1880,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |        364 |    0.19085 | 2.0009     |  -0.038665 |   -0.54155 |
  | pullz                                         | "pull z"                                      |        650 |   0.039231 | 2.4225     |  0.0097773 |   -0.84946 |
  | pullz_Monitoring                              | "pull z"                                      |        364 |   0.098901 | 2.4736     |    -0.1324 |    -0.8561 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      63194 |     45.624 | 67.866     |    -1.2282 |    -9.9197 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      21523 |    -5.3787 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      19588 |     293.49 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      22083 |     36.296 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      63194 |     10.139 | 15.466     |   -0.39024 |    -5.5792 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      53267 |     2.9242 | 0.49415    |     1.9248 |     2.7264 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      63194 |     6.3399 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      21523 |    -227.82 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      19588 |     516.09 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-detdesc-opt
index fa42e27d161..a3e82555d28 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-detdesc-opt
@@ -1884,13 +1884,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |        366 |    0.14335 | 2.0378     |   -0.10967 |   -0.44481 |
  | pullz                                         | "pull z"                                      |        647 |  0.0081144 | 2.4023     |   0.022805 |   -0.80024 |
  | pullz_Monitoring                              | "pull z"                                      |        366 |   0.095628 | 2.4595     |   -0.13551 |   -0.81936 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      63186 |     45.472 | 68.042     |    -1.1995 |    -9.7959 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      21515 |    -5.7782 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      19587 |     291.65 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      22084 |     36.163 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      63186 |     10.116 | 15.502     |   -0.37721 |    -5.5384 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      53249 |     2.9325 | 0.49869    |     1.9525 |     2.7108 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      63186 |     5.9043 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      21515 |    -240.31 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      19587 |     509.95 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-opt
index d290e6fb22c..d5ada9a5784 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_without_UT_with_monitoring_2022.ref.x86_64_v3-opt
@@ -1931,13 +1931,14 @@ vertex_resolution_Moore_TBLV           INFO 1D histograms in directory "vertex_r
  | pully_Monitoring                              | "pull y"                                      |        393 |    0.12372 | 1.4555     |   -0.11041 |   -0.11641 |
  | pullz                                         | "pull z"                                      |        705 |   0.082624 | 2.4003     | 0.00095623 |   -0.89114 |
  | pullz_Monitoring                              | "pull z"                                      |        393 |    0.11387 | 2.3576     |  -0.053591 |   -0.88771 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     185908 |        261 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      60876 |     895.55 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      62386 |     141.45 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      62646 |     53.681 | 28.588     |   -0.25014 |    -1.5496 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     185908 |     47.019 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     169578 |     3.2693 | 1.0148     |    -0.9208 |    -1.8178 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     185908 |     363.65 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      60876 |     370.13 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      62386 |     160.48 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref
index 51c6df3f109..ffa1c4d5060 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref
@@ -3207,13 +3207,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     155254 |     356.81 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      51440 |     880.95 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      52017 |     95.138 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51797 |     -208.6 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     155254 |     68.614 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     117799 |     3.5607 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     155254 |     356.81 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      51440 |     178.95 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      52017 |      83.31 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
index 82e7b94d5eb..882d6d90ed5 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
@@ -3209,13 +3209,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     155295 |     367.97 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      51453 |     1056.6 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      52030 |     97.288 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51812 |    -216.26 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     155295 |     70.803 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     117840 |        3.6 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     155295 |     367.97 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      51453 |     182.36 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      52030 |     84.932 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.detdesc
index b00bd5f3884..fc734a78741 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.detdesc
@@ -3282,13 +3282,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     155590 |     269.99 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      51551 |     132.07 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      52135 |     117.26 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51904 |    -243.81 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     155590 |     50.674 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     118059 |     3.6454 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     155590 |     269.99 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      51551 |     75.676 | 32.812     |    -4.1102 |     9.4365 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      52135 |     98.413 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 95b6e22b172..00cd3e669c1 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -3282,13 +3282,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     155647 |     265.33 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      51565 |     138.91 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      52160 |     108.53 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51922 |     -218.8 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     155647 |     49.884 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     118130 |     3.6341 | 0.060269   |     2052.4 |     -78595 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     155647 |     265.33 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      51565 |     75.554 | 34.573     |    -3.8156 |     7.8261 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      52160 |      92.93 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
index 3a3cb5f9e5e..3681533ef53 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
@@ -3209,13 +3209,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |     155296 |      355.6 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      51451 |     1059.4 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      52034 |     94.612 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      51811 |    -231.18 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |     155296 |     68.412 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |     117855 |     3.5706 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |     155296 |      355.6 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      51451 |     178.14 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      52034 |     82.958 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
index 9867365102a..36541ad70bf 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
@@ -3605,13 +3605,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17723 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17723 |     1.3724 | 0.48344    |    0.52789 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95786 |      434.7 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31668 |     411.91 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32136 |     149.92 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31982 |    -161.92 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95786 |     84.375 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      77987 |      2.763 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95786 |      434.7 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31668 |     213.98 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32136 |     120.76 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
index 4088a82d6a6..9dc9d0c0490 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
@@ -3607,13 +3607,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17725 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.61 | 96.081     |   0.030167 |   -0.99159 |
  | trackType                                     | "track type"                                  |      17725 |     1.3724 | 0.48343    |    0.52808 |    -1.7211 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95827 |     438.12 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31682 |     416.37 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32149 |     157.32 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31996 |    -180.82 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95827 |     85.113 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78028 |     2.8787 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95827 |     438.12 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31682 |     215.81 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32149 |     124.91 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.detdesc b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.detdesc
index 5fb18149fc7..3d8c27385af 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.detdesc
@@ -3716,13 +3716,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17631 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     198.82 | 94.993     |  0.0052558 |     -1.016 |
  | trackType                                     | "track type"                                  |      17631 |     1.3701 | 0.48283    |    0.53813 |    -1.7104 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96054 |     264.42 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31757 |     86.608 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32226 |    -171.05 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32071 |    -326.07 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96054 |     49.334 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78119 |     3.3455 | 0.11598    |    -255.23 |    -6653.4 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96054 |     264.42 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31757 |     72.281 | 19.976     |    -6.7474 |     30.814 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32226 |     -607.2 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
index a60ba176ab2..db1f2a73936 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
@@ -3716,13 +3716,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17683 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.16 | 95.185     |   0.021728 |    -1.0319 |
  | trackType                                     | "track type"                                  |      17683 |     1.3699 | 0.48278    |    0.53895 |    -1.7095 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      96112 |     258.55 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31775 |     88.813 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32250 |    -269.84 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      32087 |    -250.83 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      96112 |     48.385 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78213 |     3.3276 | 0.19127    |    -55.333 |     -914.1 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      96112 |     258.55 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31775 |     72.367 | 21.665     |    -6.0113 |     24.264 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32250 |     5121.4 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
index 4c5f5434fdd..142bb382428 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
@@ -3607,13 +3607,14 @@ VeloTrackMonitor                       INFO 1D histograms in directory "VeloTrac
  | history                                       | "track history"                               |      17769 |         36 | 0.0000     |          0 |          0 |
  | nTracks                                       | "# tracks"                                    |         89 |     199.83 | 96.058     |   0.037622 |   -0.97538 |
  | trackType                                     | "track type"                                  |      17769 |     1.3724 | 0.48344    |    0.52792 |    -1.7213 |
-FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 10
+FTTrackMonitor                         INFO 1D profile histograms in directory "FTTrackMonitor" : 11
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | RMSResidualModules                            | "Mean Residual (rms-unbiased) in each module" |      95838 |     413.02 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT1                          | "Residual (rms-unbiased) in FTStation T1"     |      31685 |     396.58 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT2                          | "Residual (rms-unbiased) in FTStation T2"     |      32156 |     152.96 | 0.0000     |          0 |          0 |
  | RMSResidualModulesT3                          | "Residual (rms-unbiased) in FTStation T3"     |      31997 |    -207.66 | 0.0000     |          0 |          0 |
  | RMSResidualQuarters                           | "Mean Residual (rms-unbiased) in each qua..." |      95838 |     80.225 | 0.0000     |          0 |          0 |
+ | TrackResidualPerEta                           | "Track residuals per eta"                     |      78064 |     2.9033 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModules                       | "Unbiased residual in each module"            |      95838 |     413.02 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT1                     | "Unbiased Residual in FTStation T1"           |      31685 |     208.52 | 0.0000     |          0 |          0 |
  | UnbiasedResidualModulesT2                     | "Unbiased Residual in FTStation T2"           |      32156 |     121.81 | 0.0000     |          0 |          0 |
-- 
GitLab


From 97c5ced06020c833684e454f8a811e7fd72f5eb8 Mon Sep 17 00:00:00 2001
From: Sebastien Ponce <sebastien.ponce@cern.ch>
Date: Wed, 5 Feb 2025 14:57:36 +0100
Subject: [PATCH 15/31] fixed order of input files in tests using
 mdf_input_and_conds

This order was dependent on "set" implementation in python, and changes when switching to LCG 106.
Now we sort the files to ensure consistency.
This may also fix some discrepancies between platforms
---
 Hlt/Moore/tests/options/mdf_input_and_conds.py | 2 +-
 1 file changed, 1 insertion(+), 1 deletion(-)

diff --git a/Hlt/Moore/tests/options/mdf_input_and_conds.py b/Hlt/Moore/tests/options/mdf_input_and_conds.py
index b8046fcc750..6536c6fc92b 100644
--- a/Hlt/Moore/tests/options/mdf_input_and_conds.py
+++ b/Hlt/Moore/tests/options/mdf_input_and_conds.py
@@ -11,6 +11,6 @@
 from Moore import options
 
 options.set_input_and_conds_from_testfiledb("expected_2024_min_bias_mdf")
-options.input_files = list(set(options.input_files))  # remove dups
+options.input_files = sorted(list(set(options.input_files)))  # remove dups
 options.evt_max = 1000
 options.event_store = "EvtStoreSvc"
-- 
GitLab


From 414c65979525c3b22d93abe5639871c7a9e41a4b Mon Sep 17 00:00:00 2001
From: Chris Jones <jonesc@hep.phy.cam.ac.uk>
Date: Thu, 6 Feb 2025 15:11:07 +0000
Subject: [PATCH 16/31] hlt2_pp_commissioning_data_production - Use fixed geom
 tag run3/2024.Q1.2-v00.00 instead of run3/trunk

---
 .../options/hlt2_pp_commissioning_data_production_options.yaml  | 2 +-
 1 file changed, 1 insertion(+), 1 deletion(-)

diff --git a/Hlt/Hlt2Conf/options/hlt2_pp_commissioning_data_production_options.yaml b/Hlt/Hlt2Conf/options/hlt2_pp_commissioning_data_production_options.yaml
index 6d8e3467e22..2691051ca08 100644
--- a/Hlt/Hlt2Conf/options/hlt2_pp_commissioning_data_production_options.yaml
+++ b/Hlt/Hlt2Conf/options/hlt2_pp_commissioning_data_production_options.yaml
@@ -2,7 +2,7 @@ data_type: Upgrade
 simulation: False
 dddb_tag: upgrade/master
 conddb_tag: upgrade/master
-geometry_version: run3/trunk
+geometry_version: run3/2024.Q1.2-v00.00
 conditions_version: master
 
 input_files:
-- 
GitLab


From 489994564bb7a61fe740aa58de7c03cf9f5e1cf3 Mon Sep 17 00:00:00 2001
From: Sebastien Ponce <sebastien.ponce@cern.ch>
Date: Fri, 7 Feb 2025 16:51:05 +0100
Subject: [PATCH 17/31] fixed documentation after move of code from HLT2Conf to
 RecoConf

---
 .../python/RecoConf/rdbuilder_thor.py         |  2 +-
 doc/selection/hlt2.rst                        | 24 +++++++++----------
 doc/tutorials/hlt2_line.rst                   |  2 +-
 doc/tutorials/thor_transition.rst             | 12 +++++-----
 4 files changed, 20 insertions(+), 20 deletions(-)

diff --git a/Hlt/RecoConf/python/RecoConf/rdbuilder_thor.py b/Hlt/RecoConf/python/RecoConf/rdbuilder_thor.py
index 2ab9a6ee97d..1eec2b47ea6 100644
--- a/Hlt/RecoConf/python/RecoConf/rdbuilder_thor.py
+++ b/Hlt/RecoConf/python/RecoConf/rdbuilder_thor.py
@@ -493,7 +493,7 @@ def make_rd_merged_pi0s(
 ####################################
 # V0 particles and alike           #
 ####################################
-# they are in principle defined in the Hlt2 standard_particles, however there is no way to tune IPCHI2 cuts on their children with the current ThOr framework.
+# they are in principle defined in the Reco standard_particles, however there is no way to tune IPCHI2 cuts on their children with the current ThOr framework.
 
 
 @configurable
diff --git a/doc/selection/hlt2.rst b/doc/selection/hlt2.rst
index 74f05c73170..3d2ebc89561 100644
--- a/doc/selection/hlt2.rst
+++ b/doc/selection/hlt2.rst
@@ -36,7 +36,7 @@ Particle filters
 Each filter takes a single container of particles as input. They all inherit
 their functionality from the ``Pr::Filter`` C++ algorithm.
 
-.. autofunction:: Hlt2Conf.algorithms_thor.ParticleFilter
+.. autofunction:: RecoConf.algorithms_thor.ParticleFilter
 
   An example configuration::
 
@@ -66,7 +66,7 @@ with a decay descriptor specifying the single-level decay hypothesis to
 reconstruct. They all inherit most of their functionality from the
 ``NBodyParticleCombiner`` C++ algorithm.
 
-.. autofunction:: Hlt2Conf.algorithms_thor.ParticleCombiner
+.. autofunction:: RecoConf.algorithms_thor.ParticleCombiner
 
   Depending on :math:`N`, different cut parameters are made available which
   permit selections on intermediate pre-fit combinations of size :math:`N - 1`,
@@ -146,12 +146,12 @@ their functionality from the ``FilterDesktop`` C++ algorithm.
 .. autofunction:: Hlt2Conf.algorithms.ParticleFilter
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleFilter`.
+  `RecoConf.algorithms_thor.ParticleFilter`.
 
 .. autofunction:: Hlt2Conf.algorithms.ParticleFilterWithPVs
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleFilter`.
+  `RecoConf.algorithms_thor.ParticleFilter`.
 
 .. autofunction:: Hlt2Conf.algorithms.ParticleFilterWithTMVA
 
@@ -165,41 +165,41 @@ inherit most of their functionality from the ``CombineParticles`` C++ algorithm.
 .. autofunction:: Hlt2Conf.algorithms.ParticleCombiner
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
 
 .. autofunction:: Hlt2Conf.algorithms.ParticleCombinerWithPVs
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
 
 .. autofunction:: Hlt2Conf.algorithms.NeutralParticleCombiner
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner` using ``"ParticleAdder"`` as the
+  `RecoConf.algorithms_thor.ParticleCombiner` using ``"ParticleAdder"`` as the
   value of the ``ParticleCombiner`` property.
 
 .. autofunction:: Hlt2Conf.algorithms.NeutralParticleCombinerWithPVs
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner` using ``"ParticleAdder"`` as the
+  `RecoConf.algorithms_thor.ParticleCombiner` using ``"ParticleAdder"`` as the
   value of the ``ParticleCombiner`` property.
 
 .. autofunction:: Hlt2Conf.algorithms.N3BodyCombiner
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
 
 .. autofunction:: Hlt2Conf.algorithms.N4BodyCombiner
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
 
 .. autofunction:: Hlt2Conf.algorithms.N3BodyCombinerWithPVs
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
 
 .. autofunction:: Hlt2Conf.algorithms.N4BodyCombinerWithPVs
 
   The equivalent ThOr-based function is
-  `Hlt2Conf.algorithms_thor.ParticleCombiner`.
+  `RecoConf.algorithms_thor.ParticleCombiner`.
diff --git a/doc/tutorials/hlt2_line.rst b/doc/tutorials/hlt2_line.rst
index 1833c065b34..d2f631675d1 100644
--- a/doc/tutorials/hlt2_line.rst
+++ b/doc/tutorials/hlt2_line.rst
@@ -390,7 +390,7 @@ define the cut expression here.
 
 The return value is the configured algorithm. This can be used as an 'input' to
 other algorithms as the framework knows how to extract the (single) output the
-`Hlt2Conf.algorithms_thor.ParticleFilter` algorithm produces.
+`RecoConf.algorithms_thor.ParticleFilter` algorithm produces.
 
 Define similar functions for the remaining particle filters, for kaons and for
 pions.
diff --git a/doc/tutorials/thor_transition.rst b/doc/tutorials/thor_transition.rst
index efd5fd2a723..10d32bc6ec2 100644
--- a/doc/tutorials/thor_transition.rst
+++ b/doc/tutorials/thor_transition.rst
@@ -40,7 +40,7 @@ We can express the same selection above using ThOr. It looks like this::
 
     import Functors as F
     from GaudiKernel.SystemOfUnits import MeV
-    from Hlt2Conf.algorithms_thor import ParticleFilter
+    from RecoConf.algorithms_thor import ParticleFilter
 
 
     def filter_protons(protons, pvs):
@@ -188,14 +188,14 @@ There are only two steps left.
 2. Change the filter algorithm to one which accepts ThOr functors.
 
 We'll tackle these in one step by importing the appropriate helpers from the
-``Hlt2Conf.algorithms_thor`` module:
+``RecoConf.algorithms_thor`` module:
 
 .. code-block:: python
     :emphasize-lines: 3, 11
 
     import Functors as F
     from GaudiKernel.SystemOfUnits import GeV
-    from Hlt2Conf.algorithms_thor import ParticleFilter
+    from RecoConf.algorithms_thor import ParticleFilter
 
 
     def filter_protons(particles, pvs, pt_min=0.5 * GeV, mipchi2_min=9, dllp_min=5):
@@ -420,7 +420,7 @@ With the hardest part complete, we now replace the ``require_all`` and
     import Functors as F
     from Functors.math import in_range
     from GaudiKernel.SystemOfUnits import MeV, mm
-    from Hlt2Conf.algorithms_thor import ParticleCombiner
+    from RecoConf.algorithms_thor import ParticleCombiner
 
 
     def make_lambdacs(protons,
@@ -552,7 +552,7 @@ Most HLT2 lines are written as the composition of fairly small, self-contained
 functions which each do one thing and return the result, such as a container of
 filtered protons.
 
-The algorithms from the ``Hlt2Conf.algorithms_thor`` module we've used in this
+The algorithms from the ``RecoConf.algorithms_thor`` module we've used in this
 tutorial, ``ParticleFilter`` and ``ParticleCombiner``, are compatible with the
 algorithms from the ``Hlt2Conf.algorithms module``. They can be mixed within an
 HLT2 line selection.
@@ -601,7 +601,7 @@ using the following steps:
       `make_pvs <RecoConf.reconstruction_objects.make_pvs>`.
 
 #. Change the selection algorithm to its ThOr equivalent. ThOr algorithms can be
-   imported from ``Hlt2Conf.algorithms_thor``. There is a ``require_all`` helper
+   imported from ``RecoConf.algorithms_thor``. There is a ``require_all`` helper
    function as well (which you can import from ``Functors``) if you use that.
 
    * For 3-or-more-body combiners, consider using sub-combination cuts to improve
-- 
GitLab


From 91b01def47463c1c8d45f1e15d2fd84f1cd943db Mon Sep 17 00:00:00 2001
From: Marco Clemencic <marco.clemencic@cern.ch>
Date: Fri, 7 Feb 2025 16:51:12 +0100
Subject: [PATCH 18/31] Use RecoConf instead of Hlt2Conf where needed

---
 .../python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py    | 4 ++--
 .../python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py      | 6 +++---
 .../python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py | 2 +-
 .../Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py       | 2 +-
 .../python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py   | 2 +-
 5 files changed, 8 insertions(+), 8 deletions(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
index cb7ec60b68b..737a13ab9d7 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Jpsi_trackeff.py
@@ -18,7 +18,6 @@ Definition of SMOG2 tracking efficiency HLT2 lines - following pp tracking effic
 import Functors as F
 from Functors.math import in_range
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm
-from Hlt2Conf.algorithms_thor import ParticleCombiner, ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import (
     bpv_in_smog2,
     make_smog2_prefilters,
@@ -26,14 +25,15 @@ from Hlt2Conf.lines.ift.builders.smog2_builders import (
 )
 from Hlt2Conf.lines.trackeff.DiMuonTrackEfficiency import make_LongFilter
 from Hlt2Conf.probe_muons import make_seed_muons, make_velomuon_muons
-from Hlt2Conf.standard_particles import make_ismuon_long_muon
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
 from PyConf import configurable
 from PyConf.Algorithms import MuonProbeToLongMatcher
+from RecoConf.algorithms_thor import ParticleCombiner, ParticleFilter
 from RecoConf.event_filters import require_gec
 from RecoConf.muonid import make_muon_hits
 from RecoConf.reconstruction_objects import make_pvs
+from RecoConf.standard_particles import make_ismuon_long_muon
 
 all_lines = {}
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
index d3608cc96d5..a460e534a88 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/SMOG2_Ks_trackeff.py
@@ -12,18 +12,18 @@
 import Functors as F
 from Functors.math import in_range
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm
-from Hlt2Conf.algorithms_thor import ParticleCombiner, ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import (
     bpv_in_smog2,
     make_smog2_prefilters,
 )
 from Hlt2Conf.probe_muons import make_velo_muons
-from Hlt2Conf.standard_particles import make_long_pions
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
 from PyConf import configurable
+from RecoConf.algorithms_thor import ParticleCombiner, ParticleFilter
 from RecoConf.event_filters import require_gec
 from RecoConf.reconstruction_objects import make_pvs
+from RecoConf.standard_particles import make_long_pions
 
 all_lines = {}
 
@@ -86,7 +86,7 @@ def make_kshort_pi_muplus_specific_charge(
     )
 
 
-from Hlt2Conf.algorithms_thor import ParticleContainersMerger
+from RecoConf.algorithms_thor import ParticleContainersMerger
 
 
 def make_kshort_pi_muplus(pions, muons, pvs, **kwargs):
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
index 06b01712e94..805755005be 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_charm.py
@@ -10,7 +10,6 @@
 ###############################################################################
 import Functors as F
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm, picosecond
-from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_charm_builders import (
     make_charm2hadrons,
@@ -22,6 +21,7 @@ from Hlt2Conf.lines.ift.builders.smog2_charm_builders import (
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
 from PyConf import configurable
+from RecoConf.algorithms_thor import ParticleFilter
 from RecoConf.event_filters import require_gec
 from RecoConf.reconstruction_objects import make_pvs
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
index a07057d20fe..23cb82d2b57 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_omegas.py
@@ -16,7 +16,6 @@ from __future__ import absolute_import
 
 import Functors as F
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm, ns
-from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
     make_smog2_omega2L0K_lll_line,
@@ -24,6 +23,7 @@ from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
 from PyConf import configurable
+from RecoConf.algorithms_thor import ParticleFilter
 from RecoConf.event_filters import require_gec
 from RecoConf.reconstruction_objects import make_pvs
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
index c85ccd3b32c..b3b60c3f87a 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/iftPbPb/hlt2_ift_smog2Pb_xis.py
@@ -16,7 +16,6 @@ from __future__ import absolute_import
 
 import Functors as F
 from GaudiKernel.SystemOfUnits import GeV, MeV, mm, ns
-from Hlt2Conf.algorithms_thor import ParticleFilter
 from Hlt2Conf.lines.ift.builders.smog2_builders import make_smog2_prefilters
 from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
     make_smog2_xi2L0pi_lll_line,
@@ -24,6 +23,7 @@ from Hlt2Conf.lines.ift.builders.smog2_chargedPID_builders import (
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
 from PyConf import configurable
+from RecoConf.algorithms_thor import ParticleFilter
 from RecoConf.event_filters import require_gec
 from RecoConf.reconstruction_objects import make_pvs
 
-- 
GitLab


From 64ffa4512592a1a3bbc2141f05176f39e3571ee2 Mon Sep 17 00:00:00 2001
From: Sebastien Ponce <sebastien.ponce@cern.ch>
Date: Sat, 8 Feb 2025 09:27:41 +0000
Subject: [PATCH 19/31] tiny manual ref fix for
 allen_gaudi_downstream_with_mcchecking (was missing in...

---
 ...allen_gaudi_downstream_with_mcchecking.ref | 42 +++++++++----------
 1 file changed, 21 insertions(+), 21 deletions(-)

diff --git a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
index 015463e2a3a..a1872b29640 100644
--- a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
@@ -1,6 +1,6 @@
 DownstreamTrackChecker_b5b8b4e9        INFO Results
-DownstreamTrackChecker_b5b8b4e9        INFO **** Downstream                      6930 tracks including            519 ghosts [ 7.49 %], Event average  5.88 % ****
-DownstreamTrackChecker_b5b8b4e9        INFO   01_UT+T                       :    4495 from    66730 [  6.74 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.50 %
+DownstreamTrackChecker_b5b8b4e9        INFO **** Downstream                      6931 tracks including            519 ghosts [ 7.49 %], Event average  5.88 % ****
+DownstreamTrackChecker_b5b8b4e9        INFO   01_UT+T                       :    4496 from    66730 [  6.74 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.50 %
 DownstreamTrackChecker_b5b8b4e9        INFO   02_UT+T_P>5GeV                :    3114 from    40636 [  7.66 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.49 %
 DownstreamTrackChecker_b5b8b4e9        INFO   03_UT+T_strange               :    1671 from     7004 [ 23.86 %]      0 clones [ 0.00 %], purity: 99.50 %, hitEff: 96.90 %
 DownstreamTrackChecker_b5b8b4e9        INFO   04_UT+T_strange_P>5GeV        :    1223 from     3436 [ 35.59 %]      0 clones [ 0.00 %], purity: 99.51 %, hitEff: 96.84 %
@@ -30,8 +30,8 @@ PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |*"Non-unique UT clusters in event"               |      1000 |          0 |( 0.000000 +- 0.000000)% |
 PrTrackAssociator_74593611             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |      6930 |       6411 |( 92.51082 +- 0.3161890)% |
- | "MC particles per track"                        |      6411 |       6411 |     1.0000 |
+ |*"Efficiency"                                    |      6931 |       6412 |( 92.51190 +- 0.3161452)% |
+ | "MC particles per track"                        |      6412 |       6412 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |      1000 |    2178998 |     2179.0 |
@@ -47,10 +47,10 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  | "Nb of Produced Tracks"                         |      1000 |     240661 |     240.66 |
 downstream_consolidate_tracks          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_downstream_tracks"                           |      1000 |       6930 |     6.9300 |
+ | "n_downstream_tracks"                           |      1000 |       6931 |     6.9310 |
 fromV3TrackV1Track_6f234e16            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |      1000 |       6930 |     6.9300 |
+ | "Nb of Produced Tracks"                         |      1000 |       6931 |     6.9310 |
 matching_consolidate_tracks            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_matching"                        |      1000 |      19482 |     19.482 |
@@ -59,7 +59,7 @@ pv_beamline_cleanup                    INFO Number of counters : 1
  | "n_PVs"                                         |      1000 |       5108 |     5.1080 |
 scifi_consolidate_seeds                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_seed_tracks"                                 |      1000 |      52244 |     52.244 |
+ | "n_seed_tracks"                                 |      1000 |      52245 |     52.245 |
 scifi_consolidate_tracks               INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_forward"                         |      1000 |      29340 |     29.340 |
@@ -83,19 +83,19 @@ TransposeRawBanks_e9adf917             INFO 1D histograms in directory "Transpos
  | UT                                            | "UT"                                          |     216000 |     69.797 | 61.476     |     2.6463 |     11.635 |
 downstream_consolidate_tracks          INFO 1D histograms in directory "downstream_consolidate_tracks" : 4
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | downstream_track_eta                          | "#eta"                                        |       6930 |     3.5898 | 0.69734    |   -0.21548 |   -0.79249 |
- | downstream_track_nhits                        | "N. hits / track"                             |       6930 |     15.989 | 0.67737    |    -0.9687 |   -0.28613 |
- | downstream_track_phi                          | "#phi"                                        |       6930 |   0.033911 | 1.7759     |  -0.012761 |      -1.21 |
- | n_downstream_tracks_event                     | "n_downstream_tracks_event"                   |       1000 |       6.93 | 4.5026     |    0.77589 |    0.59233 |
+ | downstream_track_eta                          | "#eta"                                        |       6931 |     3.5897 | 0.69747    |    -0.2155 |   -0.79282 |
+ | downstream_track_nhits                        | "N. hits / track"                             |       6931 |     15.989 | 0.67755    |   -0.96833 |   -0.28738 |
+ | downstream_track_phi                          | "#phi"                                        |       6931 |    0.03387 | 1.7758     |  -0.012693 |    -1.2098 |
+ | n_downstream_tracks_event                     | "n_downstream_tracks_event"                   |       1000 |      6.931 | 4.5034     |    0.77523 |    0.58956 |
 downstream_make_particles              INFO 1D histograms in directory "downstream_make_particles" : 4
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | number_of_trks                                | "NTrks"                                       |        999 |     7.4219 | 4.4976     |    0.77886 |    0.60713 |
- | trk_eta                                       | "etaTrk"                                      |       6915 |     3.5894 | 0.69747    |   -0.21462 |   -0.79279 |
- | trk_phi                                       | "phiTrk"                                      |       6915 |   0.034841 | 1.7686     |  -0.013769 |    -1.2352 |
- | trk_pt                                        | "ptTrk"                                       |       6915 |     544.09 | 504.11     |     4.1605 |     38.113 |
+ | number_of_trks                                | "NTrks"                                       |        999 |     7.4229 | 4.4984     |     0.7782 |    0.60434 |
+ | trk_eta                                       | "etaTrk"                                      |       6916 |     3.5892 | 0.69761    |   -0.21463 |   -0.79312 |
+ | trk_phi                                       | "phiTrk"                                      |       6916 |   0.034785 | 1.7685     |  -0.013676 |     -1.235 |
+ | trk_pt                                        | "ptTrk"                                       |       6916 |     544.14 | 504.09     |       4.16 |     38.109 |
 is_muon_c92a16c2                       INFO 1D histograms in directory "is_muon_c92a16c2" : 3
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_muons                                       | "# muons"                                     |       6930 |    0.12193 | 0.32721    |     2.3109 |       3.34 |
+ | n_muons                                       | "# muons"                                     |       6931 |    0.12192 | 0.32719    |     2.3111 |     3.3412 |
  | pv_x                                          | "pv_x"                                        |        550 |          2 | 0.0000     |          0 |          0 |
  | pv_y                                          | "pv_y"                                        |        845 |     462.21 | 278.88     |    0.92751 |    0.51044 |
 matching_consolidate_tracks            INFO 1D histograms in directory "matching_consolidate_tracks" : 6
@@ -115,11 +115,11 @@ pv_beamline_cleanup                    INFO 1D histograms in directory "pv_beaml
  | pv_z                                          | "pv_z"                                        |       5102 |    0.46319 | 59.430     |   -0.03759 |   -0.10541 |
 scifi_consolidate_seeds                INFO 1D histograms in directory "scifi_consolidate_seeds" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     52.244 | 36.680     |      1.574 |     3.8941 |
- | scifi_track_eta                               | "#eta"                                        |      52244 |     2.5964 | 0.69769    |    0.61508 |    0.11706 |
- | scifi_track_nhits                             | "N. hits / track"                             |      52244 |     11.328 | 0.77516    |    -0.6419 |    -1.0584 |
- | scifi_track_phi                               | "#phi"                                        |      52244 |  0.0085359 | 2.0693     | -0.0052102 |   -0.96261 |
- | scifi_track_qop                               | "q/p"                                         |      52244 | -1.614e-06 | 0.00017317 | -0.0030091 |    -1.0081 |
+ | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     52.245 | 36.681     |     1.5739 |     3.8932 |
+ | scifi_track_eta                               | "#eta"                                        |      52245 |     2.5964 | 0.69770    |    0.61505 |    0.11701 |
+ | scifi_track_nhits                             | "N. hits / track"                             |      52245 |     11.328 | 0.77518    |   -0.64185 |    -1.0585 |
+ | scifi_track_phi                               | "#phi"                                        |      52245 |  0.0085334 | 2.0693     | -0.0052066 |   -0.96257 |
+ | scifi_track_qop                               | "q/p"                                         |      52245 |-1.6098e-06 | 0.00017317 | -0.0030434 |    -1.0081 |
 scifi_consolidate_tracks               INFO 1D histograms in directory "scifi_consolidate_tracks" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | long_track_forward_eta                        | "#eta"                                        |      29340 |     4.3666 | 0.54181    |  -0.021942 |   -0.36568 |
-- 
GitLab


From 123b145e360cedf66341fbad7856bf5bf27f2c09 Mon Sep 17 00:00:00 2001
From: Yiming Liu <yiming.liu@cern.ch>
Date: Sat, 8 Feb 2025 12:49:15 +0000
Subject: [PATCH 20/31] Summary of B2CC MRs Since October 2024

---
 .../python/Hlt2Conf/lines/b_to_charmonia/b_to_jpsix.py     | 4 ++--
 .../lines/b_to_charmonia/builders/basic_builder.py         | 7 +++++++
 .../python/Hlt2Conf/lines/b_to_charmonia/hlt2_b2cc.py      | 2 +-
 3 files changed, 10 insertions(+), 3 deletions(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/b_to_jpsix.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/b_to_jpsix.py
index 8ec793410f0..42345998816 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/b_to_jpsix.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/b_to_jpsix.py
@@ -477,7 +477,7 @@ def make_BsToJpsiKstar_line(
         vtx_m_min=vtx_m_min_jpsi,
         vtx_m_max=vtx_m_max_jpsi,
     )
-    kstar = basic_builder.make_selected_kstar2kpi_widerange()
+    kstar = basic_builder.make_selected_kstar2kpi_widerange(pid_pi=-5.0, pid_k=5.0)
 
     if process == "spruce":
         kstar = basic_builder.make_selected_kstar2kpi_widerange(
@@ -1055,7 +1055,7 @@ def make_BcToJpsimumuPiplus_line(process):
     )
     jpsi = basic_builder.make_selected_jpsi2mumu()
     pip = basic_builder.make_pions(pid=-1)
-    bc2jpsipip = make_Bd2JpsimumuKshort_detached(
+    bc2jpsipip = make_Bc2Jpsipip(
         particles=[jpsi, pip],
         descriptor="[B_c+ -> J/psi(1S) pi+]cc",
         lifetime=0.2 * picosecond,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/builders/basic_builder.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/builders/basic_builder.py
index 933c644ef43..d6e460bd49b 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/builders/basic_builder.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/builders/basic_builder.py
@@ -54,6 +54,7 @@ def make_selected_particles(
     pt_with_brem_min=None,
     max_eta=None,
     pid=None,
+    max_trghostprob=None,
     isMuon=None,
     nPVs=None,
 ):
@@ -70,6 +71,8 @@ def make_selected_particles(
         code &= F.ETA < max_eta
     if nPVs is not None:
         code &= F.SIZE(make_pvs()) < nPVs
+    if max_trghostprob is not None:
+        code &= F.GHOSTPROB < max_trghostprob
 
     return ParticleFilter(make_particles(), F.FILTER(code))
 
@@ -139,6 +142,7 @@ def make_electrons(
     pid=0,
     pt_with_brem=250 * MeV,
     mipchi2_min=0,
+    max_trghostprob=None,
     **decay_arguments,
 ):
     """Return electrons filtered by thresholds common to B2CC decay product Jpsi->ee selections."""
@@ -148,6 +152,7 @@ def make_electrons(
         pt_with_brem_min=pt_with_brem,
         mipchi2_min=mipchi2_min,
         pid=(F.PID_E > pid),
+        max_trghostprob=max_trghostprob,
         **decay_arguments,
     )
 
@@ -535,6 +540,7 @@ def make_selected_jpsi2ee(
     max_vchi2pdof=15.0,
     pt=1000.0 * MeV,
     electron_particles=make_long_and_upstream_electrons_no_brem,
+    max_trghostprob=None,
     max_docachi2=30.0,
     pt_e=750 * MeV,
     max_pt_e1e2=1000 * MeV,
@@ -550,6 +556,7 @@ def make_selected_jpsi2ee(
         pid=pid_e,
         pt_with_brem=pt_e,
         mipchi2_min=mipchi2_e,
+        max_trghostprob=max_trghostprob,
     )
 
     detached_dielectron_with_brem = (
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/hlt2_b2cc.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/hlt2_b2cc.py
index 4675f2dcdef..5792c4b2e64 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/hlt2_b2cc.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_charmonia/hlt2_b2cc.py
@@ -188,7 +188,7 @@ def BsToJpsif0ws_line(name="Hlt2B2CC_BsToJpsif0ws", prescale=1, persistreco=Fals
 
 @register_line_builder(all_lines)
 def BsToJpsif0Prescaled_line(
-    name="Hlt2B2CC_BsToJpsif0Prescaled", prescale=0.03, persistreco=False
+    name="Hlt2B2CC_BsToJpsif0Prescaled", prescale=0.01, persistreco=False
 ):
     line_alg = b_to_jpsix.make_BsToJpsif0Prescaled_line(process=PROCESS)
     return Hlt2Line(
-- 
GitLab


From 492fc32aae16c52baa90bd376ca5a70f95cd8994 Mon Sep 17 00:00:00 2001
From: Marco Clemencic <marco.clemencic@cern.ch>
Date: Mon, 10 Feb 2025 09:25:41 +0100
Subject: [PATCH 21/31] Update refs for x86_64_v2-el9-gcc13-opt

---
 ...allen_gaudi_downstream_with_mcchecking.ref | 42 +++++++++----------
 1 file changed, 21 insertions(+), 21 deletions(-)

diff --git a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
index 015463e2a3a..a1872b29640 100644
--- a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref
@@ -1,6 +1,6 @@
 DownstreamTrackChecker_b5b8b4e9        INFO Results
-DownstreamTrackChecker_b5b8b4e9        INFO **** Downstream                      6930 tracks including            519 ghosts [ 7.49 %], Event average  5.88 % ****
-DownstreamTrackChecker_b5b8b4e9        INFO   01_UT+T                       :    4495 from    66730 [  6.74 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.50 %
+DownstreamTrackChecker_b5b8b4e9        INFO **** Downstream                      6931 tracks including            519 ghosts [ 7.49 %], Event average  5.88 % ****
+DownstreamTrackChecker_b5b8b4e9        INFO   01_UT+T                       :    4496 from    66730 [  6.74 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.50 %
 DownstreamTrackChecker_b5b8b4e9        INFO   02_UT+T_P>5GeV                :    3114 from    40636 [  7.66 %]      0 clones [ 0.00 %], purity: 99.42 %, hitEff: 96.49 %
 DownstreamTrackChecker_b5b8b4e9        INFO   03_UT+T_strange               :    1671 from     7004 [ 23.86 %]      0 clones [ 0.00 %], purity: 99.50 %, hitEff: 96.90 %
 DownstreamTrackChecker_b5b8b4e9        INFO   04_UT+T_strange_P>5GeV        :    1223 from     3436 [ 35.59 %]      0 clones [ 0.00 %], purity: 99.51 %, hitEff: 96.84 %
@@ -30,8 +30,8 @@ PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |*"Non-unique UT clusters in event"               |      1000 |          0 |( 0.000000 +- 0.000000)% |
 PrTrackAssociator_74593611             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |      6930 |       6411 |( 92.51082 +- 0.3161890)% |
- | "MC particles per track"                        |      6411 |       6411 |     1.0000 |
+ |*"Efficiency"                                    |      6931 |       6412 |( 92.51190 +- 0.3161452)% |
+ | "MC particles per track"                        |      6412 |       6412 |     1.0000 |
 PrVPHitsToVPLightClusters_8cd36c45     INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Clusters"                       |      1000 |    2178998 |     2179.0 |
@@ -47,10 +47,10 @@ VeloRetinaClusterTrackingSIMD_66...    INFO Number of counters : 2
  | "Nb of Produced Tracks"                         |      1000 |     240661 |     240.66 |
 downstream_consolidate_tracks          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_downstream_tracks"                           |      1000 |       6930 |     6.9300 |
+ | "n_downstream_tracks"                           |      1000 |       6931 |     6.9310 |
 fromV3TrackV1Track_6f234e16            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Tracks"                         |      1000 |       6930 |     6.9300 |
+ | "Nb of Produced Tracks"                         |      1000 |       6931 |     6.9310 |
 matching_consolidate_tracks            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_matching"                        |      1000 |      19482 |     19.482 |
@@ -59,7 +59,7 @@ pv_beamline_cleanup                    INFO Number of counters : 1
  | "n_PVs"                                         |      1000 |       5108 |     5.1080 |
 scifi_consolidate_seeds                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_seed_tracks"                                 |      1000 |      52244 |     52.244 |
+ | "n_seed_tracks"                                 |      1000 |      52245 |     52.245 |
 scifi_consolidate_tracks               INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_forward"                         |      1000 |      29340 |     29.340 |
@@ -83,19 +83,19 @@ TransposeRawBanks_e9adf917             INFO 1D histograms in directory "Transpos
  | UT                                            | "UT"                                          |     216000 |     69.797 | 61.476     |     2.6463 |     11.635 |
 downstream_consolidate_tracks          INFO 1D histograms in directory "downstream_consolidate_tracks" : 4
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | downstream_track_eta                          | "#eta"                                        |       6930 |     3.5898 | 0.69734    |   -0.21548 |   -0.79249 |
- | downstream_track_nhits                        | "N. hits / track"                             |       6930 |     15.989 | 0.67737    |    -0.9687 |   -0.28613 |
- | downstream_track_phi                          | "#phi"                                        |       6930 |   0.033911 | 1.7759     |  -0.012761 |      -1.21 |
- | n_downstream_tracks_event                     | "n_downstream_tracks_event"                   |       1000 |       6.93 | 4.5026     |    0.77589 |    0.59233 |
+ | downstream_track_eta                          | "#eta"                                        |       6931 |     3.5897 | 0.69747    |    -0.2155 |   -0.79282 |
+ | downstream_track_nhits                        | "N. hits / track"                             |       6931 |     15.989 | 0.67755    |   -0.96833 |   -0.28738 |
+ | downstream_track_phi                          | "#phi"                                        |       6931 |    0.03387 | 1.7758     |  -0.012693 |    -1.2098 |
+ | n_downstream_tracks_event                     | "n_downstream_tracks_event"                   |       1000 |      6.931 | 4.5034     |    0.77523 |    0.58956 |
 downstream_make_particles              INFO 1D histograms in directory "downstream_make_particles" : 4
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | number_of_trks                                | "NTrks"                                       |        999 |     7.4219 | 4.4976     |    0.77886 |    0.60713 |
- | trk_eta                                       | "etaTrk"                                      |       6915 |     3.5894 | 0.69747    |   -0.21462 |   -0.79279 |
- | trk_phi                                       | "phiTrk"                                      |       6915 |   0.034841 | 1.7686     |  -0.013769 |    -1.2352 |
- | trk_pt                                        | "ptTrk"                                       |       6915 |     544.09 | 504.11     |     4.1605 |     38.113 |
+ | number_of_trks                                | "NTrks"                                       |        999 |     7.4229 | 4.4984     |     0.7782 |    0.60434 |
+ | trk_eta                                       | "etaTrk"                                      |       6916 |     3.5892 | 0.69761    |   -0.21463 |   -0.79312 |
+ | trk_phi                                       | "phiTrk"                                      |       6916 |   0.034785 | 1.7685     |  -0.013676 |     -1.235 |
+ | trk_pt                                        | "ptTrk"                                       |       6916 |     544.14 | 504.09     |       4.16 |     38.109 |
 is_muon_c92a16c2                       INFO 1D histograms in directory "is_muon_c92a16c2" : 3
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_muons                                       | "# muons"                                     |       6930 |    0.12193 | 0.32721    |     2.3109 |       3.34 |
+ | n_muons                                       | "# muons"                                     |       6931 |    0.12192 | 0.32719    |     2.3111 |     3.3412 |
  | pv_x                                          | "pv_x"                                        |        550 |          2 | 0.0000     |          0 |          0 |
  | pv_y                                          | "pv_y"                                        |        845 |     462.21 | 278.88     |    0.92751 |    0.51044 |
 matching_consolidate_tracks            INFO 1D histograms in directory "matching_consolidate_tracks" : 6
@@ -115,11 +115,11 @@ pv_beamline_cleanup                    INFO 1D histograms in directory "pv_beaml
  | pv_z                                          | "pv_z"                                        |       5102 |    0.46319 | 59.430     |   -0.03759 |   -0.10541 |
 scifi_consolidate_seeds                INFO 1D histograms in directory "scifi_consolidate_seeds" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     52.244 | 36.680     |      1.574 |     3.8941 |
- | scifi_track_eta                               | "#eta"                                        |      52244 |     2.5964 | 0.69769    |    0.61508 |    0.11706 |
- | scifi_track_nhits                             | "N. hits / track"                             |      52244 |     11.328 | 0.77516    |    -0.6419 |    -1.0584 |
- | scifi_track_phi                               | "#phi"                                        |      52244 |  0.0085359 | 2.0693     | -0.0052102 |   -0.96261 |
- | scifi_track_qop                               | "q/p"                                         |      52244 | -1.614e-06 | 0.00017317 | -0.0030091 |    -1.0081 |
+ | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     52.245 | 36.681     |     1.5739 |     3.8932 |
+ | scifi_track_eta                               | "#eta"                                        |      52245 |     2.5964 | 0.69770    |    0.61505 |    0.11701 |
+ | scifi_track_nhits                             | "N. hits / track"                             |      52245 |     11.328 | 0.77518    |   -0.64185 |    -1.0585 |
+ | scifi_track_phi                               | "#phi"                                        |      52245 |  0.0085334 | 2.0693     | -0.0052066 |   -0.96257 |
+ | scifi_track_qop                               | "q/p"                                         |      52245 |-1.6098e-06 | 0.00017317 | -0.0030434 |    -1.0081 |
 scifi_consolidate_tracks               INFO 1D histograms in directory "scifi_consolidate_tracks" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | long_track_forward_eta                        | "#eta"                                        |      29340 |     4.3666 | 0.54181    |  -0.021942 |   -0.36568 |
-- 
GitLab


From ce9fa79e6ff14712536dbdd4918c6aba1ce3553a Mon Sep 17 00:00:00 2001
From: Marco Clemencic <marco.clemencic@cern.ch>
Date: Mon, 10 Feb 2025 09:25:44 +0100
Subject: [PATCH 22/31] Update refs for x86_64_v2-el9-gcc13+detdesc-dbg

---
 .../tests/refs/hlt2_trackefflines.ref.detdesc | 144 +++++++++---------
 .../refs/hlt2_with_hlt1_decisions.ref.detdesc |   7 +-
 2 files changed, 76 insertions(+), 75 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.detdesc b/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.detdesc
index aff46b6ff76..9fce2f8b0b8 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.detdesc
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.detdesc
@@ -106,16 +106,16 @@ CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  | "energy (calo) associated to track"             |      6782 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 ChargedProtoParticleAssociator_3...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |       118 |        112 |( 94.91525 +- 2.022375)% |
- | "MC particles per ProtoParticle"                |       112 |        112 |     1.0000 |
+ |*"Efficiency"                                    |       118 |         46 |( 38.98305 +- 4.489750)% |
+ | "MC particles per ProtoParticle"                |        46 |         46 |     1.0000 |
 ChargedProtoParticleAssociator_3...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       411 |        377 |( 91.72749 +- 1.358775)% |
  | "MC particles per ProtoParticle"                |       377 |        377 |     1.0000 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |        62 |         56 |( 90.32258 +- 3.754759)% |
- | "MC particles per ProtoParticle"                |        56 |         56 |     1.0000 |
+ |*"Efficiency"                                    |        62 |         10 |( 16.12903 +- 4.671046)% |
+ | "MC particles per ProtoParticle"                |        10 |         10 |     1.0000 |
 ChargedProtoParticleAssociator_7...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       143 |        135 |( 94.40559 +- 1.921798)% |
@@ -159,12 +159,12 @@ CopySignalMCParticles_daf3c6a8.M...    INFO Number of counters : 2
  |*"MCVertices cloned"                             |       335 |        335 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |        62 |       6463 |     104.24 |     116.22 |      0.0000 |      409.00 |
+ | "# of cloned entries"                           |        62 |       6351 |     102.44 |     113.95 |      0.0000 |      393.00 |
  |*"Input container absent"                        |        62 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |     12232 |      12232 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |      7497 |       5068 |( 67.60037 +- 0.5405063)% |
+ |*"MCParticles cloned"                            |     12069 |      12069 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |      7399 |       4997 |( 67.53615 +- 0.5443543)% |
 FunctionalChargedProtoParticleMa...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "CreatedProtos"                                 |       233 |
@@ -284,39 +284,39 @@ Hlt2TrackEff_DiMuon_VeloMuon_mup...    INFO Number of counters : 1
 Hlt2TrackEff_DiMuon_VeloMuon_mup...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       100 |        100 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_107edb4f        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_1d478f2d        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |         9 |          9 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_2a932878        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         3 |          3 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |         3 |          3 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_528abf2c        INFO Number of counters : 2
+ |*"#passed"                                       |         9 |          9 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |        10 |         10 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_495dc5f1        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |         8 |          8 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_55d29bc6        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |         9 |          9 |( 100.0000 +- 0.000000)% |
 Hlt2TrackEff_LongTrack_5cdea100        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        21 |         21 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |       241 |        119 |( 49.37759 +- 3.220534)% |
-Hlt2TrackEff_LongTrack_88232f2f        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_b91c0b90        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |         8 |          8 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_8dbe30ad        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |        10 |         10 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |        10 |         10 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_abaaaf39        INFO Number of counters : 2
+ |*"#passed"                                       |         3 |          3 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |         3 |          3 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_cd2496ed        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |        11 |         11 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |        11 |         11 |( 100.0000 +- 0.000000)% |
+ |*"#passed"                                       |        12 |         12 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |        12 |         12 |( 100.0000 +- 0.000000)% |
 Hlt2TrackEff_LongTrack_de768bde        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        24 |         24 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |       301 |        144 |( 47.84053 +- 2.879263)% |
-Hlt2TrackEff_LongTrack_f79c3b8a        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_eab67977        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |        10 |         10 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |        10 |         10 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_fcbad1b5        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        13 |         13 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |        13 |         13 |( 100.0000 +- 0.000000)% |
@@ -517,9 +517,9 @@ Hlt2_TrackEff_Jpsi_f8edebd9            INFO Number of counters : 8
 HltDecReportsFilter_cfeb45c6           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |        31 |         31 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_22dc9762         INFO Number of counters : 2
+HltPackedBufferWriter_28e15b5f         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |        31 |    5131631 | 1.6554e+05 |     60902. |      48830. |  3.3026e+05 |
+ | "Size of serialized data"                       |        31 |    5131965 | 1.6555e+05 |     60897. |      48830. |  3.3026e+05 |
 Hlt__RoutingBitsCombiner_a7834b37      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |        31 |
@@ -538,7 +538,7 @@ LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Tracks"                         |        39 |       3311 |     84.897 |
-LHCb__SelectivePacker_66306c0e         INFO Number of counters : 71
+LHCb__SelectivePacker_187d0a39         INFO Number of counters : 71
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "BremInfos # containers packed"                 |        31 |         93 |     3.0000 |
  | "BremInfos # of packed entries"                 |        93 |       2691 |     28.935 |
@@ -577,18 +577,18 @@ LHCb__SelectivePacker_66306c0e         INFO Number of counters : 71
  | "P2PVRelations # containers packed"             |        31 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |        31 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |        31 |         62 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |        62 |       3658 |     59.000 |
- | "PP2MCPRelations buffer size"                   |        62 |      77216 |     1245.4 |
+ | "PP2MCPRelations # of packed entries"           |        62 |       3657 |     58.984 |
+ | "PP2MCPRelations buffer size"                   |        62 |      77196 |     1245.1 |
  | "PVs # containers packed"                       |        31 |         31 |     1.0000 |
  | "PVs # of packed entries"                       |        31 |        180 |     5.8065 |
  | "PVs buffer size"                               |        31 |      80428 |     2594.5 |
  | "PVsSelection # containers packed"              |        31 |          0 |     0.0000 |
  | "Particles # containers packed"                 |        31 |        149 |     4.8065 |
- | "Particles # of packed entries"                 |       149 |        196 |     1.3154 |
- | "Particles buffer size"                         |       149 |      44562 |     299.07 |
- | "ParticlesSelection # containers packed"        |        31 |        187 |     6.0323 |
- | "ParticlesSelection # of packed entries"        |       187 |        192 |     1.0267 |
- | "ParticlesSelection buffer size"                |       187 |       6959 |     37.214 |
+ | "Particles # of packed entries"                 |       149 |        197 |     1.3221 |
+ | "Particles buffer size"                         |       149 |      44752 |     300.35 |
+ | "ParticlesSelection # containers packed"        |        31 |        191 |     6.1613 |
+ | "ParticlesSelection # of packed entries"        |       191 |        198 |     1.0366 |
+ | "ParticlesSelection buffer size"                |       191 |       7123 |     37.293 |
  | "ProtoParticles # containers packed"            |        31 |        177 |     5.7097 |
  | "ProtoParticles # of packed entries"            |       177 |       3531 |     19.949 |
  | "ProtoParticles buffer size"                    |       177 |     261798 |     1479.1 |
@@ -647,34 +647,34 @@ MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of input v2 MuonPIDs"                       |       100 |       8614 |     86.140 |
-MuonProbeToLongMatcher_3d4e41e5        INFO Number of counters : 2
+MuonProbeToLongMatcher_326afb21        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |        11 |         11 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |        11 |         10 |    0.90909 |    0.28748 |      0.0000 |      1.0000 |
+MuonProbeToLongMatcher_4238694b        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_72e149bf        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_7eeb29b4        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |        10 |         11 |     1.1000 |    0.30000 |      1.0000 |      2.0000 |
- | "#Matched composites"                           |        10 |          8 |    0.80000 |    0.40000 |      0.0000 |      1.0000 |
-MuonProbeToLongMatcher_712599c8        INFO Number of counters : 2
+ | "#Matched composites"                           |        10 |         10 |     1.0000 |    0.44721 |      0.0000 |      2.0000 |
+MuonProbeToLongMatcher_84abcef1        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        12 |         11 |    0.91667 |    0.27639 |      0.0000 |      1.0000 |
-MuonProbeToLongMatcher_900845b4        INFO Number of counters : 2
+ | "#Matched composites"                           |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_c37c54e4        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |         8 |          9 |     1.1250 |    0.33072 |      1.0000 |      2.0000 |
  | "#Matched composites"                           |         8 |          9 |     1.1250 |    0.33072 |      1.0000 |      2.0000 |
-MuonProbeToLongMatcher_9e9a8383        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |        11 |         11 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        11 |         10 |    0.90909 |    0.28748 |      0.0000 |      1.0000 |
-MuonProbeToLongMatcher_c95313f6        INFO Number of counters : 2
+MuonProbeToLongMatcher_f6531e98        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |         8 |          9 |     1.1250 |    0.33072 |      1.0000 |      2.0000 |
  | "#Matched composites"                           |         8 |          8 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
-MuonProbeToLongMatcher_f482ccb8        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
-MuonProbeToLongMatcher_f5a1415b        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
 MuonUTTracking_69103d01                INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Could not propagate state to VELO!"            |         7 |
@@ -687,10 +687,10 @@ MuonUTTracking_69103d01.TrackMas...    INFO Number of counters : 1
  | "RungeKuttaExtrapolator failed with code: RK: Curling"|        64 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |        31 |      12737 |     410.87 |     138.79 |      156.00 |      776.00 |
+ | "#MCParticles"                                  |        31 |      12574 |     405.61 |     135.76 |      156.00 |      749.00 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |        31 |       5403 |     174.29 |     56.586 |      71.000 |      322.00 |
+ | "#MCVertices"                                   |        31 |       5332 |     172.00 |     55.295 |      71.000 |      317.00 |
 PrCloneKillerDown_bb1a1095             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       100 |       1763 |     17.630 |
@@ -852,12 +852,12 @@ PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |*"Non-unique UT clusters in event"               |       100 |          0 |( 0.000000 +- 0.000000)% |
 PrTrackAssociator_32802652             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |       118 |        112 |( 94.91525 +- 2.022375)% |
- | "MC particles per track"                        |       112 |        112 |     1.0000 |
+ |*"Efficiency"                                    |       118 |         46 |( 38.98305 +- 4.489750)% |
+ | "MC particles per track"                        |        46 |         46 |     1.0000 |
 PrTrackAssociator_3c42fca2             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |        62 |         56 |( 90.32258 +- 3.754759)% |
- | "MC particles per track"                        |        56 |         56 |     1.0000 |
+ |*"Efficiency"                                    |        62 |         10 |( 16.12903 +- 4.671046)% |
+ | "MC particles per track"                        |        10 |         10 |     1.0000 |
 PrTrackAssociator_615f5a8d             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       411 |        377 |( 91.72749 +- 1.358775)% |
@@ -1020,7 +1020,7 @@ GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMo
  | /Hlt2TrackEff_DiMuon_SeedMuon_mum_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mum..." |         11 |        1.5 | 0.0000     |          0 |          0 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Match" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |        1.5 | 0.0000     |          0 |          0 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |        1.5 | 0.0000     |          0 |          0 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |        1.5 | 0.0000     |          0 |          0 |
@@ -1032,7 +1032,7 @@ GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMo
  | /Hlt2TrackEff_DiMuon_VeloMuon_mum_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mum..." |          8 |      1.625 | 0.33072    |     2.2678 |     3.1429 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Match" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |      1.625 | 0.33072    |     2.2678 |     3.1429 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     1.6111 | 0.31427    |     2.4749 |      4.125 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |        1.6 | 0.30000    |     2.6667 |     5.1111 |
@@ -1098,11 +1098,11 @@ Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor_
  | /Hlt2TrackEff_DiMuon_SeedMuon_mum_Tag/vchi2   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mum..." |         11 |    0.47727 | 0.49376    |     1.8255 |     1.5951 |
 Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Match" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     3.2773 | 0.99826    |    0.77201 |   -0.45894 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     70.312 | 51.031     |    0.17223 |    -1.4648 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     3105.9 | 43.995     |    0.25935 |     1.0462 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     5159.1 | 3617.0     |     0.1052 |    -1.4655 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |    0.29545 | 0.14374    |      2.846 |        6.1 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |       3.25 | 0.96003    |    0.87757 |   -0.18093 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     64.062 | 51.916     |    0.33564 |    -1.4257 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     3103.3 | 42.979     |    0.40399 |     1.1697 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     5583.3 | 3737.9     |  -0.044056 |    -1.5375 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |    0.29167 | 0.13819    |     3.0151 |     7.0909 |
 Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag/eta     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |       3.25 | 0.96003    |    0.87757 |   -0.18093 |
@@ -1126,11 +1126,11 @@ Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor_
  | /Hlt2TrackEff_DiMuon_VeloMuon_mum_Tag/vchi2   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mum..." |          9 |    0.60243 | 0.56381    |    0.89331 |   0.093073 |
 Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Match" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     3.2722 | 0.70518    |    -0.3772 |    -1.2286 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     297.74 | 280.87     |    0.69215 |   -0.98608 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     3058.3 | 78.174     |   -0.95622 |    0.20329 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |       4642 | 3126.6     |    0.97901 |   -0.43624 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |    0.39757 | 0.38011    |    0.96035 |  -0.030039 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |       3.28 | 0.66940    |   -0.43158 |    -1.0172 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |     285.94 | 268.80     |    0.83405 |   -0.70067 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |       3038 | 96.026     |     -0.769 |   -0.64573 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |       4450 | 3021.6     |     1.1415 |  -0.072474 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |    0.36562 | 0.37312    |     1.1085 |    0.26825 |
 Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag/eta     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         11 |     3.4773 | 0.89248    |    0.46726 |   0.038982 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.detdesc b/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.detdesc
index 58d2c28c558..2cede01267b 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.detdesc
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.detdesc
@@ -100,11 +100,12 @@ FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |*"# passed Track filter"                         |      1342 |       1342 |( 100.0000 +- 0.000000)% |
  | "Nb created anti-particles"                     |        20 |        705 |     35.250 |     24.075 |      6.0000 |      90.000 |
  | "Nb created particles"                          |        20 |        637 |     31.850 |     21.875 |      4.0000 |      78.000 |
-GaudiAllenCountAndDumpLineDecisi...    INFO Number of counters : 99
+GaudiAllenCountAndDumpLineDecisi...    INFO Number of counters : 100
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Selected by Hlt1BGIPseudoPVsBeamOneDecision"   |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsBeamTwoDecision"   |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsDownBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
+ |*"Selected by Hlt1BGIPseudoPVsIRBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsNoBeamDecision"    |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsUpBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BeamGasDecision"               |        20 |          0 |( 0.000000 +- 0.000000)% |
@@ -431,8 +432,8 @@ fit_v0_secondary_vertices              INFO 1D histograms in directory "fit_v0_s
  | number_of_svs                                 | "NSVs"                                        |         20 |        0.7 | 1.1446     |     1.6047 |     1.5287 |
 gather_selections                      INFO 1D histograms in directory "gather_selections" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | line_passes                                   | "line passes"                                 |         28 |      87.25 | 15.191     |    -1.4349 |    0.19818 |
- | line_rates                                    | "line rates"                                  |          2 |         91 | 1.5000     |          0 |         -2 |
+ | line_passes                                   | "line passes"                                 |         28 |      88.25 | 15.191     |    -1.4349 |    0.19818 |
+ | line_rates                                    | "line rates"                                  |          2 |         92 | 1.5000     |          0 |         -2 |
 is_muon                                INFO 1D histograms in directory "is_muon" : 3
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | n_muons                                       | "# muons"                                     |        667 |   0.061469 | 0.24019    |     3.6515 |     11.334 |
-- 
GitLab


From 6ed65a6456090e608cdcbfc193d0658edce97e05 Mon Sep 17 00:00:00 2001
From: Marco Clemencic <marco.clemencic@cern.ch>
Date: Mon, 10 Feb 2025 09:25:45 +0100
Subject: [PATCH 23/31] Update refs for x86_64_v3-el9-gcc13+detdesc-opt+g

---
 ...t2_trackefflines.ref.x86_64_v3-detdesc-opt | 138 +++++++++---------
 ...h_hlt1_decisions.ref.x86_64_v3-detdesc-opt |   7 +-
 2 files changed, 73 insertions(+), 72 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.x86_64_v3-detdesc-opt
index 974f52395cd..3b9fb571b1b 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_trackefflines.ref.x86_64_v3-detdesc-opt
@@ -107,16 +107,16 @@ CaloTrackToHcalEnergyAlg_Long_d4...    INFO Number of counters : 1
  | "energy (calo) associated to track"             |      6778 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
 ChargedProtoParticleAssociator_3...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |       113 |        106 |( 93.80531 +- 2.267693)% |
- | "MC particles per ProtoParticle"                |       106 |        106 |     1.0000 |
+ |*"Efficiency"                                    |       113 |         45 |( 39.82301 +- 4.605142)% |
+ | "MC particles per ProtoParticle"                |        45 |         45 |     1.0000 |
 ChargedProtoParticleAssociator_3...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       394 |        360 |( 91.37056 +- 1.414641)% |
  | "MC particles per ProtoParticle"                |       360 |        360 |     1.0000 |
 ChargedProtoParticleAssociator_4...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |        55 |         49 |( 89.09091 +- 4.203680)% |
- | "MC particles per ProtoParticle"                |        49 |         49 |     1.0000 |
+ |*"Efficiency"                                    |        55 |          9 |( 16.36364 +- 4.988341)% |
+ | "MC particles per ProtoParticle"                |         9 |          9 |     1.0000 |
 ChargedProtoParticleAssociator_7...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       137 |        129 |( 94.16058 +- 2.003360)% |
@@ -160,12 +160,12 @@ CopySignalMCParticles_daf3c6a8.M...    INFO Number of counters : 2
  |*"MCVertices cloned"                             |       329 |        329 |( 100.0000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "# of cloned entries"                           |        60 |       6212 |     103.53 |     115.72 |      0.0000 |      406.00 |
+ | "# of cloned entries"                           |        60 |       6111 |     101.85 |     113.63 |      0.0000 |      392.00 |
  |*"Input container absent"                        |        60 |          0 |( 0.000000 +- 0.000000)% |
 Copy_MC_For__Event_Relations_Cha...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"MCParticles cloned"                            |     11746 |      11746 |( 100.0000 +- 0.000000)% |
- |*"MCVertices cloned"                             |      7192 |       4868 |( 67.68632 +- 0.5514661)% |
+ |*"MCParticles cloned"                            |     11608 |      11608 |( 100.0000 +- 0.000000)% |
+ |*"MCVertices cloned"                             |      7110 |       4807 |( 67.60900 +- 0.5549829)% |
 FunctionalChargedProtoParticleMa...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "CreatedProtos"                                 |       233 |
@@ -285,39 +285,39 @@ Hlt2TrackEff_DiMuon_VeloMuon_mup...    INFO Number of counters : 1
 Hlt2TrackEff_DiMuon_VeloMuon_mup...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#accept"                                       |       100 |        100 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_107edb4f        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_1d478f2d        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |        10 |         10 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_2a932878        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         3 |          3 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |         3 |          3 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_528abf2c        INFO Number of counters : 2
+ |*"Cut selection efficiency"                      |         9 |          9 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_495dc5f1        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |         9 |          9 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_55d29bc6        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |         8 |          8 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |        10 |         10 |( 100.0000 +- 0.000000)% |
 Hlt2TrackEff_LongTrack_5cdea100        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        22 |         22 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |       263 |        135 |( 51.33080 +- 3.082040)% |
-Hlt2TrackEff_LongTrack_88232f2f        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_b91c0b90        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |         7 |          7 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |         7 |          7 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_8dbe30ad        INFO Number of counters : 2
+ |*"#passed"                                       |         3 |          3 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |         3 |          3 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_cd2496ed        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        12 |         12 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |        12 |         12 |( 100.0000 +- 0.000000)% |
-Hlt2TrackEff_LongTrack_abaaaf39        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"#passed"                                       |        11 |         11 |( 100.0000 +- 0.000000)% |
- |*"Cut selection efficiency"                      |        11 |         11 |( 100.0000 +- 0.000000)% |
 Hlt2TrackEff_LongTrack_de768bde        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        23 |         23 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |       290 |        140 |( 48.27586 +- 2.934355)% |
-Hlt2TrackEff_LongTrack_f79c3b8a        INFO Number of counters : 2
+Hlt2TrackEff_LongTrack_eab67977        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ |*"#passed"                                       |        12 |         12 |( 100.0000 +- 0.000000)% |
+ |*"Cut selection efficiency"                      |        12 |         12 |( 100.0000 +- 0.000000)% |
+Hlt2TrackEff_LongTrack_fcbad1b5        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"#passed"                                       |        13 |         13 |( 100.0000 +- 0.000000)% |
  |*"Cut selection efficiency"                      |        13 |         13 |( 100.0000 +- 0.000000)% |
@@ -518,9 +518,9 @@ Hlt2_TrackEff_Jpsi_f8edebd9            INFO Number of counters : 8
 HltDecReportsFilter_cfeb45c6           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Cut selection efficiency"                      |        30 |         30 |( 100.0000 +- 0.000000)% |
-HltPackedBufferWriter_22dc9762         INFO Number of counters : 2
+HltPackedBufferWriter_28e15b5f         INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Size of serialized data"                       |        30 |    4960301 | 1.6534e+05 |     61772. |      48888. |  3.2785e+05 |
+ | "Size of serialized data"                       |        30 |    4960635 | 1.6535e+05 |     61767. |      48888. |  3.2785e+05 |
 Hlt__RoutingBitsCombiner_a7834b37      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "# missing hlt1 bank"                           |        30 |
@@ -539,7 +539,7 @@ LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
 LHCb__Converters__Track__SOA__fr...    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of Produced Tracks"                         |        38 |       3208 |     84.421 |
-LHCb__SelectivePacker_66306c0e         INFO Number of counters : 71
+LHCb__SelectivePacker_187d0a39         INFO Number of counters : 71
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "BremInfos # containers packed"                 |        30 |         90 |     3.0000 |
  | "BremInfos # of packed entries"                 |        90 |       2578 |     28.644 |
@@ -578,18 +578,18 @@ LHCb__SelectivePacker_66306c0e         INFO Number of counters : 71
  | "P2PVRelations # containers packed"             |        30 |          0 |     0.0000 |
  | "P2VRelations # containers packed"              |        30 |          0 |     0.0000 |
  | "PP2MCPRelations # containers packed"           |        30 |         60 |     2.0000 |
- | "PP2MCPRelations # of packed entries"           |        60 |       3525 |     58.750 |
- | "PP2MCPRelations buffer size"                   |        60 |      74432 |     1240.5 |
+ | "PP2MCPRelations # of packed entries"           |        60 |       3524 |     58.733 |
+ | "PP2MCPRelations buffer size"                   |        60 |      74412 |     1240.2 |
  | "PVs # containers packed"                       |        30 |         30 |     1.0000 |
  | "PVs # of packed entries"                       |        30 |        176 |     5.8667 |
  | "PVs buffer size"                               |        30 |      78138 |     2604.6 |
  | "PVsSelection # containers packed"              |        30 |          0 |     0.0000 |
  | "Particles # containers packed"                 |        30 |        148 |     4.9333 |
- | "Particles # of packed entries"                 |       148 |        198 |     1.3378 |
- | "Particles buffer size"                         |       148 |      44908 |     303.43 |
- | "ParticlesSelection # containers packed"        |        30 |        189 |     6.3000 |
- | "ParticlesSelection # of packed entries"        |       189 |        199 |     1.0529 |
- | "ParticlesSelection buffer size"                |       189 |       7073 |     37.423 |
+ | "Particles # of packed entries"                 |       148 |        199 |     1.3446 |
+ | "Particles buffer size"                         |       148 |      45098 |     304.72 |
+ | "ParticlesSelection # containers packed"        |        30 |        193 |     6.4333 |
+ | "ParticlesSelection # of packed entries"        |       193 |        205 |     1.0622 |
+ | "ParticlesSelection buffer size"                |       193 |       7237 |     37.497 |
  | "ProtoParticles # containers packed"            |        30 |        173 |     5.7667 |
  | "ProtoParticles # of packed entries"            |       173 |       3405 |     19.682 |
  | "ProtoParticles buffer size"                    |       173 |     252542 |     1459.8 |
@@ -648,34 +648,34 @@ MuonPIDV2ToMuonTracks_Downstream...    INFO Number of counters : 1
 MuonPIDV2ToMuonTracks_Long_da5469c1    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb of input v2 MuonPIDs"                       |       100 |       8607 |     86.070 |
-MuonProbeToLongMatcher_3d4e41e5        INFO Number of counters : 2
+MuonProbeToLongMatcher_326afb21        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_4238694b        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_72e149bf        INFO Number of counters : 2
+ |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
+ | "#Input composites"                             |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+ | "#Matched composites"                           |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_7eeb29b4        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |         9 |         10 |     1.1111 |    0.31427 |      1.0000 |      2.0000 |
- | "#Matched composites"                           |         9 |          7 |    0.77778 |    0.41574 |      0.0000 |      1.0000 |
-MuonProbeToLongMatcher_712599c8        INFO Number of counters : 2
+ | "#Matched composites"                           |         9 |          9 |     1.0000 |    0.47140 |      0.0000 |      2.0000 |
+MuonProbeToLongMatcher_84abcef1        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        12 |         11 |    0.91667 |    0.27639 |      0.0000 |      1.0000 |
-MuonProbeToLongMatcher_900845b4        INFO Number of counters : 2
+ | "#Matched composites"                           |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
+MuonProbeToLongMatcher_c37c54e4        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |         8 |         10 |     1.2500 |    0.43301 |      1.0000 |      2.0000 |
  | "#Matched composites"                           |         8 |         10 |     1.2500 |    0.43301 |      1.0000 |      2.0000 |
-MuonProbeToLongMatcher_9e9a8383        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        12 |         12 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
-MuonProbeToLongMatcher_c95313f6        INFO Number of counters : 2
+MuonProbeToLongMatcher_f6531e98        INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#Input composites"                             |         8 |          9 |     1.1250 |    0.33072 |      1.0000 |      2.0000 |
  | "#Matched composites"                           |         8 |          9 |     1.1250 |    0.33072 |      1.0000 |      2.0000 |
-MuonProbeToLongMatcher_f482ccb8        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |        13 |         13 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
-MuonProbeToLongMatcher_f5a1415b        INFO Number of counters : 2
- |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#Input composites"                             |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
- | "#Matched composites"                           |         3 |          3 |     1.0000 |     0.0000 |      1.0000 |      1.0000 |
 MuonUTTracking_69103d01                INFO Number of counters : 5
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Could not propagate state to VELO!"            |         7 |
@@ -689,10 +689,10 @@ MuonUTTracking_69103d01.TrackMas...    INFO Number of counters : 2
  | "RungeKuttaExtrapolator failed with code: RK: Exceed maximum number of steps"|         1 |
 Pack__Event_HLT2_MC_Particles          INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCParticles"                                  |        30 |      12245 |     408.17 |     140.32 |      156.00 |      774.00 |
+ | "#MCParticles"                                  |        30 |      12107 |     403.57 |     137.43 |      156.00 |      748.00 |
 Pack__Event_HLT2_MC_Vertices           INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#MCVertices"                                   |        30 |       5197 |     173.23 |     57.247 |      71.000 |      321.00 |
+ | "#MCVertices"                                   |        30 |       5136 |     171.20 |     55.973 |      71.000 |      316.00 |
 PrCloneKillerDown_bb1a1095             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "nTracksInput"                                  |       100 |       1763 |     17.630 |
@@ -854,12 +854,12 @@ PrStoreUTHitClusters_69298ec0          INFO Number of counters : 3
  |*"Non-unique UT clusters in event"               |       100 |          0 |( 0.000000 +- 0.000000)% |
 PrTrackAssociator_32802652             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |       113 |        106 |( 93.80531 +- 2.267693)% |
- | "MC particles per track"                        |       106 |        106 |     1.0000 |
+ |*"Efficiency"                                    |       113 |         45 |( 39.82301 +- 4.605142)% |
+ | "MC particles per track"                        |        45 |         45 |     1.0000 |
 PrTrackAssociator_3c42fca2             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- |*"Efficiency"                                    |        55 |         49 |( 89.09091 +- 4.203680)% |
- | "MC particles per track"                        |        49 |         49 |     1.0000 |
+ |*"Efficiency"                                    |        55 |          9 |( 16.36364 +- 4.988341)% |
+ | "MC particles per track"                        |         9 |          9 |     1.0000 |
 PrTrackAssociator_615f5a8d             INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Efficiency"                                    |       394 |        360 |( 91.37056 +- 1.414641)% |
@@ -1028,7 +1028,7 @@ GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMo
  | /Hlt2TrackEff_DiMuon_SeedMuon_mum_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mum..." |         12 |        1.5 | 0.0000     |          0 |          0 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Match" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |        1.5 | 0.0000     |          0 |          0 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |        1.5 | 0.0000     |          0 |          0 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |        1.5 | 0.0000     |          0 |          0 |
@@ -1040,7 +1040,7 @@ GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMo
  | /Hlt2TrackEff_DiMuon_VeloMuon_mum_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mum..." |          8 |       1.75 | 0.43301    |     1.1547 |   -0.66667 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Match" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          7 |     1.6429 | 0.34993    |     2.0412 |     2.1667 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/n_can | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |      1.625 | 0.33072    |     2.2678 |     3.1429 |
 GlobalMonitor__Hlt2TrackEff_DiMu...    INFO 1D histograms in directory "GlobalMonitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag/n_candi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     1.6111 | 0.31427    |     2.4749 |      4.125 |
@@ -1106,11 +1106,11 @@ Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor_
  | /Hlt2TrackEff_DiMuon_SeedMuon_mum_Tag/vchi2   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mum..." |         12 |    0.58333 | 0.58926    |     1.2784 |    -0.2256 |
 Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Match" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     3.2773 | 0.99826    |    0.77201 |   -0.45894 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     76.172 | 46.178     |   -0.10668 |    -1.4911 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     3105.9 | 43.995     |    0.25935 |     1.0462 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |     5159.1 | 3617.0     |     0.1052 |    -1.4655 |
- | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         11 |    0.29545 | 0.14374    |      2.846 |        6.1 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |       3.25 | 0.96003    |    0.87757 |   -0.18093 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     68.576 | 48.549     |   0.081397 |    -1.5619 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     3103.3 | 42.979     |    0.40399 |     1.1697 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |     5583.3 | 3737.9     |  -0.044056 |    -1.5375 |
+ | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |    0.29167 | 0.13819    |     3.0151 |     7.0909 |
 Monitor__Hlt2TrackEff_DiMuon_See...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_SeedMuon_mup_Tag/eta     | "Monitor_Hlt2TrackEff_DiMuon_SeedMuon_mup..." |         12 |       3.25 | 0.96003    |    0.87757 |   -0.18093 |
@@ -1134,11 +1134,11 @@ Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor_
  | /Hlt2TrackEff_DiMuon_VeloMuon_mum_Tag/vchi2   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mum..." |         10 |    0.55625 | 0.55252    |     1.0472 |    0.37512 |
 Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Match" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |     3.2125 | 0.72618    |   -0.17691 |    -1.3501 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |     328.12 | 283.63     |     0.5123 |    -1.1769 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |       3045 | 72.629     |    -1.1804 |    0.18492 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |     4758.6 | 3297.8     |    0.83536 |   -0.79598 |
- | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          8 |      0.375 | 0.39744    |      1.104 |   0.021505 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/eta   | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     3.2278 | 0.68602    |   -0.25245 |    -1.1389 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/ipchi | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     311.63 | 271.44     |    0.68382 |   -0.91443 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/m     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     3023.9 | 90.853     |   -0.84265 |   -0.82865 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/pt    | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |     4532.3 | 3174.4     |     1.0174 |   -0.43956 |
+ | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Match/vchi2 | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |          9 |    0.34201 | 0.38615    |     1.2763 |    0.44499 |
 Monitor__Hlt2TrackEff_DiMuon_Vel...    INFO 1D histograms in directory "Monitor__Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /Hlt2TrackEff_DiMuon_VeloMuon_mup_Tag/eta     | "Monitor_Hlt2TrackEff_DiMuon_VeloMuon_mup..." |         10 |       3.45 | 0.93167    |    0.53717 |   -0.12794 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.x86_64_v3-detdesc-opt
index 7c0a98bd2d0..a63e5a27ccc 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_with_hlt1_decisions.ref.x86_64_v3-detdesc-opt
@@ -100,11 +100,12 @@ FunctionalParticleMaker_fa1d2992       INFO Number of counters : 5
  |*"# passed Track filter"                         |      1341 |       1341 |( 100.0000 +- 0.000000)% |
  | "Nb created anti-particles"                     |        20 |        705 |     35.250 |     23.966 |      6.0000 |      89.000 |
  | "Nb created particles"                          |        20 |        636 |     31.800 |     21.894 |      4.0000 |      78.000 |
-GaudiAllenCountAndDumpLineDecisi...    INFO Number of counters : 99
+GaudiAllenCountAndDumpLineDecisi...    INFO Number of counters : 100
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Selected by Hlt1BGIPseudoPVsBeamOneDecision"   |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsBeamTwoDecision"   |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsDownBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
+ |*"Selected by Hlt1BGIPseudoPVsIRBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsNoBeamDecision"    |        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BGIPseudoPVsUpBeamBeamDecision"|        20 |          0 |( 0.000000 +- 0.000000)% |
  |*"Selected by Hlt1BeamGasDecision"               |        20 |          0 |( 0.000000 +- 0.000000)% |
@@ -431,8 +432,8 @@ fit_v0_secondary_vertices              INFO 1D histograms in directory "fit_v0_s
  | number_of_svs                                 | "NSVs"                                        |         20 |        0.7 | 1.1446     |     1.6047 |     1.5287 |
 gather_selections                      INFO 1D histograms in directory "gather_selections" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | line_passes                                   | "line passes"                                 |         28 |      87.25 | 15.191     |    -1.4349 |    0.19818 |
- | line_rates                                    | "line rates"                                  |          2 |         91 | 1.5000     |          0 |         -2 |
+ | line_passes                                   | "line passes"                                 |         28 |      88.25 | 15.191     |    -1.4349 |    0.19818 |
+ | line_rates                                    | "line rates"                                  |          2 |         92 | 1.5000     |          0 |         -2 |
 is_muon                                INFO 1D histograms in directory "is_muon" : 3
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | n_muons                                       | "# muons"                                     |        667 |   0.061469 | 0.24019    |     3.6515 |     11.334 |
-- 
GitLab


From 6a7ee22a9c37c4606f011f1f7f4baf2b8ca4ed3b Mon Sep 17 00:00:00 2001
From: Sebastien Ponce <sebastien.ponce@cern.ch>
Date: Mon, 10 Feb 2025 14:05:20 +0100
Subject: [PATCH 24/31] Fixed validator of
 test_lbexec_hlt2_pp_2024_noflagging_mc

---
 .../tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt    | 3 +--
 1 file changed, 1 insertion(+), 2 deletions(-)

diff --git a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
index 910697dda0d..bdcfe823eb2 100644
--- a/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
+++ b/Hlt/Moore/tests/qmtest/test_lbexec_hlt2_pp_2024_noflagging_mc.qmt
@@ -28,8 +28,7 @@ Test that HLT2 can run from LHCbDirac and that it produces the expected outputs
 <argument name="use_temp_dir"><enumeral>true</enumeral></argument>
 <argument name="validator"><text>
 
-findReferenceBlock("""# WARNING: Unsupported type &lt;class 'PrFilters.PrFiltersConf.PrFilter__PV'&gt; for line output PrFilter__PV/PrFilter__PV_6a9ee3b3 for line ('Hlt2IFTFull_SMOG2Passthrough_PV_in_SMOG2',); this will not be persisted. Only Particles are persisted as line outputs.
-ApplicationMgr    SUCCESS""")
+findReferenceBlock("""# WARNING: Unsupported type &lt;class 'PrFilters.PrFiltersConf.PrFilter__PV'&gt; for line output PrFilter__PV/PrFilter__PV_6a9ee3b3 for line ('Hlt2IFTFull_SMOG2Passthrough_PV_in_SMOG2',); this will not be persisted. Only Particles are persisted as line outputs.""")
 
 from Moore.qmtest.exclusions import remove_known_warnings
 countErrorLines({"FATAL": 0, "ERROR": 0, "WARNING": 0},
-- 
GitLab


From a5eadd6f6a7c44d554e9e32f9a6c2fdbd588ed13 Mon Sep 17 00:00:00 2001
From: RefBot <lhcbsoft@cern.ch>
Date: Mon, 10 Feb 2025 15:43:07 +0100
Subject: [PATCH 25/31] Update References for: Rec!3399 based on
 lhcb-master-mr/12533

[skip ci]
---
 .../refs/hlt2_reco_2024_with_mcchecking.ref   |   6 +-
 ...t2_reco_2024_with_mcchecking.ref.armv8.1_a |  32 +--
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt |  22 +-
 ...eco_2024_with_mcchecking.ref.x86_64_v3-opt |  12 +-
 ...udi_downstream_with_mcchecking.ref.detdesc |  32 +--
 ...ull_geometry_with_mcchecking.ref.armv8.1_a |  12 +-
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt | 194 ++++++++---------
 ...geometry_with_mcchecking.ref.x86_64_v3-opt |   4 +-
 ...co_track_master_fitter_with_mcchecking.ref |   8 +-
 ...aster_fitter_with_mcchecking.ref.armv8.1_a | 180 ++++++++--------
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt | 194 ++++++++---------
 ...r_fitter_with_mcchecking.ref.x86_64_v3-opt | 186 ++++++++--------
 .../refs/hlt2_fast_reco_with_mcchecking.ref   |   8 +-
 ...t2_fast_reco_with_mcchecking.ref.armv8.1_a | 166 +++++++--------
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt | 198 +++++++++---------
 ...ast_reco_with_mcchecking.ref.x86_64_v3-opt | 192 ++++++++---------
 ...fastest_reco_with_mcchecking.ref.armv8.1_a |  28 +--
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt |  30 +--
 ...t_reco_pr_kf_with_mcchecking.ref.armv8.1_a |  22 +-
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt |  32 +--
 ...2_light_reco_with_mcchecking.ref.armv8.1_a |  16 +-
 ..._with_mcchecking.ref.x86_64_v3-detdesc-opt |  24 +--
 ...ght_reco_with_mcchecking.ref.x86_64_v3-opt |  30 +--
 .../hlt2_pr_kf_tool_example.ref.armv8.1_a     |   6 +-
 .../hlt2_pr_kf_tool_example.ref.x86_64_v3-opt |   6 +-
 ...seline_with_mcchecking_mpp_with_bfield.ref |   6 +-
 ...h_mcchecking_mpp_with_bfield.ref.armv8.1_a | 180 ++++++++--------
 ..._mpp_with_bfield.ref.x86_64_v3-detdesc-opt | 196 ++++++++---------
 ...checking_mpp_with_bfield.ref.x86_64_v3-opt | 190 ++++++++---------
 29 files changed, 1106 insertions(+), 1106 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
index 527f9bd94c9..6a4c2d4e3e6 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref
@@ -3545,17 +3545,17 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       5472 | 0.00046459 | 0.077073   |    0.16525 |     1.0468 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3610 |   0.040492 | 0.14272    |   -0.91351 |    -1.3111 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       5917 |    0.18431 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       5990 | -0.0085026 | 0.12484    |    0.30665 |   -0.93872 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       5990 | -0.0085037 | 0.12484    |    0.30666 |   -0.93871 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3067 |  0.0019284 | 0.10892    |  -0.053952 |     -1.318 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       5391 |  0.0025986 | 0.054376   |-0.00047162 |     2.4288 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       5464 |   0.001377 | 0.059972   |    0.15983 |     2.4691 |
  | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3067 |  0.0019034 | 0.12376    |  -0.052813 |    -1.5129 |
  | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       5391 | 0.00054524 | 0.074815   |  -0.079705 |     1.0057 |
- | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       5464 | 8.0709e-05 | 0.078399   |   0.044041 |     1.1131 |
+ | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       5464 | 8.0708e-05 | 0.078399   |   0.044041 |     1.1131 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       5914 | -0.0011244 | 0.050505   |   -0.08021 |     2.4575 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       5987 |   0.001998 | 0.053983   |   -0.13519 |       2.28 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       5391 |  -0.011005 | 0.064819   |   -0.81396 |   -0.12443 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5464 |  0.0083938 | 0.072147   |   -0.46525 |    0.97918 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5464 |  0.0083936 | 0.072147   |   -0.46527 |    0.97918 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       9830 |  0.0018997 | 0.18536    |  -0.037246 |   -0.73137 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2610 |   0.002624 | 0.063269   |    0.60976 |     1.9373 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2637 |  0.0017418 | 0.060204   |   -0.61205 |     2.1471 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
index 34259e34421..1f021414b61 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.armv8.1_a
@@ -609,7 +609,7 @@ CaloSelectiveBremMatchAlg_Long_e...    INFO Number of counters : 3
 CaloSelectiveBremMatchAlg_Upstre...    INFO Number of counters : 3
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "#links in table"                               |       100 |        177 |     1.7700 |     2.1064 |      0.0000 |      10.000 |
- | "average chi2"                                  |       177 |   1066.957 |     6.0280 |     7.6749 |   0.0010416 |      44.756 |
+ | "average chi2"                                  |       177 |   1066.956 |     6.0280 |     7.6749 |   0.0010416 |      44.756 |
  | "average energy (track based)"                  |       510 |    61279.3 |     120.16 |     326.65 |      0.0000 |      3097.3 |
 CaloSelectiveElectronMatchAlg_Do...    INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
@@ -3540,22 +3540,22 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3073 |  0.0014701 | 0.10923    |  -0.045066 |    -1.3238 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       5404 |  0.0025932 | 0.054922   |   0.027628 |     2.3575 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       5477 |  0.0011605 | 0.060581   |    0.17985 |     2.4268 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3073 | 0.00077211 | 0.12928    |    0.01017 |    -1.5954 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       5404 | 0.00046926 | 0.071529   |  -0.060593 |     1.2539 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3073 |  0.0007721 | 0.12928    |    0.01017 |    -1.5954 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       5404 | 0.00046925 | 0.071529   |  -0.060593 |     1.2539 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       5477 | 0.00053658 | 0.076950   |    0.16431 |     1.0534 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3611 |   0.040395 | 0.14277    |   -0.91082 |    -1.3154 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       5921 |    0.19575 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       5994 | 0.00061523 | 0.12250    |    0.23207 |    -0.9066 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3611 |   0.040394 | 0.14277    |   -0.91082 |    -1.3154 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       5921 |    0.19574 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       5994 | 0.00057618 | 0.12247    |    0.23225 |   -0.90603 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3069 |  0.0018031 | 0.10888    |  -0.051478 |    -1.3181 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       5396 |  0.0025874 | 0.054315   |-0.00053178 |     2.4373 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       5396 |  0.0025874 | 0.054315   |-0.00053172 |     2.4373 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       5469 |  0.0014029 | 0.059895   |    0.15991 |     2.4766 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3069 |  0.0018011 | 0.12373    |  -0.050953 |    -1.5128 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       5396 | 0.00039873 | 0.074762   |  -0.078391 |     1.0053 |
- | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       5469 |-2.2492e-06 | 0.078355   |   0.043183 |     1.1112 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       5918 | -0.0012773 | 0.050532   |  -0.082305 |     2.4481 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       5991 |  0.0018742 | 0.053991   |   -0.12553 |     2.2557 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       5396 |  -0.011771 | 0.064834   |    -0.8089 |   -0.17241 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5469 |  0.0080676 | 0.072253   |   -0.44845 |    0.92098 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3069 |   0.001801 | 0.12373    |  -0.050953 |    -1.5128 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       5396 | 0.00039874 | 0.074762   |  -0.078391 |     1.0053 |
+ | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       5469 |-2.2547e-06 | 0.078355   |   0.043182 |     1.1112 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       5918 | -0.0012772 | 0.050533   |  -0.082259 |     2.4483 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       5991 |  0.0018743 | 0.053991   |   -0.12551 |     2.2558 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       5396 |  -0.011771 | 0.064833   |   -0.80903 |   -0.17275 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5469 |  0.0080659 | 0.072251   |    -0.4486 |    0.92093 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       9834 |  0.0019214 | 0.18542    |  -0.036529 |   -0.73281 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2611 |  0.0025881 | 0.063229   |    0.61087 |     1.9466 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2639 |  0.0016856 | 0.060235   |   -0.61075 |     2.1353 |
@@ -3591,10 +3591,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        580 |      10431 | 12644.     |     3.1721 |     12.608 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        588 |   -0.01496 | 1.8551     |  0.0072129 |    -1.1283 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        580 |     9110.8 | 11524.     |     3.5812 |     15.773 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        588 |   0.046269 | 1.8629     |  -0.049647 |    -1.0947 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        588 |   0.046268 | 1.8629     |  -0.049646 |    -1.0947 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        535 |     2.6221 | 0.51523    |     1.3712 |     1.9223 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        580 |     5459.4 | 5381.3     |     5.9927 |     52.051 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        588 |   0.012421 | 1.8667     |  -0.045675 |    -1.0593 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        588 |   0.012418 | 1.8667     |  -0.045673 |    -1.0593 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |      13057 |     9650.8 | 10748.     |     1.6698 |     2.3344 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |      13055 |  -0.042868 | 1.7937     |   0.013181 |     -1.174 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      13057 |       8283 | 10617.     |     1.9326 |      3.151 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 988ed21f0c6..29a528f114a 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -2584,7 +2584,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/HitVeloALayers                       | "Hit Velo-A layers"                           |       3122 |     16.161 | 5.1672     |  -0.071608 |   -0.97435 |
  | Upstream/HitVeloCLayers                       | "Hit Velo-C layers"                           |       2658 |     16.325 | 4.9666     |  -0.025467 |   -0.92686 |
  | Upstream/UTResidual                           | "UTresidual (rms-unbiased)"                   |       2790 | 5.0179e-05 | 0.052719   |   -0.04063 |     1.1796 |
- | Upstream/UTresidualPull                       | "UT residual pull"                            |       2790 |  0.0017921 | 1.1969     |  0.0017048 |   0.055786 |
+ | Upstream/UTresidualPull                       | "UT residual pull"                            |       2790 |  0.0018638 | 1.1969     |  0.0015304 |   0.055666 |
  | Upstream/VPXResidual                          | "VPXresidual (rms-unbiased)"                  |       5688 | 3.7975e-05 | 0.013154   |   0.028425 |   -0.22869 |
  | Upstream/VPXresidualPull                      | "VPX residual pull"                           |       5688 |  0.0016526 | 1.0499     |   0.020286 |   -0.22157 |
  | Upstream/VPYResidual                          | "VPYresidual (rms-unbiased)"                  |       5688 |-4.2897e-05 | 0.013151   |   0.032683 |    -0.2458 |
@@ -2617,7 +2617,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        704 |      14695 | 16940.     |      2.148 |     4.8998 |
  | Upstream/phi                                  | "phi"                                         |        704 |    0.01071 | 1.8022     |   0.011669 |    -1.0369 |
  | Upstream/probChi2                             | "probChi2"                                    |        704 |    0.38156 | 0.31763    |    0.50282 |    -1.1124 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        704 |      15066 | 17505.     |     2.3063 |     5.9654 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        704 |      15069 | 17506.     |     2.3053 |      5.961 |
  | Upstream/pt                                   | "pt"                                          |        704 |     850.71 | 546.30     |     3.1988 |     13.992 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        704 |-3.5227e-06 | 0.00021073 |   0.066793 |     -0.548 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        704 |    -4.7523 | 0.37569    |  -0.099583 |    -1.0924 |
@@ -3093,7 +3093,7 @@ TrackResCheckerBestUpstream            INFO 1D histograms in directory "TrackRes
  | Upstream/vertex/qoppull                       | "qop pull"                                    |        668 |  -0.038914 | 1.4787     |   -0.11183 |     1.0012 |
  | Upstream/vertex/txpull                        | "tx pull"                                     |        668 |    0.03822 | 1.1518     |   -0.18741 |     1.1787 |
  | Upstream/vertex/txres                         | "tx resolution"                               |        668 | 1.1142e-05 | 0.00051917 |    0.11449 |      4.597 |
- | Upstream/vertex/typull                        | "ty pull"                                     |        668 |  0.0064604 | 1.1110     |  -0.082374 |     1.0732 |
+ | Upstream/vertex/typull                        | "ty pull"                                     |        668 |  0.0063102 | 1.1110     |  -0.081979 |     1.0735 |
  | Upstream/vertex/tyres                         | "ty resolution"                               |        668 | 9.1842e-06 | 0.00046658 |    0.52803 |     3.7897 |
  | Upstream/vertex/xpull                         | "x pull"                                      |        668 |  -0.024189 | 1.1796     | -0.0015231 |    0.86603 |
  | Upstream/vertex/xres                          | "x resolution / mm"                           |        668 | -0.0016581 | 0.040937   |   -0.53228 |      7.112 |
@@ -3661,11 +3661,11 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       6308 |    0.35353 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       6384 |    0.56176 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       4013 |  0.0020748 | 0.089224   |   0.044372 |   -0.49543 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       6337 |   0.005493 | 0.043996   |     -1.234 |     3.5077 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       6337 |  0.0054931 | 0.043996   |     -1.234 |     3.5077 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       6413 |   0.009039 | 0.054330   |     1.0457 |     7.9496 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       4013 | -0.0030179 | 0.090665   |   -0.15846 |   -0.95671 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       6337 |   -0.01874 | 0.077389   |   -0.74252 |    0.15492 |
- | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       6413 | -0.0025473 | 0.074673   |     1.0442 |     8.5154 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       4013 | -0.0030174 | 0.090665   |   -0.15846 |   -0.95671 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       6337 |  -0.018739 | 0.077389   |   -0.74252 |    0.15492 |
+ | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       6413 | -0.0025475 | 0.074674   |     1.0442 |     8.5154 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       6323 |  -0.083083 | 0.0000     |          0 |          0 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       6399 |    0.18409 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       6337 |    0.32148 | 0.0000     |          0 |          0 |
@@ -3705,10 +3705,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        693 |      14711 | 16948.     |     2.1429 |     4.8699 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        704 |    0.01071 | 1.8022     |   0.011669 |    -1.0369 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        693 |      12252 | 16262.     |     2.7832 |     8.5939 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        704 | -0.0060531 | 1.8085     |  -0.017738 |    -1.0172 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        704 | -0.0060532 | 1.8085     |  -0.017738 |    -1.0172 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        654 |     3.0899 | 0.88270    |    0.59192 |    -1.0147 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        693 |      12282 | 16098.     |     2.7453 |     8.4869 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        704 | -0.0061302 | 1.8316     |  -0.003101 |    -1.0499 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        704 | -0.0061304 | 1.8316     | -0.0031008 |    -1.0499 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |      13058 |     9638.1 | 10738.     |     1.6704 |     2.3298 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |      13057 |  -0.040157 | 1.7931     |   0.010899 |    -1.1739 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      13058 |     8270.4 | 10610.     |     1.9363 |     3.1661 |
@@ -3730,8 +3730,8 @@ TrackPV2HalfMonitor                    INFO 1D profile histograms in directory "
  | PV left-right delta z versus z                | "PV left-right delta z versus z"              |          2 |     66.227 | 19.641     |    0.38417 |    -1.8524 |
 TrackVPOverlapMonitor                  INFO 1D profile histograms in directory "TrackVPOverlapMonitor" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1876 |     363.74 | 178.58     |    0.23681 |    -1.4719 |
- | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1876 |     47.683 | 223.61     |    0.22817 |    -1.9481 |
+ | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1876 |     363.75 | 178.58     |    0.23681 |    -1.4719 |
+ | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1876 |     47.682 | 223.61     |    0.22817 |    -1.9481 |
 TrackVertexMonitor                     INFO 1D profile histograms in directory "TrackVertexMonitor" : 28
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | PV forward-backward delta x versus z          | "PV forward-backward delta x versus z"        |        426 |        159 | 0.0000     |          0 |          0 |
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
index d0135e5c284..32489aff68f 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_reco_2024_with_mcchecking.ref.x86_64_v3-opt
@@ -3542,12 +3542,12 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3072 |   0.001405 | 0.10915    |   -0.04493 |    -1.3231 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       5416 |  0.0025789 | 0.054895   |   0.027727 |     2.3571 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       5488 |  0.0010971 | 0.060562   |    0.17665 |     2.4274 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3072 | 0.00070193 | 0.12914    |   0.010595 |    -1.5936 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3072 | 0.00070191 | 0.12914    |   0.010595 |    -1.5936 |
  | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       5416 | 0.00048115 | 0.071419   |  -0.061376 |     1.2591 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       5488 | 0.00030798 | 0.076863   |    0.16307 |     1.0602 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3611 |   0.034153 | 0.14357    |   -0.87618 |    -1.4446 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3611 |   0.034153 | 0.14357    |   -0.87619 |    -1.4446 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       5934 |     0.1985 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       6006 | -0.0078105 | 0.12461    |    0.29258 |   -0.87773 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       6006 | -0.0078063 | 0.12461    |    0.29257 |   -0.87779 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3068 |  0.0017187 | 0.10881    |  -0.051248 |    -1.3174 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       5408 |  0.0025755 | 0.054290   | -0.0011839 |     2.4346 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       5480 |  0.0013325 | 0.059864   |     0.1584 |     2.4791 |
@@ -3557,7 +3557,7 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       5932 | -0.0013262 | 0.050411   |  -0.093551 |     2.4413 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       6004 |  0.0017233 | 0.053827   |   -0.15116 |     2.2811 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       5408 |  -0.011904 | 0.064724   |   -0.83011 |   -0.22494 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5480 |  0.0068274 | 0.072280   |   -0.46994 |    0.92825 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       5480 |   0.006828 | 0.072281   |   -0.46988 |    0.92827 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       9846 |   0.002028 | 0.18559    |  -0.037302 |   -0.73396 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2616 |  0.0026175 | 0.063222   |    0.60986 |      1.941 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2644 |   0.001627 | 0.060178   |   -0.60956 |     2.1419 |
@@ -3595,8 +3595,8 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        582 |     9104.3 | 11479.     |     3.5926 |     15.906 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        590 |   0.033838 | 1.8671     |   -0.04694 |     -1.098 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        537 |     2.6236 | 0.51537    |     1.3584 |     1.8751 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        582 |     5481.8 | 5373.8     |     5.9613 |     51.802 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        590 | -0.0018016 | 1.8703     |  -0.038206 |    -1.0641 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        582 |     5481.8 | 5373.9     |     5.9613 |     51.802 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        590 | -0.0018014 | 1.8703     |  -0.038206 |    -1.0641 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |      13070 |     9641.8 | 10742.     |     1.6715 |     2.3426 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |      13068 |  -0.040696 | 1.7932     |   0.011016 |    -1.1736 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      13070 |     8279.7 | 10615.     |     1.9329 |     3.1531 |
diff --git a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
index 513dba7ad6f..10ce6a69d58 100644
--- a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
@@ -53,13 +53,13 @@ fromV3TrackV1Track_6f234e16            INFO Number of counters : 1
  | "Nb of Produced Tracks"                         |      1000 |       6810 |     6.8100 |
 matching_consolidate_tracks            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_long_tracks_matching"                        |      1000 |      15371 |     15.371 |
+ | "n_long_tracks_matching"                        |      1000 |      15370 |     15.370 |
 pv_beamline_cleanup                    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_PVs"                                         |      1000 |       5079 |     5.0790 |
 scifi_consolidate_seeds                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_seed_tracks"                                 |      1000 |      47152 |     47.152 |
+ | "n_seed_tracks"                                 |      1000 |      47151 |     47.151 |
 scifi_consolidate_tracks               INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_forward"                         |      1000 |      34078 |     34.078 |
@@ -68,7 +68,7 @@ velo_consolidate_tracks                INFO Number of counters : 1
  | "n_velo_tracks"                                 |      1000 |     246878 |     246.88 |
 TransposeRawBanks_901cc252             INFO 1D histograms in directory "TransposeRawBanks_901cc252" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | ECal                                          | "ECal"                                        |      72000 |      157.5 | 0.0000     |-nan        |-nan        |
+ | ECal                                          | "ECal"                                        |      72000 |      157.5 | 0.0000     |          0 |          0 |
 TransposeRawBanks_abee1068             INFO 1D histograms in directory "TransposeRawBanks_abee1068" : 1
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | FTCluster                                     | "FTCluster"                                   |     240000 |     43.621 | 27.730     |     1.7421 |     4.0042 |
@@ -96,30 +96,30 @@ downstream_make_particles              INFO 1D histograms in directory "downstre
 is_muon_c92a16c2                       INFO 1D histograms in directory "is_muon_c92a16c2" : 3
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | n_muons                                       | "# muons"                                     |       6810 |    0.14229 | 0.34935    |     2.0479 |     2.1938 |
- | pv_x                                          | "pv_x"                                        |        642 |          2 | 0.0000     |-nan        |-nan        |
+ | pv_x                                          | "pv_x"                                        |        642 |          2 | 0.0000     |          0 |          0 |
  | pv_y                                          | "pv_y"                                        |        969 |     453.06 | 302.95     |     2.6228 |     22.408 |
 matching_consolidate_tracks            INFO 1D histograms in directory "matching_consolidate_tracks" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | long_track_ghost_prob                         | "GhostProb"                                   |      15371 |      0.141 | 0.12232    |     1.1158 |    0.35605 |
- | long_track_matching_eta                       | "#eta"                                        |      15371 |     3.8774 | 0.71669    |   -0.56844 |   -0.26373 |
- | long_track_matching_nhits                     | "N. hits / track"                             |      15371 |     24.567 | 3.4252     |   0.073154 |   -0.70842 |
- | long_track_matching_phi                       | "#phi"                                        |      15371 |   0.020404 | 1.7904     |  -0.026563 |    -1.1886 |
- | long_track_matching_qop                       | "q/p"                                         |      15371 |-1.6645e-06 | 0.00018882 |    0.02867 |    -1.3855 |
- | n_long_tracks_matching_event                  | "n_long_tracks_matching_event"                |       1000 |     15.371 | 10.971     |     1.1676 |     1.5396 |
+ | long_track_ghost_prob                         | "GhostProb"                                   |      15370 |    0.14101 | 0.12232    |     1.1157 |    0.35583 |
+ | long_track_matching_eta                       | "#eta"                                        |      15370 |     3.8775 | 0.71664    |   -0.56856 |   -0.26318 |
+ | long_track_matching_nhits                     | "N. hits / track"                             |      15370 |     24.567 | 3.4253     |    0.07307 |   -0.70852 |
+ | long_track_matching_phi                       | "#phi"                                        |      15370 |   0.020384 | 1.7904     |   -0.02653 |    -1.1887 |
+ | long_track_matching_qop                       | "q/p"                                         |      15370 |-1.6461e-06 | 0.00018882 |   0.028602 |    -1.3855 |
+ | n_long_tracks_matching_event                  | "n_long_tracks_matching_event"                |       1000 |      15.37 | 10.970     |     1.1678 |     1.5413 |
 pv_beamline_cleanup                    INFO 1D histograms in directory "pv_beamline_cleanup" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | n_pvs_event                                   | "n_pvs_event"                                 |       1000 |      5.079 | 2.1737     |    0.39579 |   -0.14695 |
- | n_smog2_PVs                                   | "n_smog2_PVs"                                 |       1000 |          0 | 0.0000     |-nan        |-nan        |
+ | n_smog2_PVs                                   | "n_smog2_PVs"                                 |       1000 |          0 | 0.0000     |          0 |          0 |
  | pv_x                                          | "pv_x"                                        |       5073 |     1.0923 | 0.028647   |   -0.15766 |     2.8989 |
  | pv_y                                          | "pv_y"                                        |       5073 |     0.4733 | 0.028514   |   -0.12287 |      2.051 |
  | pv_z                                          | "pv_z"                                        |       5073 |    0.45689 | 59.520     |  -0.036897 |   -0.11128 |
 scifi_consolidate_seeds                INFO 1D histograms in directory "scifi_consolidate_seeds" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     47.152 | 32.622     |     1.5837 |     4.3011 |
- | scifi_track_eta                               | "#eta"                                        |      47152 |      2.536 | 0.67358    |    0.68897 |    0.30964 |
- | scifi_track_nhits                             | "N. hits / track"                             |      47152 |     11.315 | 0.77787    |   -0.61157 |    -1.0962 |
- | scifi_track_phi                               | "#phi"                                        |      47152 |   0.011841 | 2.0901     | -0.0074469 |   -0.98744 |
- | scifi_track_qop                               | "q/p"                                         |      47152 | 1.2254e-06 | 0.00017911 |  0.0016186 |    -1.1154 |
+ | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     47.151 | 32.621     |     1.5838 |     4.3015 |
+ | scifi_track_eta                               | "#eta"                                        |      47151 |      2.536 | 0.67357    |    0.68904 |     0.3097 |
+ | scifi_track_nhits                             | "N. hits / track"                             |      47151 |     11.315 | 0.77786    |   -0.61162 |    -1.0961 |
+ | scifi_track_phi                               | "#phi"                                        |      47151 |    0.01184 | 2.0901     | -0.0074449 |   -0.98749 |
+ | scifi_track_qop                               | "q/p"                                         |      47151 | 1.2315e-06 | 0.00017911 |  0.0016036 |    -1.1154 |
 scifi_consolidate_tracks               INFO 1D histograms in directory "scifi_consolidate_tracks" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | long_track_forward_eta                        | "#eta"                                        |      34078 |     4.3558 | 0.55018    |  -0.050691 |   -0.35983 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
index e8de9be1cd5..26ed9d68165 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.armv8.1_a
@@ -3482,12 +3482,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       1146 |   0.028105 | 0.0031681  |     -2.578 |     7.0193 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       3168 | 2.7109e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      68339 |-3.0897e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      17298 |-3.9501e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      63777 |-2.6112e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      59093 |-8.7783e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       7018 | 2.1039e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       3168 | 1.3832e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      68339 |-3.3588e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      17298 |-4.7372e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      63777 |-2.6543e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      59093 |-8.9946e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       7018 | 2.4451e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       2519 |     1.1163 | 1.0183     |    0.93254 |     1.1765 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       2480 |   0.048167 | 0.0063227  |    -2.4421 |     6.7175 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 2d98e07cd52..a9fbac4d9f1 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -276,7 +276,7 @@ VeloTrackChecker_c566ca82              INFO   11_long_strange_P>3GeV_Pt>0.5GeV
 VeloTrackChecker_c566ca82              INFO
 TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Skip'     map has the size 5
    |                      Logical Volume                     |    |  #          mean             RMS          min              max    |
-   | BeforeMagnetRegion/Rich1/lvRich1Master                  | mm | 234     -421.26657          71.346342 -440.06263         -9.00129 |
+   | BeforeMagnetRegion/Rich1/lvRich1Master                  | mm | 234     -421.26658          71.346342 -440.06263         -9.00129 |
    | BeforeMagnetRegion/Rich1/lvRich1Master                  | X0 | 234     -5.2504283         0.94600884 -5.4970878       -0.0603029 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | mm | 25      -26.192842          21.187235 -70.819736         -2.73819 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 25      -0.064853601      0.068960807 -0.20541455      -0.0027133 |
@@ -296,9 +296,9 @@ TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has
    | BeforeMagnetRegion/Rich1/lvRich1Master                  | X0 | 406     6.202868            5.2761431 0                   11.0790 |
    | BeforeMagnetRegion/Rich1/lvRich1Mirror1Master           | mm | 36      2.9208662           1.9050048 0.087237537         6.78130 |
    | BeforeMagnetRegion/Rich1/lvRich1Mirror1Master           | X0 | 36      0.00015476907   0.00030596612 0               0.000886052 |
-   | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | mm | 521     35.858529           77.051625 0.90257604          315.107 |
-   | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 521     0.10113674         0.22021681 0                  0.903071 |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 27369   0.016639777       0.075410401 1.1822846e-11        5.0039 |
+   | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | mm | 521     35.858602           77.051759 0.90257604          315.107 |
+   | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 521     0.10113695          0.2202172 0                  0.903071 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 27369   0.016639776       0.075410397 1.1822846e-11        5.0039 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | X0 | 27369   0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter1             | mm | 2       0.3110806           0.3041024 0.0069781963       0.615182 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter1             | X0 | 2       0                           0 0                           |
@@ -312,15 +312,15 @@ TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter17            | X0 | 1       0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter18            | mm | 8       0.44893026         0.34063941 0.043698748        0.995122 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter18            | X0 | 8       0                           0 0                           |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | mm | 19      0.71107521          1.7208723 0.028409797         7.91680 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | mm | 19      0.7110758           1.7208748 0.028409797         7.91681 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | X0 | 19      0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter2             | mm | 2       0.28669968         0.12390844 0.16279125         0.410608 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter2             | X0 | 2       0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter20            | mm | 26      0.67642453         0.82459207 0.010770347         4.25188 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter20            | X0 | 26      0                           0 0                           |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter21            | mm | 17      0.47626238         0.41605675 0.014640923         1.65087 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter21            | mm | 17      0.47626143         0.41605683 0.014640923         1.65087 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter21            | X0 | 17      0                           0 0                           |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter22            | mm | 8       1.4460204           1.8434007 0.031283167         5.84330 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter22            | mm | 8       1.4462047           1.8433213 0.031283167         5.84330 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter22            | X0 | 8       0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter23            | mm | 1       0.00092832878   5.9029979e-12 0.00092832878   0.000928328 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter23            | X0 | 1       0                           0 0                           |
@@ -1355,9 +1355,9 @@ TrackBestTrackCreator_6b1be456         INFO Number of counters : 32
  | "Ttrack.ghostProbability"                       |      2804 |   266.0525 |   0.094883 |
  | "Ttrack.numOutliers"                            |      2804 |        900 |    0.32097 |
  |*"Upstream.badChisq"                             |       678 |        168 |( 24.77876 +- 1.658041)% |
- | "Upstream.chisqProbSum"                         |       678 |   222.1392 |    0.32764 |
+ | "Upstream.chisqProbSum"                         |       678 |   222.1393 |    0.32764 |
  |*"Upstream.flipCharge"                           |       678 |         14 |( 2.064897 +- 0.5461394)% |
- | "Upstream.ghostProbability"                     |       678 |   192.6862 |    0.28420 |
+ | "Upstream.ghostProbability"                     |       678 |   192.6863 |    0.28420 |
  | "Upstream.numOutliers"                          |       678 |        519 |    0.76549 |
  |*"Velo.badChisq"                                 |      5786 |       1329 |( 22.96924 +- 0.5529886)% |
  | "Velo.chisqProbSum"                             |      5786 |   1878.876 |    0.32473 |
@@ -1729,19 +1729,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      34954 |     0.0281 | 0.0023346  |    -2.5354 |     10.211 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      87024 |  2.681e-05 | 0.0014139  |  -0.014197 |    -1.0348 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      40053 | 1.2788e-05 | 0.0013712  |  0.0087572 |   -0.95406 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      87024 | 1.7393e-05 | 0.0014330  |    -0.0095 |    -1.0682 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51879 | 2.6396e-07 | 0.0014060  |   0.016002 |    -1.0202 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79569 | 5.3937e-05 | 0.0015301  |  -0.051283 |    -1.2435 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      36782 | 5.2991e-05 | 0.0015281  |  -0.046487 |    -1.2515 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79569 | 4.4534e-05 | 0.0015238  |  -0.042162 |    -1.2311 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      48143 | 3.8809e-05 | 0.0015237  |  -0.029557 |    -1.2412 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 |-3.1195e-05 | 0.0011236  |   0.055927 |   -0.44537 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3271 |-7.5169e-05 | 0.00093465 |   0.060959 |   -0.13967 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 |-3.1195e-05 | 0.0011236  |   0.055927 |   -0.44537 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 |-6.1146e-05 | 0.0011260  |   0.052459 |   -0.44229 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3736 | -0.0001159 | 0.00095892 |  0.0072496 |   -0.16478 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      87024 | 2.6691e-05 | 0.0014138  |    -0.0142 |    -1.0348 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      40053 | 1.2819e-05 | 0.0013712  |  0.0087604 |   -0.95405 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      87024 | 1.7285e-05 | 0.0014329  | -0.0094954 |    -1.0681 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51879 |  2.895e-07 | 0.0014060  |   0.016002 |    -1.0202 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79569 | 5.3744e-05 | 0.0015300  |  -0.051238 |    -1.2435 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      36782 | 5.3036e-05 | 0.0015281  |    -0.0465 |    -1.2515 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79569 | 4.4372e-05 | 0.0015237  |   -0.04213 |    -1.2311 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      48143 | 3.8843e-05 | 0.0015237  |  -0.029567 |    -1.2412 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 | -3.115e-05 | 0.0011237  |   0.056025 |   -0.44535 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3271 |-7.5169e-05 | 0.00093465 |    0.06095 |   -0.13966 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 | -3.115e-05 | 0.0011237  |   0.056025 |   -0.44535 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7455 |-6.1095e-05 | 0.0011260  |   0.052604 |   -0.44217 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3736 | -0.0001159 | 0.00095892 |  0.0072401 |   -0.16477 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      79569 |     3.1267 | 1.8102     |    0.01641 |    -1.1892 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7455 |     3.1393 | 1.8093     | -0.0015943 |     -1.203 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      79569 |   0.039175 | 0.011750   |   -0.64048 |   -0.62297 |
@@ -2298,67 +2298,67 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      90515 |   0.026983 | 0.0045019  |    -1.6248 |     2.3092 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44831 | 7.6436e-06 | 0.0014305  |  -0.010506 |    -1.0657 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      26440 |-7.8794e-06 | 0.0014008  |   0.016162 |    -1.0036 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44831 | 7.6436e-06 | 0.0014305  |  -0.010506 |    -1.0657 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44831 | 7.3593e-06 | 0.0014304  |  -0.010479 |    -1.0657 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      26440 |-7.8878e-06 | 0.0014008  |   0.016197 |    -1.0036 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44831 | 7.3593e-06 | 0.0014304  |  -0.010479 |    -1.0657 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         76 |   0.000286 | 0.0013067  |    0.61325 |     -1.095 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2264 | 0.00014816 | 0.0013711  |   -0.09425 |   -0.96525 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        325 | 0.00046884 | 0.0015743  |   -0.41464 |     -1.146 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        811 |-2.3045e-05 | 0.0015111  |   0.066892 |    -1.2823 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        325 | 0.00047219 | 0.0015772  |   -0.41407 |    -1.1506 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        811 |-5.2897e-05 | 0.0014937  |     0.0696 |    -1.2822 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1567 | 0.00045915 | 0.0014816  |   -0.43371 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2718 |-5.4431e-05 | 0.0015049  |  0.0085017 |    -1.2059 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2718 |-5.4325e-05 | 0.0015050  |  0.0085473 |     -1.206 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4485 | 4.8045e-05 | 0.0014772  |  -0.074621 |    -1.1463 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9599 |-7.8719e-06 | 0.0014287  | -0.0095006 |    -1.0643 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14211 |   -3.9e-05 | 0.0014246  |   0.039776 |    -1.0484 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8771 | -1.001e-05 | 0.0013930  |   0.014338 |   -0.97743 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9599 | -7.931e-06 | 0.0014287  | -0.0094408 |    -1.0643 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14211 |-3.9034e-05 | 0.0014246  |   0.039843 |    -1.0484 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8771 |-1.0074e-05 | 0.0013929  |    0.01445 |   -0.97728 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         76 |   0.000286 | 0.0013067  |    0.61325 |     -1.095 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2264 | 0.00014816 | 0.0013711  |   -0.09425 |   -0.96525 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        325 | 0.00046884 | 0.0015743  |   -0.41464 |     -1.146 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        811 |-2.3045e-05 | 0.0015111  |   0.066892 |    -1.2823 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        325 | 0.00047219 | 0.0015772  |   -0.41407 |    -1.1506 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        811 |-5.2897e-05 | 0.0014937  |     0.0696 |    -1.2822 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1567 | 0.00045915 | 0.0014816  |   -0.43371 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2718 |-5.4431e-05 | 0.0015049  |  0.0085017 |    -1.2059 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2718 |-5.4325e-05 | 0.0015050  |  0.0085473 |     -1.206 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4485 | 4.8045e-05 | 0.0014772  |  -0.074621 |    -1.1463 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9599 |-7.8719e-06 | 0.0014287  | -0.0095006 |    -1.0643 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14211 |   -3.9e-05 | 0.0014246  |   0.039776 |    -1.0484 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8771 | -1.001e-05 | 0.0013930  |   0.014338 |   -0.97743 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      87024 | 1.7393e-05 | 0.0014330  |    -0.0095 |    -1.0682 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51879 | 2.6396e-07 | 0.0014060  |   0.016002 |    -1.0202 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      87024 | 1.7393e-05 | 0.0014330  |    -0.0095 |    -1.0682 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9599 | -7.931e-06 | 0.0014287  | -0.0094408 |    -1.0643 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14211 |-3.9034e-05 | 0.0014246  |   0.039843 |    -1.0484 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8771 |-1.0074e-05 | 0.0013929  |    0.01445 |   -0.97728 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      87024 | 1.7285e-05 | 0.0014329  | -0.0094954 |    -1.0681 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51879 |  2.895e-07 | 0.0014060  |   0.016002 |    -1.0202 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      87024 | 1.7285e-05 | 0.0014329  | -0.0094954 |    -1.0681 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      87024 |     3.1278 | 1.8101     |   0.014868 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      87024 |    0.03979 | 0.011609   |   -0.72193 |   -0.50888 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42193 | 2.6951e-05 | 0.0014353  |  -0.008659 |    -1.0708 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25439 | 8.6235e-06 | 0.0014112  |    0.01558 |    -1.0371 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42193 | 2.6951e-05 | 0.0014353  |  -0.008659 |    -1.0708 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42193 | 2.7013e-05 | 0.0014353  | -0.0086828 |    -1.0708 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25439 | 8.6839e-06 | 0.0014112  |   0.015544 |    -1.0371 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42193 | 2.7013e-05 | 0.0014353  | -0.0086828 |    -1.0708 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         95 |  0.0001872 | 0.0013493  |    0.24582 |   -0.39558 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2140 | 1.1771e-05 | 0.0014256  |   -0.03279 |    -1.0743 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2140 | 1.1845e-05 | 0.0014256  |  -0.032915 |    -1.0744 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        334 |  0.0001209 | 0.0014033  |  -0.013848 |   -0.95024 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        723 | 0.00020061 | 0.0014594  |  -0.097409 |     -1.036 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1308 |-5.0899e-06 | 0.0014654  |   0.027379 |    -1.1152 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2371 | 1.9774e-05 | 0.0014802  |  0.0093906 |    -1.0994 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4565 |-5.6357e-05 | 0.0014537  |   0.035672 |    -1.1076 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8449 | 7.4815e-05 | 0.0014137  |  -0.030996 |    -1.0633 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13843 |  2.312e-05 | 0.0014503  | -0.0027524 |    -1.0928 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8349 | 1.7545e-05 | 0.0014117  | -0.0075525 |    -1.0117 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4565 |-5.6309e-05 | 0.0014536  |   0.035611 |    -1.1075 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8449 | 7.4942e-05 | 0.0014136  |  -0.030997 |    -1.0633 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13843 | 2.3169e-05 | 0.0014503  | -0.0027924 |    -1.0927 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8349 | 1.7575e-05 | 0.0014117  | -0.0075095 |    -1.0117 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         95 |  0.0001872 | 0.0013493  |    0.24582 |   -0.39558 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2140 | 1.1771e-05 | 0.0014256  |   -0.03279 |    -1.0743 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2140 | 1.1845e-05 | 0.0014256  |  -0.032915 |    -1.0744 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        334 |  0.0001209 | 0.0014033  |  -0.013848 |   -0.95024 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        723 | 0.00020061 | 0.0014594  |  -0.097409 |     -1.036 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1308 |-5.0899e-06 | 0.0014654  |   0.027379 |    -1.1152 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2371 | 1.9774e-05 | 0.0014802  |  0.0093906 |    -1.0994 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4565 |-5.6357e-05 | 0.0014537  |   0.035672 |    -1.1076 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8449 | 7.4815e-05 | 0.0014137  |  -0.030996 |    -1.0633 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13843 |  2.312e-05 | 0.0014503  | -0.0027524 |    -1.0928 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8349 | 1.7545e-05 | 0.0014117  | -0.0075525 |    -1.0117 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4565 |-5.6309e-05 | 0.0014536  |   0.035611 |    -1.1075 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8449 | 7.4942e-05 | 0.0014136  |  -0.030997 |    -1.0633 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13843 | 2.3169e-05 | 0.0014503  | -0.0027924 |    -1.0927 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8349 | 1.7575e-05 | 0.0014117  | -0.0075095 |    -1.0117 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 43
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8822e-05 | 0.0014027  |   0.032858 |    -1.0093 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8822e-05 | 0.0014027  |   0.032858 |    -1.0093 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8822e-05 | 0.0014027  |   0.032858 |    -1.0093 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8809e-05 | 0.0014028  |   0.032867 |    -1.0093 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8809e-05 | 0.0014028  |   0.032867 |    -1.0093 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      16856 |-1.8809e-05 | 0.0014028  |   0.032867 |    -1.0093 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1337 | 0.00016921 | 0.0014113  |  -0.055575 |    -1.0462 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010192 | 0.0011017  |    0.42769 |   -0.93592 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 | -0.0004784 | 0.0014911  |     0.4795 |    -1.0311 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 |-0.00036029 | 0.0015130  |    0.49561 |   -0.90184 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 |-0.00043306 | 0.0011829  |    0.31783 |   -0.70506 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 |-0.00043225 | 0.0011843  |    0.32078 |   -0.70267 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        609 |-1.3289e-05 | 0.0013763  |   0.038599 |   -0.98556 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3272 |-6.0619e-05 | 0.0014011  |   0.043547 |    -1.0101 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6711 |-2.0495e-05 | 0.0014084  |   0.028661 |    -1.0059 |
@@ -2367,27 +2367,27 @@ RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010192 | 0.0011017  |    0.42769 |   -0.93592 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 | -0.0004784 | 0.0014911  |     0.4795 |    -1.0311 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 |-0.00036029 | 0.0015130  |    0.49561 |   -0.90184 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 |-0.00043306 | 0.0011829  |    0.31783 |   -0.70506 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 |-0.00043225 | 0.0011843  |    0.32078 |   -0.70267 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        609 |-1.3289e-05 | 0.0013763  |   0.038599 |   -0.98556 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3272 |-6.0619e-05 | 0.0014011  |   0.043547 |    -1.0101 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6711 |-2.0495e-05 | 0.0014084  |   0.028661 |    -1.0059 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4601 |-1.0065e-07 | 0.0013920  |   0.013181 |   -0.99678 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35612 |-7.1253e-06 | 0.0013985  |   0.021979 |    -1.0045 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35612 |-7.1253e-06 | 0.0013985  |   0.021979 |    -1.0045 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35612 |-7.1253e-06 | 0.0013985  |   0.021979 |    -1.0045 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35612 |-7.1133e-06 | 0.0013985  |   0.021972 |    -1.0046 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35612 |-7.1133e-06 | 0.0013985  |   0.021972 |    -1.0046 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35612 |-7.1133e-06 | 0.0013985  |   0.021972 |    -1.0046 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      35612 |      3.124 | 1.8139     |   0.015004 |    -1.1973 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      35612 |   0.039582 | 0.011688   |   -0.70407 |   -0.51777 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9685e-06 | 0.0013948  |    0.01268 |    -1.0001 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9685e-06 | 0.0013948  |    0.01268 |    -1.0001 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9685e-06 | 0.0013948  |    0.01268 |    -1.0001 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1288 | -9.757e-06 | 0.0013971  |   0.028326 |     -1.049 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9798e-06 | 0.0013948  |   0.012661 |    -1.0001 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9798e-06 | 0.0013948  |   0.012661 |    -1.0001 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18756 | 2.9798e-06 | 0.0013948  |   0.012661 |    -1.0001 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1288 |-9.6443e-06 | 0.0013971  |    0.02813 |    -1.0493 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         41 | -0.0010289 | 0.0015855  |     1.4279 |    0.72845 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.2873e-05 | 0.0012988  |    0.13625 |     -0.742 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        987 |-0.00011817 | 0.0013824  |    0.15387 |   -0.93589 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4000 | 8.9814e-05 | 0.0013875  |  -0.015314 |    -1.0112 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7451 |-1.0361e-05 | 0.0014089  |  -0.018621 |    -1.0245 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4789 |-3.2704e-05 | 0.0013796  |   0.036457 |   -0.93898 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1288 | -9.757e-06 | 0.0013971  |   0.028326 |     -1.049 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1288 |-9.6443e-06 | 0.0013971  |    0.02813 |    -1.0493 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         41 | -0.0010289 | 0.0015855  |     1.4279 |    0.72845 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.2873e-05 | 0.0012988  |    0.13625 |     -0.742 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        987 |-0.00011817 | 0.0013824  |    0.15387 |   -0.93589 |
@@ -2583,7 +2583,7 @@ RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        451 |    0.96847 | 17.747     |   -0.27244 |  -0.024476 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        483 |     -17.87 | 16.241     |   -0.17153 |   -0.88743 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        451 |     1.3023 | 16.873     |   -0.31696 |    0.32662 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        482 |    -4.9378 | 8.9770     |   -0.33645 |     3.2593 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        482 |    -4.9357 | 8.9837     |    -0.3292 |     3.2718 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        451 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        451 |     1.2472 | 17.609     |   -0.24702 |   0.006495 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2618,7 +2618,7 @@ RichMassRingsUpstream                  INFO 1D histograms in directory "RichMass
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1392 |  -0.024138 | 0.20141    |    0.32749 |    -1.6778 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      44568 |   0.010817 | 0.65109    |     0.5907 |     80.543 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12776 |  -0.020539 | 0.21867    |    0.11636 |   -0.86806 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12776 |  -0.020507 | 0.21868    |    0.11605 |    -0.8682 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      39176 |  0.0025084 | 0.53172    |   -0.41808 |     144.38 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      34240 |-0.00025134 | 0.44639    |    0.83338 |       33.1 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5424 |  -0.020206 | 0.20177    |    0.20735 |    -1.7414 |
@@ -2988,7 +2988,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        554 |      14478 | 16897.     |     2.3365 |     6.1506 |
  | Upstream/phi                                  | "phi"                                         |        554 |  -0.048088 | 1.7992     |   0.057989 |    -1.0536 |
  | Upstream/probChi2                             | "probChi2"                                    |        554 |    0.40141 | 0.32318    |    0.41631 |    -1.2142 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        554 |      14480 | 16744.     |     2.4948 |     7.4644 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        554 |      14484 | 16746.     |     2.4934 |     7.4572 |
  | Upstream/pt                                   | "pt"                                          |        554 |     848.38 | 555.98     |     2.9816 |     12.002 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        554 | 2.8881e-06 | 0.00021137 |   0.021041 |   -0.53764 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        554 |    -4.7575 | 0.39529    |   -0.07737 |    -1.0939 |
@@ -3142,7 +3142,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | ALL/probChi2                                  | "probChi2"                                    |      19792 |    0.39805 | 0.31954    |    0.40176 |    -1.1889 |
  | ALL/truemom                                   | "true p [GeV]"                                |      19792 |     7.1117 | 8.4919     |     2.2313 |     5.3643 |
  | ALL/truept                                    | "true pT [GeV]"                               |      19792 |    0.45914 | 0.45433    |     3.3005 |     23.075 |
- | ALL/vertex/dpoverp                            | "dp/p"                                        |      19792 |-0.00018539 | 0.015204   |    0.11744 |     2.9743 |
+ | ALL/vertex/dpoverp                            | "dp/p"                                        |      19792 |-0.00018524 | 0.015204   |    0.11762 |     2.9742 |
  | ALL/vertex/expecteddpoverp                    | "expected dp/p"                               |      19792 |  0.0030862 | 0.00083194 |     2.6679 |     8.8159 |
  | ALL/vertex/ppull                              | "p pull"                                      |      19792 |  -0.054645 | 0.89192    |    0.33412 |     7.3133 |
  | ALL/vertex/qop_res                            | "qop"                                         |      19792 |-5.4189e-05 | 0.0057492  |   -0.10533 |     2.1062 |
@@ -3377,7 +3377,7 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7455 |     7905.7 | 10616.     |     4.9208 |     37.702 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        483 |      61402 | 26296.     |    0.95748 |   -0.50862 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        483 |      61402 | 26296.     |    0.95748 |   -0.50861 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        483 |      10774 | 12788.     |     3.7568 |     21.064 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        483 |      24725 | 16875.     |      2.994 |     11.158 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        483 |      11796 | 13318.     |     3.5887 |      19.18 |
@@ -3436,11 +3436,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |          8 |      18934 | 8263.8     |   -0.55182 |    -0.7941 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |          8 |     -89395 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         88 |      17121 | 10037.     |    0.40056 |   -0.61355 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         88 |      25669 | 7157.2     |    -0.3736 |    0.87771 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         88 |      25669 | 7157.2     |   -0.37362 |    0.87776 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        301 |      20292 | 18019.     |     2.1152 |     5.7882 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        301 |      67893 | 34392.     |   -0.79342 |    -0.8854 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        301 |      67892 | 34392.     |   -0.79341 |   -0.88542 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         50 |      26084 | 18704.     |    0.52138 |   -0.82803 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         50 |      33374 | 14660.     |    -1.0663 |    0.20216 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         50 |      33374 | 14660.     |    -1.0662 |    0.20211 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         11 |      52894 | 9032.0     |   -0.49286 |     -1.213 |
@@ -3471,7 +3471,7 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        344 |      54998 | 16341.     |    0.73095 |   -0.35571 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      61998 | 22789.     |    0.59448 |    -1.3066 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      61998 | 22789.     |    0.59447 |    -1.3066 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        482 |      10420 | 11722.     |     3.2841 |     16.192 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        171 |      25467 | 15421.     |     2.5432 |     8.1725 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        481 |      12181 | 12521.     |     3.0183 |     13.732 |
@@ -3507,7 +3507,7 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        359 |      54808 | 16371.     |    0.73496 |   -0.34545 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      61403 | 22778.     |     0.6297 |    -1.2576 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      61403 | 22778.     |    0.62969 |    -1.2576 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        482 |      10420 | 11722.     |     3.2841 |     16.192 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        176 |      25382 | 15400.     |     2.5465 |     8.2078 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        481 |      12149 | 12509.     |     3.0218 |     13.764 |
@@ -3543,7 +3543,7 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        344 |      55084 | 16387.     |    0.72846 |   -0.36363 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      62473 | 23053.     |    0.54016 |    -1.3736 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         25 |      62473 | 23053.     |    0.54016 |    -1.3737 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        482 |      10539 | 11792.     |     3.2457 |     15.853 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        171 |      25581 | 15470.     |     2.5204 |     8.0481 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        481 |      12296 | 12573.     |     2.9885 |     13.499 |
@@ -3587,12 +3587,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       8090 |   0.027915 | 0.0028353  |    -2.3588 |     7.2727 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1392 | 5.9535e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      44568 |-3.3795e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12776 |-1.0788e+15 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      39176 |-2.2201e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      34240 | 2.0655e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5424 | 2.7864e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1392 |-3.1243e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      44568 |-4.6677e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12776 | 7.2515e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      39176 |-7.8034e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      34240 | 1.6199e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5424 |  1.272e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1698 |     1.0775 | 0.93076    |    0.49703 |    -0.1866 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1663 |   0.047617 | 0.0071669  |    -2.1467 |     4.7155 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -3777,20 +3777,20 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3073 |  -0.081546 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4898 |  -0.093984 | 0.073508   |     5.7809 |     30.561 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4953 |   -0.11463 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3073 |  -0.023259 | 0.065587   |     3.9676 |      1.126 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4898 |  0.0078856 | 0.10532    |    0.98976 |    0.67319 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4953 |   0.067516 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3075 |   -0.15872 | 0.036601   |    -13.544 |    -204.07 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4894 |    0.38516 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4949 |   -0.33767 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3071 |  -0.053595 | 0.032269   |     40.633 |     296.46 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4896 |  -0.093725 | 0.10491    |     3.7586 |     10.854 |
- | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4951 |   -0.13575 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3071 |     1.3325 | 0.0000     |          0 |          0 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3073 |  -0.023258 | 0.065587   |     3.9676 |     1.1259 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4898 |  0.0078855 | 0.10532    |    0.98976 |     0.6732 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4953 |   0.067515 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3075 |   -0.15872 | 0.036600   |    -13.545 |    -204.08 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4894 |    0.38517 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4949 |   -0.33768 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3071 |  -0.053595 | 0.032268   |     40.638 |     296.51 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4896 |  -0.093726 | 0.10491    |     3.7587 |     10.854 |
+ | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4951 |   -0.13576 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3071 |     1.3324 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4896 |   -0.28869 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4951 |   -0.23233 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4888 |    0.48541 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4943 |   -0.96813 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4888 |    0.48544 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4943 |   -0.96816 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4896 |    -0.1222 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4951 |    0.87292 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       8260 | -0.0010343 | 0.18564    |   0.041119 |   -0.71207 |
@@ -3827,7 +3827,7 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        554 | -0.0058574 | 1.7961     |  -0.016259 |    -1.0181 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        518 |     3.0746 | 0.87261    |    0.57951 |    -1.0025 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        547 |      11692 | 15260.     |     2.9351 |     10.203 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        554 |  0.0050314 | 1.7842     | 0.00012956 |   -0.99174 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        554 |  0.0050313 | 1.7842     | 0.00012956 |   -0.99174 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       5785 |     7791.7 | 11877.     |     1.9142 |     2.6028 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       5786 |   -0.10799 | 1.8112     |   0.020844 |    -1.1699 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       3941 |     3.0601 | 0.91824    |    0.72479 |   -0.82856 |
@@ -3846,7 +3846,7 @@ TrackPV2HalfMonitor                    INFO 1D profile histograms in directory "
 TrackVPOverlapMonitor                  INFO 1D profile histograms in directory "TrackVPOverlapMonitor" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1004 |     345.15 | 138.33     |      1.099 |    -2.7396 |
- | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1004 |    0.95204 | 104.34     |    -11.532 |    -99.082 |
+ | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1004 |    0.95199 | 104.34     |    -11.532 |    -99.082 |
 TrackVertexMonitor                     INFO 1D profile histograms in directory "TrackVertexMonitor" : 28
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | PV forward-backward delta x versus z          | "PV forward-backward delta x versus z"        |        352 |     160.97 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
index a182ac43eb7..31d87be836d 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_full_geometry_with_mcchecking.ref.x86_64_v3-opt
@@ -3484,10 +3484,10 @@ RichMassRingsUpstream                  INFO 1D profile histograms in directory "
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       2984 |-5.6254e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      66240 | 1.3542e+14 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      16376 | 2.2227e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      16376 | 2.2362e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      60640 |  3.468e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      56272 | 1.3241e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       6600 |-1.4716e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       6600 |-2.1158e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       2529 |     1.1157 | 1.0174     |    0.93084 |     1.1754 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       2490 |   0.048165 | 0.0063244  |     -2.436 |     6.6593 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
index 25c4fc3648d..d43d440a6c7 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref
@@ -3910,10 +3910,10 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1636 | 2.8422e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42172 | 1.3714e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42172 | 1.3207e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10652 |-1.0258e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37136 | -9.613e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31692 | 1.7977e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37136 |-9.5242e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31692 | 1.7714e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4720 | 4.1012e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1535 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1509 |    0.04746 | 0.0072297  |    -2.0162 |     4.0918 |
@@ -4121,7 +4121,7 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4466 | -0.0011674 | 0.053299   |  -0.053878 |     1.7258 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4521 |  0.0085564 | 0.057377   |    0.45197 |     1.7021 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4163 | -0.0060496 | 0.061149   |    -1.0336 |    -1.5705 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4217 |   0.026419 | 0.070252   |    0.69554 |   0.015488 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4217 |   0.026419 | 0.070252   |    0.69554 |   0.015489 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7844 |  0.0012001 | 0.18949    |  -0.031638 |   -0.79388 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2124 |   0.002527 | 0.063034   |    0.56526 |     1.9258 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2105 |-6.2453e-05 | 0.062549   |   -0.70679 |     2.0194 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
index 81b1a04d734..805a6f32e78 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.armv8.1_a
@@ -1284,7 +1284,7 @@ TrackBestTrackCreator_6218465d         INFO Number of counters : 32
  |*"Upstream.badChisq"                             |       816 |        455 |( 55.75980 +- 1.738698)% |
  | "Upstream.chisqProbSum"                         |       816 |   128.5162 |    0.15750 |
  |*"Upstream.flipCharge"                           |       816 |         37 |( 4.534314 +- 0.7283403)% |
- | "Upstream.ghostProbability"                     |       816 |   417.8332 |    0.51205 |
+ | "Upstream.ghostProbability"                     |       816 |    417.833 |    0.51205 |
  | "Upstream.numOutliers"                          |       816 |       1019 |     1.2488 |
  |*"Velo.badChisq"                                 |      6084 |       1364 |( 22.41946 +- 0.5346805)% |
  | "Velo.chisqProbSum"                             |      6084 |   1956.208 |    0.32153 |
@@ -1664,19 +1664,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      30158 |   0.027964 | 0.0023061  |    -2.4406 |     9.5013 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      74303 | 2.4812e-05 | 0.0014506  |  -0.019115 |    -1.1206 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      29996 |  1.318e-05 | 0.0014194  | -0.0048927 |    -1.0597 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38576 | 1.5281e-05 | 0.0014369  | -0.0099208 |    -1.0896 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 1.3249e-05 | 0.0015273  | -0.0097766 |    -1.2362 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27029 |  1.022e-05 | 0.0015425  | -0.0083074 |    -1.2547 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 2.9424e-05 | 0.0015121  |  -0.020414 |    -1.2136 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35430 | 2.9764e-05 | 0.0015225  |   -0.02345 |    -1.2258 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1171e-05 | 0.0012578  |   -0.02643 |   -0.84227 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.8886e-05 | 0.0011454  |    0.02401 |   -0.67009 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1171e-05 | 0.0012578  |   -0.02643 |   -0.84227 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.2615e-05 | 0.0012796  |  -0.027909 |    -0.8641 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.3696e-05 | 0.0011751  |  0.0028078 |   -0.69373 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      74303 | 2.4683e-05 | 0.0014507  |   -0.01912 |    -1.1206 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      29996 |  1.295e-05 | 0.0014196  | -0.0048983 |    -1.0598 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38576 | 1.5105e-05 | 0.0014371  | -0.0099464 |    -1.0897 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 1.2814e-05 | 0.0015273  | -0.0097163 |    -1.2362 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27029 | 9.3832e-06 | 0.0015425  | -0.0081363 |    -1.2547 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 2.9097e-05 | 0.0015121  |   -0.02038 |    -1.2136 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35430 | 2.9137e-05 | 0.0015226  |  -0.023388 |    -1.2258 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1733e-05 | 0.0012582  |   -0.02595 |   -0.84192 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9823e-05 | 0.0011463  |   0.025554 |   -0.66887 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1733e-05 | 0.0012582  |   -0.02595 |   -0.84192 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.3236e-05 | 0.0012800  |  -0.027392 |   -0.86374 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2645e-05 | 0.0011760  |  0.0044794 |   -0.69236 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      67395 |     3.1168 | 1.8129     |   0.028477 |    -1.1976 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       6908 |     3.1343 | 1.7895     | -0.0025063 |    -1.1838 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      67395 |   0.039682 | 0.011520   |   -0.67564 |    -0.5459 |
@@ -2229,37 +2229,37 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      35705 |   0.027179 | 0.0043058  |    -1.7269 |     2.7581 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 |  5.731e-06 | 0.0014547  |  -0.012863 |    -1.1208 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18444 |-1.4277e-05 | 0.0014387  |   0.017776 |    -1.0868 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 |  5.731e-06 | 0.0014547  |  -0.012863 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 | 5.5102e-06 | 0.0014549  |  -0.012859 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18444 |-1.4695e-05 | 0.0014390  |   0.017739 |    -1.0868 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 | 5.5102e-06 | 0.0014549  |  -0.012859 |    -1.1208 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7464e-05 | 0.0014383  |  -0.094991 |    -1.0964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7571e-05 | 0.0014381  |  -0.094644 |    -1.0968 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        803 | 0.00027761 | 0.0016222  |   -0.21451 |    -1.4353 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1593 | 0.00013605 | 0.0014822  |   -0.10605 |    -1.2166 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2756 |-8.9289e-05 | 0.0013763  |   0.059504 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4621 | 2.8814e-05 | 0.0014318  |  -0.041701 |    -1.1196 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3343e-05 | 0.0014612  |   0.037782 |    -1.1388 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.8717e-05 | 0.0014532  |  -0.027857 |    -1.0929 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4474e-05 | 0.0014769  | -0.0097939 |    -1.1465 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3318e-05 | 0.0014612  |    0.03801 |    -1.1391 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.7768e-05 | 0.0014538  |  -0.028112 |    -1.0926 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4127e-05 | 0.0014771  | -0.0098002 |    -1.1462 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7464e-05 | 0.0014383  |  -0.094991 |    -1.0964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7571e-05 | 0.0014381  |  -0.094644 |    -1.0968 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        803 | 0.00027761 | 0.0016222  |   -0.21451 |    -1.4353 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1593 | 0.00013605 | 0.0014822  |   -0.10605 |    -1.2166 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2756 |-8.9289e-05 | 0.0013763  |   0.059504 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4621 | 2.8814e-05 | 0.0014318  |  -0.041701 |    -1.1196 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3343e-05 | 0.0014612  |   0.037782 |    -1.1388 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.8717e-05 | 0.0014532  |  -0.027857 |    -1.0929 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4474e-05 | 0.0014769  | -0.0097939 |    -1.1465 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38576 | 1.5281e-05 | 0.0014369  | -0.0099208 |    -1.0896 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3318e-05 | 0.0014612  |    0.03801 |    -1.1391 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.7768e-05 | 0.0014538  |  -0.028112 |    -1.0926 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4127e-05 | 0.0014771  | -0.0098002 |    -1.1462 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38576 | 1.5105e-05 | 0.0014371  | -0.0099464 |    -1.0897 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      74303 |     3.1184 | 1.8108     |   0.025635 |    -1.1963 |
- | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      74303 |   0.040306 | 0.011379   |    -0.7568 |   -0.42674 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1632e-05 | 0.0014592  |  -0.030573 |    -1.1382 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20132 | 3.9762e-05 | 0.0014350  |  -0.032782 |      -1.09 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1632e-05 | 0.0014592  |  -0.030573 |    -1.1382 |
+ | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      74303 |   0.040306 | 0.011379   |    -0.7568 |   -0.42675 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1661e-05 | 0.0014592  |  -0.030565 |    -1.1383 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20132 | 3.9792e-05 | 0.0014351  |  -0.032795 |    -1.0901 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1661e-05 | 0.0014592  |  -0.030565 |    -1.1383 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1745 |-4.1036e-05 | 0.0014340  |   0.070176 |    -1.0405 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2267,9 +2267,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1204 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2230 | 9.1032e-05 | 0.0015193  |   -0.10595 |    -1.1853 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4436 | 9.1789e-05 | 0.0014691  |  -0.077864 |    -1.1354 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012753 | 0.0014610  |  -0.093498 |    -1.1231 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 | 8.4941e-06 | 0.0014707  |   0.012916 |    -1.1601 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.864e-06 | 0.0014185  |   0.014278 |    -1.1066 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012756 | 0.0014610  |  -0.093627 |    -1.1232 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 |   8.59e-06 | 0.0014707  |   0.013019 |    -1.1601 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.832e-06 | 0.0014186  |   0.014314 |    -1.1068 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1745 |-4.1036e-05 | 0.0014340  |   0.070176 |    -1.0405 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2277,9 +2277,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1204 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2230 | 9.1032e-05 | 0.0015193  |   -0.10595 |    -1.1853 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4436 | 9.1789e-05 | 0.0014691  |  -0.077864 |    -1.1354 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012753 | 0.0014610  |  -0.093498 |    -1.1231 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 | 8.4941e-06 | 0.0014707  |   0.012916 |    -1.1601 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.864e-06 | 0.0014185  |   0.014278 |    -1.1066 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012756 | 0.0014610  |  -0.093627 |    -1.1232 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 |   8.59e-06 | 0.0014707  |   0.013019 |    -1.1601 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.832e-06 | 0.0014186  |   0.014314 |    -1.1068 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4964 | 4.8279e-05 | 0.0014427  |  -0.047219 |    -1.1071 |
@@ -2423,7 +2423,7 @@ RiTkGeomEffsLong                       INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsLong/Rich2Gas/proton/eff    | "Rich2Gas proton Geom. Eff. (>0)"             |        204 |    0.67353 | 0.072225   |     -1.047 |     2.3952 |
 RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeomEffsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |    0.66208 | 0.057914   |    0.44316 |   -0.47724 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |     0.6625 | 0.057753   |    0.42844 |   -0.46343 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        446 |    0.66469 | 0.055122   |     -1.803 |     6.4691 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        142 |    0.67521 | 0.050969   |   -0.66295 |     1.2811 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        446 |    0.66839 | 0.060894   |    -1.7928 |     5.8414 |
@@ -2470,7 +2470,7 @@ RiTkSignalYieldsLong                   INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0);Photon..." |        204 |     16.596 | 10.727     |    0.11302 |    -1.2396 |
 RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |       30.6 | 18.865     |   0.093038 |     -1.283 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |     30.633 | 18.898     |   0.092182 |     -1.289 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        446 |     59.708 | 5.2691     |    -1.4865 |     5.2887 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        142 |      38.13 | 16.988     |   -0.61475 |   -0.55268 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        446 |     46.488 | 13.094     |   -0.76863 |   -0.24556 |
@@ -2497,10 +2497,10 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        407 |     3.2337 | 17.266     |   -0.22166 |    0.39055 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        407 |     3.1181 | 17.183     |   -0.21845 |    0.46088 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        407 |     3.1156 | 17.186     |   -0.21867 |    0.45945 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        446 |    -18.546 | 17.644     |     0.1269 |   -0.41857 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        407 |     2.9131 | 16.376     |    -0.3619 |     0.7888 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        446 |    -4.6416 | 10.308     |   0.099241 |     3.4028 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        446 |    -4.6416 | 10.308     |   0.099298 |     3.4023 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        407 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        407 |     3.3317 | 17.120     |   -0.24899 |    0.49546 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2534,11 +2534,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 |  -0.019332 | 0.22474    |    0.18048 |   -0.64885 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |   0.020863 | 0.70798    |     2.4255 |     66.962 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |   0.020854 | 0.70798    |     2.4256 |     66.964 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |  -0.011041 | 0.22914    |   0.045132 |   -0.16426 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 |  0.0012661 | 0.53541    |   -0.02214 |     116.74 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 |   0.012981 | 0.52763    |      4.456 |     61.303 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |  -0.017112 | 0.22088    |      0.114 |    -0.8024 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 |  0.0012555 | 0.53540    |  -0.022118 |     116.75 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 |   0.012969 | 0.52762    |     4.4562 |     61.308 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |  -0.017195 | 0.22088    |    0.11482 |   -0.80207 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichPIDMonDownstream10to70/evOK         | "Event Success V Failures;Event has PIDs;..." |         89 |    0.97753 | 0.14821    |    -6.4438 |     39.523 |
@@ -3321,10 +3321,10 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Ttrack/vertex/xres                            | "x resolution / mm"                           |       2666 |  -0.018245 | 0.19905    |    0.25145 |   -0.75857 |
  | Ttrack/vertex/ypull                           | "y pull"                                      |       2666 |  -0.074903 | 1.4458     |  0.0024396 |    0.79439 |
  | Ttrack/vertex/yres                            | "y resolution / mm"                           |       2666 |  -0.027067 | 0.23411    |    0.13774 |    -1.1484 |
- | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        457 | -0.0072066 | 0.027949   |    0.23503 |    -1.1395 |
+ | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        457 | -0.0071904 | 0.027934   |    0.23504 |    -1.1379 |
  | Upstream/BegRich1/ppull                       | "p pull"                                      |        457 |   -0.39839 | 1.8807     |   0.076425 |   -0.16636 |
  | Upstream/BegRich1/qoppull                     | "qop pull"                                    |        457 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/BegRich1/txpull                      | "tx pull"                                     |        457 |   -0.73152 | 2.9746     |    0.37981 |    -1.1696 |
+ | Upstream/BegRich1/txpull                      | "tx pull"                                     |        457 |   -0.73056 | 2.9744     |    0.37896 |    -1.1696 |
  | Upstream/BegRich1/txres                       | "tx resolution"                               |        457 | 0.00034687 | 0.0011067  |   -0.61363 |   0.048765 |
  | Upstream/BegRich1/typull                      | "ty pull"                                     |        457 |    0.33244 | 1.8684     |-0.00075447 |   -0.17659 |
  | Upstream/BegRich1/tyres                       | "ty resolution"                               |        457 | 0.00012952 | 0.00071169 |   0.033209 |     1.7982 |
@@ -3352,7 +3352,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/EndVelo/tyres                        | "ty resolution"                               |        457 | 7.3272e-05 | 0.00050452 |   0.071926 |      3.968 |
  | Upstream/EndVelo/xpull                        | "x pull"                                      |        457 |    -2.0045 | 2.0494     |    0.69107 |    0.02111 |
  | Upstream/EndVelo/xres                         | "x resolution / mm"                           |        457 |   -0.11446 | 0.18374    |    0.49369 |   -0.39519 |
- | Upstream/EndVelo/ypull                        | "y pull"                                      |        457 |     -1.783 | 1.5853     |    0.37098 |    0.54827 |
+ | Upstream/EndVelo/ypull                        | "y pull"                                      |        457 |    -1.7826 | 1.5847     |    0.37228 |    0.54997 |
  | Upstream/EndVelo/yres                         | "y resolution / mm"                           |        457 |   -0.20358 | 0.17552    |      1.116 |    0.55203 |
  | Upstream/FirstMeasurement/dpoverp             | "dp/p"                                        |        454 | -0.0062165 | 0.028237   |    0.22555 |     -1.096 |
  | Upstream/FirstMeasurement/ppull               | "p pull"                                      |        454 |   -0.40052 | 1.8625     |   0.087453 |   -0.14896 |
@@ -3382,7 +3382,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/vertex/dpoverp                       | "dp/p"                                        |        457 | -0.0068828 | 0.028296   |    0.24947 |    -1.1087 |
  | Upstream/vertex/ppull                         | "p pull"                                      |        457 |   -0.40308 | 1.8774     |   0.077028 |   -0.15839 |
  | Upstream/vertex/qoppull                       | "qop pull"                                    |        457 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/vertex/txpull                        | "tx pull"                                     |        457 |   -0.01484 | 1.1072     |   -0.29855 |     2.1214 |
+ | Upstream/vertex/txpull                        | "tx pull"                                     |        457 |  -0.014619 | 1.1069     |   -0.29826 |     2.1252 |
  | Upstream/vertex/txres                         | "tx resolution"                               |        457 |-1.9671e-06 | 0.00051975 |   -0.17521 |     2.9963 |
  | Upstream/vertex/typull                        | "ty pull"                                     |        457 | -0.0048191 | 1.0650     |   -0.27087 |     1.8233 |
  | Upstream/vertex/tyres                         | "ty resolution"                               |        457 |-9.5957e-06 | 0.00047744 |      0.124 |     2.3018 |
@@ -3701,7 +3701,7 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.9 | 10659.     |     4.1659 |      23.78 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        441 |      58419 | 19160.     |    0.95676 |   -0.20549 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        441 |      58419 | 19160.     |    0.95677 |    -0.2055 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        441 |     9703.7 | 11682.     |     3.4812 |     16.703 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        441 |      24537 | 16033.     |     2.2978 |     6.2822 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        441 |      10683 | 12249.     |     3.2741 |     14.742 |
@@ -3758,13 +3758,13 @@ RiMCTkResLong                          INFO 1D profile histograms in directory "
 RiMCTkResUpstream                      INFO 1D profile histograms in directory "RiMCTkResUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |         10 |      13833 | 6776.6     |   -0.68946 |    -1.4297 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39513 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39512 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         75 |      18091 | 14319.     |      2.149 |     7.1021 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         75 | 2.4987e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         75 | 2.4988e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        285 |      20904 | 18318.     |     2.0174 |     5.8364 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        285 | 1.0865e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         49 |      26225 | 23581.     |     1.2321 |    0.44706 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 |  1.807e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.8066e+05 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      55870 | 12552.     |    0.83251 |  0.0039787 |
@@ -3795,12 +3795,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        192 |      56179 | 17968.     |    0.65609 |   -0.64797 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56534 |   -0.95197 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9369.1 | 10772.     |       3.09 |     12.515 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25405 | 14755.     |     1.7971 |     3.4386 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11067 | 11666.     |     2.7462 |      9.829 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12833 | 12312.     |     2.5213 |     8.2134 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37697 | 15995.     |     1.2206 |     1.0316 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57146 |   -0.96665 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9371.3 | 10787.     |     3.1028 |     12.652 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25416 | 14797.     |     1.8104 |       3.51 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11070 | 11683.     |     2.7587 |      9.947 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12836 | 12331.     |     2.5337 |     8.3202 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37727 | 16072.     |     1.2347 |     1.0734 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         58 |      55623 | 12604.     |    0.82814 |   0.018014 |
@@ -3831,12 +3831,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        204 |      55940 | 18003.     |    0.66379 |   -0.63471 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57993 |   -0.92795 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9369.1 | 10772.     |       3.09 |     12.515 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25302 | 14739.     |      1.802 |     3.4659 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11035 | 11652.     |     2.7513 |     9.8662 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12774 | 12293.     |     2.5275 |     8.2568 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37515 | 15991.     |     1.2271 |      1.054 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58628 |   -0.94176 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9371.3 | 10787.     |     3.1028 |     12.652 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25313 | 14781.     |     1.8153 |     3.5375 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11038 | 11669.     |     2.7637 |     9.9845 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12777 | 12312.     |     2.5399 |     8.3639 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37544 | 16068.     |     1.2412 |     1.0962 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      56052 | 12525.     |    0.82303 |  0.0021588 |
@@ -3867,12 +3867,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        192 |      56152 | 17958.     |    0.66509 |   -0.62279 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      56966 | 14706.     |    0.61715 |   -0.86093 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |       9488 | 10912.     |     3.0648 |      12.24 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25559 | 14839.     |     1.7826 |     3.3604 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11179 | 11806.     |     2.7252 |     9.6166 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12955 | 12455.     |     2.5013 |     8.0242 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38000 | 16283.     |     1.1914 |    0.90551 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57076 | 14871.     |    0.62431 |   -0.87404 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9490.2 | 10926.     |      3.077 |     12.368 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25570 | 14880.     |     1.7953 |     3.4275 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11182 | 11822.     |      2.737 |     9.7271 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12959 | 12474.     |      2.513 |     8.1241 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38030 | 16360.     |     1.2046 |     0.9426 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3459 | 1.4334e+13 | 0.0000     |          0 |          0 |
@@ -3911,14 +3911,14 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       7129 |   0.027906 | 0.0028677  |    -2.3605 |     7.1719 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 |-2.1026e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |-2.9206e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |-7.5352e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 |  2.137e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 | 3.9597e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |-1.3028e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 |-3.2212e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |-1.4898e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |-5.8788e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 | 1.4034e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 |  2.915e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |-1.3353e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1532 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1507 |   0.047463 | 0.0072253  |    -2.0191 |     4.1077 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1507 |   0.047464 | 0.0072253  |    -2.0191 |     4.1077 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichPIDMonDownstream10to70/electron/use | "electron Fraction of Tracks with RICH1 I..." |         28 |      19214 | 14290.     |     2.3487 |     4.2526 |
@@ -4108,21 +4108,21 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2370 | 9.1167e-05 | 0.10943    |    0.00436 |    -1.3296 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4173 |  0.0021261 | 0.056969   |   -0.12685 |     2.1324 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4227 | 0.00054765 | 0.062356   |    0.10681 |     2.2674 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2370 | -0.0018365 | 0.12987    |   0.072353 |    -1.6156 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 | 0.00056483 | 0.070930   |   -0.24678 |     1.1389 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4227 |-5.8803e-06 | 0.077592   |    0.11994 |     1.0556 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2370 | -0.0018365 | 0.12987    |   0.072352 |    -1.6156 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 | 0.00056482 | 0.070930   |   -0.24678 |     1.1389 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4227 |-5.8858e-06 | 0.077592   |    0.11994 |     1.0556 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2678 |    0.21293 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4475 |    0.53924 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4530 |   -0.28683 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2362 | 0.00041048 | 0.10889    | -0.0049017 |    -1.3196 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4165 |  0.0020082 | 0.056483   |   -0.14019 |     2.2299 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4219 | 0.00049406 | 0.061661   |    0.10424 |     2.3654 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2362 | 0.00050057 | 0.12375    | 0.00039561 |    -1.5282 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-4.3056e-05 | 0.074157   |    -0.1343 |     1.0095 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2362 | 0.00050056 | 0.12375    | 0.00039573 |    -1.5282 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 | -4.305e-05 | 0.074157   |    -0.1343 |     1.0095 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4219 | -0.0030105 | 0.079817   |    0.09744 |     1.2063 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 | -0.0015096 | 0.053417   |  -0.060944 |     1.6989 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4523 |  0.0082763 | 0.057558   |    0.44192 |     1.6728 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 | -0.0076704 | 0.061710   |    -1.0014 |    -1.6539 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 | -0.0015096 | 0.053417   |  -0.060943 |     1.6989 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4523 |  0.0082762 | 0.057558   |    0.44192 |     1.6728 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 | -0.0076703 | 0.061710   |    -1.0014 |    -1.6538 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4219 |   0.024804 | 0.071663   |    0.60513 |    0.04801 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7850 |  0.0012002 | 0.18942    |  -0.031626 |   -0.79259 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2125 |  0.0024656 | 0.062987   |    0.56733 |     1.9373 |
@@ -4155,10 +4155,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       2822 |     8139.8 | 8980.7     |     3.2084 |     15.157 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       2837 |   0.034392 | 2.1274     | -0.0098649 |    -1.1084 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        479 |      10232 | 12084.     |     2.6231 |     7.8265 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        486 |  -0.027645 | 1.8169     |   0.013054 |    -1.0707 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        486 |  -0.027647 | 1.8169     |   0.013054 |    -1.0707 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        447 |     2.6561 | 0.52846    |     1.1642 |     1.0727 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        479 |     5525.6 | 5647.7     |     6.6061 |     62.855 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        486 |  -0.033865 | 1.8195     |  -0.023433 |    -1.0042 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        479 |     5525.6 | 5647.7     |     6.6062 |     62.855 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        486 |  -0.033868 | 1.8195     |  -0.023431 |    -1.0042 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6084 |     8207.9 | 11854.     |     1.7728 |     2.1026 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6084 |   -0.11337 | 1.8081     |   0.032512 |    -1.1615 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       4233 |     3.1562 | 0.95664    |    0.53914 |     -1.152 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
index f5acb372ec7..0c847d752cc 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -1327,7 +1327,7 @@ TrackBestTrackCreator_6218465d         INFO Number of counters : 32
  |*"Upstream.badChisq"                             |       680 |        180 |( 26.47059 +- 1.691835)% |
  | "Upstream.chisqProbSum"                         |       680 |   203.8682 |    0.29981 |
  |*"Upstream.flipCharge"                           |       680 |         16 |( 2.352941 +- 0.5812737)% |
- | "Upstream.ghostProbability"                     |       680 |   203.2289 |    0.29887 |
+ | "Upstream.ghostProbability"                     |       680 |    203.229 |    0.29887 |
  | "Upstream.numOutliers"                          |       680 |        535 |    0.78676 |
  |*"Velo.badChisq"                                 |      5803 |       1356 |( 23.36722 +- 0.5555006)% |
  | "Velo.chisqProbSum"                             |      5803 |   1856.365 |    0.31990 |
@@ -1699,19 +1699,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      34877 |     0.0281 | 0.0023348  |    -2.5386 |     10.232 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      84853 | 2.5277e-05 | 0.0014051  |  -0.010033 |    -1.0228 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      39039 | 1.7466e-05 | 0.0013642  | 0.00096113 |   -0.94465 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51047 | 2.7012e-06 | 0.0014006  |  0.0086361 |    -1.0145 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 5.6517e-05 | 0.0015248  |  -0.048402 |    -1.2407 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35741 | 5.7365e-05 | 0.0015263  |   -0.05442 |     -1.253 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 4.8942e-05 | 0.0015204  |  -0.043776 |    -1.2295 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      47260 | 4.0075e-05 | 0.0015210  |  -0.035361 |    -1.2417 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0151e-05 | 0.0011107  |    0.04324 |   -0.41657 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3298 |-6.6313e-05 | 0.00093120 |   0.057896 |   -0.12955 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0151e-05 | 0.0011107  |    0.04324 |   -0.41657 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-7.0552e-05 | 0.0011155  |   0.050701 |   -0.41028 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3787 |-0.00010667 | 0.00095680 |-0.00031171 |   -0.15209 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      84853 | 2.5014e-05 | 0.0014050  |  -0.010183 |    -1.0227 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      39039 | 1.7455e-05 | 0.0013643  | 0.00086754 |    -0.9445 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51047 | 2.6926e-06 | 0.0014006  |   0.008537 |    -1.0144 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 5.6107e-05 | 0.0015246  |  -0.048455 |    -1.2406 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35741 | 5.7342e-05 | 0.0015264  |  -0.054511 |    -1.2529 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 4.8584e-05 | 0.0015203  |  -0.043815 |    -1.2294 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      47260 | 4.0058e-05 | 0.0015211  |  -0.035461 |    -1.2416 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0095e-05 | 0.0011106  |    0.04331 |    -0.4165 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3298 |-6.6297e-05 | 0.00093116 |   0.057953 |   -0.12936 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0095e-05 | 0.0011106  |    0.04331 |    -0.4165 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |  -7.05e-05 | 0.0011154  |   0.050773 |   -0.41023 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3787 |-0.00010666 | 0.00095676 |-0.00027709 |   -0.15187 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      77486 |     3.1244 | 1.8125     |   0.020295 |    -1.1929 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7367 |       3.13 | 1.8112     |  0.0050379 |    -1.2045 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      77486 |   0.039199 | 0.011741   |    -0.6421 |   -0.62141 |
@@ -2266,37 +2266,37 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      88268 |   0.026988 | 0.0044927  |    -1.6213 |     2.2946 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.9522e-06 | 0.0014256  |  -0.012523 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      25624 |-7.0996e-06 | 0.0013972  |   0.002827 |    -1.0027 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.9522e-06 | 0.0014256  |  -0.012523 |    -1.0615 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.6509e-06 | 0.0014255  |  -0.012681 |    -1.0614 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      25624 |-7.1515e-06 | 0.0013973  |  0.0026548 |    -1.0025 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.6509e-06 | 0.0014255  |  -0.012681 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 |  0.0001498 | 0.0013644  |   -0.10525 |   -0.95246 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 | 0.00014994 | 0.0013645  |   -0.10529 |   -0.95252 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1458 | 0.00042866 | 0.0014626  |   -0.43835 |   -0.99005 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2591 |-5.4825e-05 | 0.0014817  |   0.039013 |    -1.1954 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8128e-05 | 0.0014788  |  -0.065747 |      -1.15 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011936 |     -1.055 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.3468e-05 | 0.0014252  |    0.03862 |    -1.0492 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.3601e-06 | 0.0013847  |  0.0061811 |   -0.98867 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8065e-05 | 0.0014789  |  -0.065664 |    -1.1502 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011888 |    -1.0551 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.4381e-05 | 0.0014246  |   0.038315 |    -1.0492 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.5297e-06 | 0.0013848  |  0.0056163 |   -0.98797 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 |  0.0001498 | 0.0013644  |   -0.10525 |   -0.95246 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 | 0.00014994 | 0.0013645  |   -0.10529 |   -0.95252 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1458 | 0.00042866 | 0.0014626  |   -0.43835 |   -0.99005 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2591 |-5.4825e-05 | 0.0014817  |   0.039013 |    -1.1954 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8128e-05 | 0.0014788  |  -0.065747 |      -1.15 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011936 |     -1.055 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.3468e-05 | 0.0014252  |    0.03862 |    -1.0492 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.3601e-06 | 0.0013847  |  0.0061811 |   -0.98867 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51047 | 2.7012e-06 | 0.0014006  |  0.0086361 |    -1.0145 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8065e-05 | 0.0014789  |  -0.065664 |    -1.1502 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011888 |    -1.0551 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.4381e-05 | 0.0014246  |   0.038315 |    -1.0492 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.5297e-06 | 0.0013848  |  0.0056163 |   -0.98797 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51047 | 2.6926e-06 | 0.0014006  |   0.008537 |    -1.0144 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      84853 |     3.1249 | 1.8124     |   0.018971 |    -1.1939 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      84853 |   0.039821 | 0.011599   |   -0.72434 |   -0.50628 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2453e-05 | 0.0014294  | -0.0034159 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25423 | 1.2408e-05 | 0.0014038  |   0.014116 |    -1.0266 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2453e-05 | 0.0014294  | -0.0034159 |    -1.0615 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2242e-05 | 0.0014292  | -0.0034743 |    -1.0614 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25423 | 1.2443e-05 | 0.0014038  |   0.014091 |    -1.0266 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2242e-05 | 0.0014292  | -0.0034743 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2156 | 1.7852e-05 | 0.0014213  |  -0.037001 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
@@ -2304,9 +2304,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1240 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2252 | 4.4806e-05 | 0.0014756  |  -0.026818 |    -1.1126 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4325 |-2.4027e-05 | 0.0014511  |   0.025404 |    -1.0796 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0336e-05 | 0.0014149  |  -0.027352 |    -1.0621 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3962e-05 | 0.0014396  |  0.0061011 |      -1.08 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2015e-05 | 0.0014050  |   0.022668 |   -0.99596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0379e-05 | 0.0014149  |  -0.027479 |    -1.0621 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3225e-05 | 0.0014391  |   0.006031 |    -1.0798 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2073e-05 | 0.0014050  |   0.022655 |    -0.9959 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2156 | 1.7852e-05 | 0.0014213  |  -0.037001 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
@@ -2314,53 +2314,53 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1240 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2252 | 4.4806e-05 | 0.0014756  |  -0.026818 |    -1.1126 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4325 |-2.4027e-05 | 0.0014511  |   0.025404 |    -1.0796 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0336e-05 | 0.0014149  |  -0.027352 |    -1.0621 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3962e-05 | 0.0014396  |  0.0061011 |      -1.08 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2015e-05 | 0.0014050  |   0.022668 |   -0.99596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0379e-05 | 0.0014149  |  -0.027479 |    -1.0621 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3225e-05 | 0.0014391  |   0.006031 |    -1.0798 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2073e-05 | 0.0014050  |   0.022655 |    -0.9959 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 43
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6106e-05 | 0.0014224  |   0.016317 |    -1.0217 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1116e-05 | 0.0013747  |  -0.015649 |   -0.99084 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6071e-05 | 0.0014224  |   0.016255 |    -1.0218 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1052e-05 | 0.0013747  |  -0.016179 |   -0.99023 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6106e-05 | 0.0014224  |   0.016317 |    -1.0217 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1116e-05 | 0.0013747  |  -0.015649 |   -0.99084 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6071e-05 | 0.0014224  |   0.016255 |    -1.0218 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1052e-05 | 0.0013747  |  -0.016179 |   -0.99023 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      35131 |     3.1376 | 1.8087     |  0.0021491 |     -1.196 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      35131 |   0.039758 | 0.011667   |   -0.72603 |   -0.49296 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1119 |-1.9116e-05 | 0.0013882  |   0.029505 |    -1.0038 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.0676e-05 | 0.0012898  |    0.15392 |   -0.73665 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        953 |-6.7498e-05 | 0.0013501  |    0.11522 |   -0.90668 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035051 |    -1.0152 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.6189e-06 | 0.0014099  |  -0.016984 |      -1.03 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035146 |     -1.015 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.4894e-06 | 0.0014099  |  -0.017011 |    -1.0298 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4446 |-2.0269e-05 | 0.0013753  |   0.029018 |   -0.95041 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1119 |-1.9116e-05 | 0.0013882  |   0.029505 |    -1.0038 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.0676e-05 | 0.0012898  |    0.15392 |   -0.73665 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        953 |-6.7498e-05 | 0.0013501  |    0.11522 |   -0.90668 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035051 |    -1.0152 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.6189e-06 | 0.0014099  |  -0.016984 |      -1.03 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035146 |     -1.015 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.4894e-06 | 0.0014099  |  -0.017011 |    -1.0298 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4446 |-2.0269e-05 | 0.0013753  |   0.029018 |   -0.95041 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2551,7 +2551,7 @@ RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        442 |    0.63563 | 17.640     |   -0.25588 |   -0.11851 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        470 |    -17.535 | 15.965     |    -0.1588 |   -0.83985 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        442 |     1.2378 | 16.877     |   -0.23161 |    0.13321 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        469 |    -4.9691 | 9.0966     |   -0.21866 |     3.5598 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        469 |    -4.9712 | 9.0957     |   -0.21816 |     3.5622 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        442 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        442 |     1.0253 | 17.649     |   -0.23267 |  -0.063059 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2584,11 +2584,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
  | /RICH/RichMassRingsLong/Rich2Gas/proton/pntSe | "Rich2Gas proton Ring - Segment local poi..." |      21896 |-0.00082207 | 6.9731     |    0.88181 |    0.75355 |
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  -0.021512 | 0.20460    |    0.37902 |    -1.4633 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |   0.012846 | 0.64607    |     1.6949 |     58.593 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  -0.021802 | 0.20457    |    0.38205 |    -1.4608 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |   0.012836 | 0.64607    |     1.6949 |     58.593 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 |  -0.020389 | 0.21899    |     0.1383 |   -0.84869 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |  0.0040533 | 0.52674    |    0.88915 |      110.5 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | -1.203e-05 | 0.44640    |    0.92156 |     35.413 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |  0.0040428 | 0.52674    |    0.88921 |      110.5 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | -2.406e-05 | 0.44640    |    0.92163 |     35.413 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 |  -0.021746 | 0.20192    |    0.21436 |    -1.7158 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2956,7 +2956,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        544 |      14521 | 16433.     |     2.1439 |     4.9703 |
  | Upstream/phi                                  | "phi"                                         |        544 |  -0.014553 | 1.8054     |   0.036427 |    -1.0559 |
  | Upstream/probChi2                             | "probChi2"                                    |        544 |    0.37518 | 0.31941    |    0.51228 |    -1.1091 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        544 |      14660 | 16849.     |     2.4615 |     7.2795 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        544 |      14664 | 16851.     |     2.4601 |     7.2725 |
  | Upstream/pt                                   | "pt"                                          |        544 |     846.14 | 559.78     |     3.2192 |     13.931 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        544 | 5.5147e-06 | 0.00021042 |  0.0068329 |   -0.53278 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        544 |    -4.7747 | 0.39134    |  -0.050515 |     -1.172 |
@@ -3809,8 +3809,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4766 |      53747 | 18217.     |     1.1886 |     1.1378 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7367 |     7945.1 | 10287.     |     4.5632 |     34.017 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        469 |      57721 | 24894.     |     1.2956 |    0.29746 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7367 |       7945 | 10287.     |     4.5633 |     34.017 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        469 |      57721 | 24894.     |     1.2956 |    0.29745 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        469 |      10673 | 12231.     |     3.5684 |      20.18 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        469 |      24299 | 15595.     |     3.0539 |     12.607 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        469 |      11690 | 12718.     |     3.4116 |     18.487 |
@@ -3869,11 +3869,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |          8 |      18934 | 8263.8     |   -0.55182 |    -0.7941 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |          8 |     -48936 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         86 |      17452 | 10308.     |    0.39221 |   -0.69805 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         86 |      26188 | 6392.6     |    0.58672 |     -2.176 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         86 |      26188 | 6392.6     |    0.58671 |     -2.176 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        293 |      19450 | 16597.     |     2.3268 |     8.2199 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        293 |      60220 | 34165.     |   -0.44892 |   -0.98163 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        293 |      60219 | 34165.     |   -0.44889 |   -0.98166 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         51 |      25966 | 17956.     |    0.56108 |    -0.6299 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         51 |      28891 | 11916.     |    0.30337 |    0.57871 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         51 |      28891 | 11916.     |    0.30337 |    0.57868 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         11 |      52965 | 8983.4     |   -0.49869 |    -1.2041 |
@@ -3904,7 +3904,7 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        337 |      55171 | 16310.     |    0.72332 |   -0.35959 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51145 | 13232.     |     1.0869 |    0.13028 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51145 | 13232.     |     1.0869 |    0.13032 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10120 | 10356.     |     2.3372 |     7.2761 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        164 |      24222 | 11857.     |     1.6851 |     3.7827 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        466 |      11824 | 10960.     |     2.0815 |     5.8546 |
@@ -3940,7 +3940,7 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        352 |      54986 | 16341.     |    0.72702 |   -0.34992 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      50754 | 13198.     |     1.1163 |    0.21392 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      50754 | 13198.     |     1.1163 |    0.21396 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10120 | 10356.     |     2.3372 |     7.2761 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        168 |      24150 | 11852.     |     1.6867 |     3.7931 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        467 |      11793 | 10951.     |     2.0851 |      5.873 |
@@ -3976,7 +3976,7 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        337 |      55276 | 16363.     |    0.71862 |   -0.37307 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51252 | 13102.     |     1.0875 |    0.16982 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51252 | 13102.     |     1.0876 |    0.16986 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10236 | 10451.     |     2.3196 |     7.1542 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        164 |      24345 | 11966.     |     1.6671 |     3.6728 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        466 |      11945 | 11048.     |     2.0683 |     5.7693 |
@@ -4020,12 +4020,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       8064 |   0.027915 | 0.0028384  |    -2.3563 |     7.2295 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |-6.6541e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |-1.9116e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 |-7.2125e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-1.6068e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | 1.0041e+14 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 | 4.8988e+11 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  8.376e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |-2.1142e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 | 2.7151e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-1.7745e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 |-2.4362e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 |  2.052e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1658 |     1.0798 | 0.94431    |    0.57747 |    0.12061 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1621 |   0.047612 | 0.0071905  |    -2.1658 |     4.8553 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -4210,22 +4210,22 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3057 |  -0.071576 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4850 |  -0.096725 | 0.088044   |     5.0526 |     20.344 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4904 |    -0.1964 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3057 |   0.016418 | 0.016026   |     397.96 |    -3346.5 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3057 |   0.016418 | 0.016026   |     397.92 |    -3346.1 |
  | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4850 |   0.070467 | 0.10353    |    0.63802 |    -1.3778 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4904 |   0.021307 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3062 |    -0.1944 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4851 |    0.95486 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4905 |  -0.068654 | 0.33981    |    0.47518 |    -2.5955 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3055 |  -0.064857 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4848 |   -0.14774 | 0.13799    |     5.1506 |     15.073 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4851 |    0.95487 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4905 |  -0.068657 | 0.33981    |     0.4752 |    -2.5955 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3055 |  -0.064858 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4848 |   -0.14774 | 0.13798    |     5.1508 |     15.075 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4902 |      2.406 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3055 |    0.26074 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4848 |    -16.188 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4902 |   -0.34949 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4848 |    0.14217 | 0.10485    |     -5.578 |       23.8 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4902 |   -0.59908 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3055 |    0.26073 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4848 |    -16.199 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4902 |    -0.3495 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4848 |    0.14217 | 0.10485    |    -5.5785 |     23.804 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4902 |   -0.59909 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4848 |   0.049867 | 0.0000     |          0 |          0 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4902 |     4.7116 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4902 |     4.7117 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       8218 | -0.0019168 | 0.18526    |   0.045919 |   -0.70796 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2220 | 0.00022951 | 0.060819   |   -0.71814 |     2.2192 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2195 |  0.0024723 | 0.062158   |    0.56371 |     2.0318 |
@@ -4258,9 +4258,9 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       2826 |   0.039363 | 2.1371     |  -0.013258 |    -1.1224 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        536 |      12026 | 15035.     |     2.5481 |     7.1076 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        544 |  0.0063562 | 1.7896     |  -0.026379 |    -1.0062 |
- | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        510 |     3.1131 | 0.87913    |    0.53142 |    -1.0472 |
+ | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        510 |     3.1131 | 0.87914    |    0.53142 |    -1.0472 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        536 |      11910 | 14952.     |     2.6756 |     8.3163 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        544 |   0.015314 | 1.7899     | -0.0088242 |    -1.0126 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        544 |   0.015313 | 1.7899     | -0.0088241 |    -1.0126 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       5802 |     7780.1 | 11904.     |     1.9009 |     2.4876 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       5803 |   -0.12833 | 1.8135     |   0.039812 |    -1.1668 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       3944 |     3.0493 | 0.91332    |    0.74801 |   -0.77874 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
index 6d8d32fb3d5..5c8d40a220e 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_default_reco_track_master_fitter_with_mcchecking.ref.x86_64_v3-opt
@@ -1282,9 +1282,9 @@ TrackBestTrackCreator_6218465d         INFO Number of counters : 32
  | "Ttrack.ghostProbability"                       |      2838 |   271.3144 |   0.095601 |
  | "Ttrack.numOutliers"                            |      2838 |        939 |    0.33087 |
  |*"Upstream.badChisq"                             |       815 |        455 |( 55.82822 +- 1.739484)% |
- | "Upstream.chisqProbSum"                         |       815 |   128.5401 |    0.15772 |
+ | "Upstream.chisqProbSum"                         |       815 |   128.5402 |    0.15772 |
  |*"Upstream.flipCharge"                           |       815 |         37 |( 4.539877 +- 0.7292127)% |
- | "Upstream.ghostProbability"                     |       815 |   418.2279 |    0.51316 |
+ | "Upstream.ghostProbability"                     |       815 |   418.2278 |    0.51316 |
  | "Upstream.numOutliers"                          |       815 |       1020 |     1.2515 |
  |*"Velo.badChisq"                                 |      6088 |       1365 |( 22.42116 +- 0.5345192)% |
  | "Velo.chisqProbSum"                             |      6088 |   1958.504 |    0.32170 |
@@ -1664,23 +1664,23 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      30104 |   0.027963 | 0.0023066  |    -2.4428 |     9.5066 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      75794 |  2.419e-05 | 0.0014502  |  -0.019208 |    -1.1207 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      30231 | 1.2638e-05 | 0.0014190  | -0.0050061 |    -1.0599 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38907 |  1.516e-05 | 0.0014364  | -0.0098865 |    -1.0897 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 1.2345e-05 | 0.0015268  | -0.0097533 |    -1.2363 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      75794 | 2.4493e-05 | 0.0014503  |  -0.019204 |    -1.1207 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      30231 | 1.2632e-05 | 0.0014190  | -0.0049938 |    -1.0599 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38907 | 1.5165e-05 | 0.0014364  | -0.0098898 |    -1.0897 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 1.2557e-05 | 0.0015269  | -0.0097732 |    -1.2363 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27264 | 8.9839e-06 | 0.0015417  | -0.0082123 |    -1.2548 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 2.9537e-05 | 0.0015114  |  -0.020564 |    -1.2135 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35761 | 2.9271e-05 | 0.0015217  |  -0.023381 |    -1.2258 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1182e-05 | 0.0012578  |  -0.026292 |   -0.84193 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9676e-05 | 0.0011462  |   0.025606 |    -0.6686 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1182e-05 | 0.0012578  |  -0.026292 |   -0.84193 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.2664e-05 | 0.0012796  |  -0.027781 |    -0.8637 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2784e-05 | 0.0011759  |  0.0044873 |   -0.69201 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 2.9521e-05 | 0.0015114  |   -0.02057 |    -1.2135 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35761 | 2.9286e-05 | 0.0015217  |    -0.0234 |    -1.2258 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1688e-05 | 0.0012582  |  -0.025983 |   -0.84191 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9658e-05 | 0.0011462  |   0.025648 |   -0.66865 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1688e-05 | 0.0012582  |  -0.025983 |   -0.84191 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.3224e-05 | 0.0012800  |  -0.027474 |    -0.8637 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2803e-05 | 0.0011759  |  0.0045336 |   -0.69206 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      68886 |     3.1152 | 1.8142     |   0.028994 |    -1.1992 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       6908 |     3.1343 | 1.7895     | -0.0025063 |    -1.1838 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      68886 |   0.039305 | 0.011771   |   -0.64618 |    -0.6294 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       6908 |   0.046308 | 0.0076576  |    -1.7475 |      2.655 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       6908 |   0.046308 | 0.0076577  |    -1.7474 |     2.6549 |
 RiCKResDownstream                      INFO 1D histograms in directory "RiCKResDownstream" : 137
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResDownstream/Rich1Gas/bottom/ckRes | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      56426 | 7.4558e-05 | 0.0014256  |  -0.067361 |    -1.0923 |
@@ -2229,9 +2229,9 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      35661 |   0.027189 | 0.0043019  |    -1.7355 |     2.7947 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012863 |    -1.1208 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18579 | -1.431e-05 | 0.0014382  |   0.017772 |    -1.0868 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012863 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012888 |    -1.1209 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18579 |-1.4286e-05 | 0.0014382  |   0.017742 |    -1.0868 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012888 |    -1.1209 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1607 | 7.7571e-05 | 0.0014378  |  -0.094745 |    -1.0971 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2239,9 +2239,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1611 | 0.00013605 | 0.0014819  |   -0.10504 |    -1.2173 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2797 |-8.9169e-05 | 0.0013765  |   0.059543 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4801 | 2.9048e-05 | 0.0014317  |  -0.041406 |      -1.12 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1797e-05 | 0.0014605  |   0.037926 |    -1.1389 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027967 |     -1.093 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.5907e-05 | 0.0014759  |  -0.010153 |    -1.1461 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1671e-05 | 0.0014605  |   0.037839 |    -1.1388 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027938 |    -1.0931 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.6099e-05 | 0.0014759  |  -0.010211 |    -1.1463 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1607 | 7.7571e-05 | 0.0014378  |  -0.094745 |    -1.0971 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2249,36 +2249,36 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1611 | 0.00013605 | 0.0014819  |   -0.10504 |    -1.2173 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2797 |-8.9169e-05 | 0.0013765  |   0.059543 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4801 | 2.9048e-05 | 0.0014317  |  -0.041406 |      -1.12 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1797e-05 | 0.0014605  |   0.037926 |    -1.1389 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027967 |     -1.093 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.5907e-05 | 0.0014759  |  -0.010153 |    -1.1461 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38907 |  1.516e-05 | 0.0014364  | -0.0098865 |    -1.0897 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1671e-05 | 0.0014605  |   0.037839 |    -1.1388 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027938 |    -1.0931 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.6099e-05 | 0.0014759  |  -0.010211 |    -1.1463 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38907 | 1.5165e-05 | 0.0014364  | -0.0098898 |    -1.0897 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      75794 |     3.1169 | 1.8119     |   0.026158 |    -1.1979 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      75794 |   0.039954 | 0.011631   |   -0.72877 |   -0.51274 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1609e-05 | 0.0014585  |  -0.030744 |    -1.1381 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20328 | 3.9571e-05 | 0.0014344  |  -0.032717 |    -1.0901 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1609e-05 | 0.0014585  |  -0.030744 |    -1.1381 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1848e-05 | 0.0014586  |  -0.030768 |    -1.1381 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20328 | 3.9561e-05 | 0.0014344  |  -0.032698 |    -1.0902 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1848e-05 | 0.0014586  |  -0.030768 |    -1.1381 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1756 | -4.088e-05 | 0.0014342  |   0.070171 |    -1.0409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.0333e-05 | 0.0015132  |   -0.11026 |    -1.1806 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0222e-05 | 0.0014688  |  -0.076122 |    -1.1345 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012741 | 0.0014611  |  -0.093494 |    -1.1235 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012828 |    -1.1597 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.6263e-05 | 0.0015163  |   -0.11033 |    -1.1807 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0129e-05 | 0.0014687  |  -0.076166 |    -1.1346 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012739 | 0.0014611  |  -0.093539 |    -1.1235 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012833 |    -1.1598 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7102 | 2.6112e-06 | 0.0014163  |   0.014405 |    -1.1074 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1756 | -4.088e-05 | 0.0014342  |   0.070171 |    -1.0409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.0333e-05 | 0.0015132  |   -0.11026 |    -1.1806 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0222e-05 | 0.0014688  |  -0.076122 |    -1.1345 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012741 | 0.0014611  |  -0.093494 |    -1.1235 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012828 |    -1.1597 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.6263e-05 | 0.0015163  |   -0.11033 |    -1.1807 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0129e-05 | 0.0014687  |  -0.076166 |    -1.1346 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012739 | 0.0014611  |  -0.093539 |    -1.1235 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012833 |    -1.1598 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7102 | 2.6112e-06 | 0.0014163  |   0.014405 |    -1.1074 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2299,27 +2299,27 @@ RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1198 |-3.2933e-06 | 0.0014528  |    0.01223 |    -1.1014 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1926 | 9.1663e-05 | 0.0014709  |  -0.076287 |      -1.15 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1192 | 7.7107e-05 | 0.0014072  |  -0.074893 |    -1.0739 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      11074 |     3.1268 | 1.8144     |   0.011834 |    -1.2037 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62054 |   -0.66614 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62053 |   -0.66615 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2426,7 +2426,7 @@ RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |    0.65875 | 0.058081   |    0.54927 |   -0.37747 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        445 |    0.66304 | 0.055327   |    -1.7214 |     6.2416 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        142 |     0.6731 | 0.050531   |   -0.86048 |     3.0728 |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        445 |    0.66648 | 0.061768   |    -1.5751 |       4.96 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        445 |    0.66646 | 0.061847   |    -1.5814 |     4.9796 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/pion/eff  | "Rich1Gas pion Geom. Eff. (>0)"               |        406 |    0.66778 | 0.060980   |    -1.2414 |     5.1551 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/proton/ef | "Rich1Gas proton Geom. Eff. (>0)"             |         67 |    0.65724 | 0.059093   |   -0.14821 |   -0.17854 |
 RiTkMaterialDownstream                 INFO 1D histograms in directory "RiTkMaterialDownstream" : 2
@@ -2473,7 +2473,7 @@ RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |     31.067 | 19.320     |   0.075317 |    -1.3434 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        445 |     59.578 | 5.2731     |    -1.4499 |     5.2119 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        142 |     38.028 | 16.869     |    -0.6185 |    -0.5097 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        445 |     46.343 | 13.047     |   -0.77828 |   -0.22455 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        445 |     46.342 | 13.049     |   -0.77795 |   -0.22596 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0);Photon Y..." |        406 |     41.237 | 17.241     |   -0.69667 |   -0.60955 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0);Photon..." |         67 |     32.245 | 17.577     |  -0.031988 |    -1.1013 |
 RichDLLsDownstream                     INFO 1D histograms in directory "RichDLLsDownstream" : 7
@@ -2496,13 +2496,13 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsLong/proton/dll                 | "proton DLL"                                  |       3995 |    -2.3271 | 20.430     |  -0.073422 |   -0.11404 |
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        406 |     2.9899 | 17.208     |    -0.2077 |    0.32827 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        406 |     2.8643 | 17.157     |   -0.20801 |    0.38038 |
+ | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        406 |     2.9925 | 17.206     |   -0.20785 |    0.32973 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        406 |     2.8668 | 17.155     |   -0.20815 |    0.38187 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        445 |     -18.56 | 17.634     |    0.10609 |   -0.52457 |
- | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        406 |     2.7443 | 16.256     |   -0.36131 |    0.74091 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        445 |    -4.3984 | 10.134     |    0.38446 |     3.3038 |
+ | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        406 |     2.7443 | 16.258     |   -0.36202 |    0.74154 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        445 |    -4.3962 | 10.143     |    0.39387 |     3.3411 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        406 |        0.5 | 0.0000     |          0 |          0 |
- | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        406 |     3.0854 | 17.004     |   -0.24768 |    0.45549 |
+ | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        406 |     3.0879 | 17.001     |   -0.24783 |    0.45706 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3264 |   -0.02598 | 0.21853    |    0.27003 |   -0.77629 |
@@ -3324,7 +3324,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        456 | -0.0071904 | 0.027934   |    0.23504 |    -1.1379 |
  | Upstream/BegRich1/ppull                       | "p pull"                                      |        456 |   -0.40427 | 1.8781     |   0.079908 |   -0.15338 |
  | Upstream/BegRich1/qoppull                     | "qop pull"                                    |        456 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/BegRich1/txpull                      | "tx pull"                                     |        456 |   -0.73152 | 2.9746     |    0.37981 |    -1.1696 |
+ | Upstream/BegRich1/txpull                      | "tx pull"                                     |        456 |   -0.73056 | 2.9744     |    0.37896 |    -1.1696 |
  | Upstream/BegRich1/txres                       | "tx resolution"                               |        456 | 0.00035584 | 0.0010976  |   -0.60708 |   0.062502 |
  | Upstream/BegRich1/typull                      | "ty pull"                                     |        456 |    0.33681 | 1.8685     | -0.0056561 |   -0.17249 |
  | Upstream/BegRich1/tyres                       | "ty resolution"                               |        456 | 0.00013127 | 0.00071154 |   0.028832 |     1.8096 |
@@ -3700,8 +3700,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4686 |      55481 | 21194.     |     1.1333 |     0.6042 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.7 | 10659.     |     4.1661 |     23.783 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        440 |      58419 | 19160.     |    0.95679 |   -0.20546 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.8 | 10659.     |      4.166 |     23.782 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        440 |      58419 | 19160.     |    0.95678 |   -0.20548 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        440 |     9717.8 | 11691.     |     3.4773 |     16.666 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        440 |      24537 | 16033.     |     2.2979 |     6.2823 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        440 |      10699 | 12258.     |     3.2709 |     14.713 |
@@ -3760,11 +3760,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |         10 |      13833 | 6776.6     |   -0.68946 |    -1.4297 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39301 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         74 |      18196 | 14319.     |     2.1503 |     7.1066 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         74 | 2.2866e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         74 | 2.2867e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        285 |      20904 | 18318.     |     2.0174 |     5.8364 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        285 | 1.0858e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         49 |      26225 | 23581.     |     1.2321 |    0.44706 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.7983e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.7982e+05 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      55870 | 12552.     |    0.83251 |  0.0039788 |
@@ -3795,12 +3795,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        191 |      56225 | 17957.     |    0.65519 |   -0.64935 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57147 |   -0.96664 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9385.1 | 10796.     |      3.099 |     12.621 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25416 | 14797.     |     1.8105 |     3.5101 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11086 | 11690.     |     2.7559 |     9.9271 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12853 | 12335.     |     2.5321 |     8.3089 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37727 | 16072.     |     1.2347 |     1.0734 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56535 |   -0.95196 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9382.9 | 10781.     |     3.0861 |     12.484 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25404 | 14755.     |     1.7972 |     3.4387 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11083 | 11673.     |     2.7435 |     9.8092 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12850 | 12316.     |     2.5197 |     8.2021 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37698 | 15994.     |     1.2206 |     1.0316 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         58 |      55623 | 12604.     |    0.82814 |   0.018014 |
@@ -3831,12 +3831,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        203 |      55987 | 17991.     |    0.66274 |   -0.63619 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58629 |   -0.94174 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9385.1 | 10796.     |      3.099 |     12.621 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25313 | 14781.     |     1.8154 |     3.5377 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11054 | 11676.     |     2.7609 |     9.9644 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12794 | 12317.     |     2.5382 |     8.3523 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37546 | 16067.     |     1.2412 |     1.0962 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57994 |   -0.92794 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9382.9 | 10781.     |     3.0861 |     12.484 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25301 | 14739.     |     1.8021 |      3.466 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11052 | 11659.     |     2.7485 |     9.8463 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12791 | 12298.     |     2.5258 |     8.2452 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37516 | 15991.     |     1.2271 |      1.054 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      56048 | 12530.     |    0.82906 |  0.0061688 |
@@ -3867,12 +3867,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        191 |      56294 | 18033.     |    0.65595 |   -0.64581 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57232 | 14841.     |    0.61524 |   -0.87852 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9487.2 | 10958.     |      3.103 |     12.571 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25598 | 14985.     |     1.8048 |     3.4414 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11186 | 11863.     |     2.7602 |     9.8815 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12951 | 12514.     |     2.5379 |     8.2713 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38105 | 16478.     |     1.2063 |    0.91731 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57122 | 14676.     |    0.60816 |   -0.86477 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9484.9 | 10942.     |     3.0901 |     12.435 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25585 | 14941.     |     1.7917 |     3.3722 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11183 | 11846.     |     2.7476 |     9.7642 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12947 | 12494.     |     2.5255 |     8.1658 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38072 | 16396.     |     1.1928 |     0.8799 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3264 |-6.0065e+13 | 0.0000     |          0 |          0 |
@@ -3911,12 +3911,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       7124 |   0.027908 | 0.0028641  |    -2.3611 |     7.1745 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1584 |-1.9797e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      41240 | -3.523e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10352 | 3.9093e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      35776 | -1.618e+14 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      30592 | 1.1161e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4584 | 3.5669e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1584 |-2.9103e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      41240 |-2.4588e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10352 | 3.1165e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      35776 |-1.9515e+15 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      30592 | 9.8225e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4584 |-2.3924e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1529 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1504 |   0.047469 | 0.0072252  |    -2.0236 |     4.1283 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -4110,19 +4110,19 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4226 | 0.00056202 | 0.062361   |    0.10357 |     2.2716 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2368 | -0.0017641 | 0.12972    |   0.070812 |    -1.6137 |
  | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 | 0.00053315 | 0.070946   |   -0.24682 |     1.1293 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4226 |-0.00015726 | 0.077513   |    0.11726 |     1.0672 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4226 |-0.00015727 | 0.077513   |    0.11726 |     1.0672 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2675 |    0.20942 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4474 |    0.52351 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4528 |   -0.34457 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2360 | 0.00044419 | 0.10879    | -0.0055576 |    -1.3185 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2360 | 0.00044418 | 0.10879    | -0.0055576 |    -1.3185 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4165 |  0.0020049 | 0.056491   |   -0.14318 |     2.2213 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4218 | 0.00051302 | 0.061663   |   0.099839 |     2.3698 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2360 | 0.00053607 | 0.12367    |-4.6965e-05 |    -1.5271 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-5.7713e-05 | 0.074143   |   -0.13655 |     1.0029 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2360 | 0.00053606 | 0.12367    |-4.6704e-05 |    -1.5271 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-5.7705e-05 | 0.074143   |   -0.13655 |     1.0029 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4218 | -0.0031725 | 0.079739   |   0.093316 |     1.2161 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 | -0.0013403 | 0.053357   |  -0.077895 |      1.682 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4522 |  0.0081924 | 0.057744   |    0.40443 |     1.7529 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 |  -0.007427 | 0.061580   |    -1.0503 |     -1.725 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 | -0.0074269 | 0.061580   |    -1.0503 |     -1.725 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4218 |   0.024031 | 0.072885   |    0.51235 |     0.2018 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7842 |  0.0012743 | 0.18955    |  -0.031115 |   -0.79251 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2124 |  0.0025495 | 0.063089   |    0.56475 |     1.9132 |
@@ -4157,7 +4157,7 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        478 |      10222 | 12072.     |     2.6263 |     7.8506 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        485 |  -0.026527 | 1.8155     |   0.011539 |    -1.0686 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        447 |     2.6555 | 0.52839    |     1.1641 |     1.0744 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        478 |     5538.1 | 5651.6     |      6.587 |     62.604 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        478 |     5538.1 | 5651.6     |     6.5871 |     62.604 |
  | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        485 |  -0.034411 | 1.8203     |   -0.02182 |    -1.0059 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6087 |       8191 | 11849.     |     1.7765 |     2.1149 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6088 |   -0.10956 | 1.8060     |   0.028603 |    -1.1609 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
index da0941f57db..f4c04f171f0 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref
@@ -3499,10 +3499,10 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1728 | 1.1406e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43196 | 1.4743e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43196 | 1.4171e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      11280 |-9.5398e+11 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-9.9357e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32644 | 1.5525e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-9.8777e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32644 | 1.5167e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4924 | 2.1902e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1580 |     1.1552 | 1.0291     |    0.84914 |    0.97941 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1554 |   0.047491 | 0.0072026  |    -2.0193 |     4.1032 |
@@ -3736,7 +3736,7 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       3187 |      10342 | 12788.     |     2.6594 |      7.933 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       3210 |   0.016276 | 2.1080     |  0.0025223 |    -1.0925 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        490 |      10220 | 11974.     |      2.632 |     7.9614 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        499 |  -0.023238 | 1.8137     |  0.0074954 |    -1.0811 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        499 |  -0.023238 | 1.8137     |  0.0074955 |    -1.0811 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        460 |      2.667 | 0.53426    |     1.1382 |    0.95462 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        490 |       5557 | 5619.0     |     6.5706 |      62.78 |
  | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        499 |  -0.024366 | 1.8168     |  -0.029953 |    -1.0139 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
index bb1c265ffd8..e819fe9d4ed 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.armv8.1_a
@@ -1275,7 +1275,7 @@ TrackBestTrackCreator_4472c1b6         INFO Number of counters : 32
  |*"Upstream.badChisq"                             |       829 |        462 |( 55.72979 +- 1.725132)% |
  | "Upstream.chisqProbSum"                         |       829 |   131.0881 |    0.15813 |
  |*"Upstream.flipCharge"                           |       829 |         37 |( 4.463209 +- 0.7171858)% |
- | "Upstream.ghostProbability"                     |       829 |   423.0478 |    0.51031 |
+ | "Upstream.ghostProbability"                     |       829 |   423.0476 |    0.51031 |
  | "Upstream.numOutliers"                          |       829 |       1030 |     1.2425 |
  |*"Velo.badChisq"                                 |      6141 |       1372 |( 22.34164 +- 0.5315352)% |
  | "Velo.chisqProbSum"                             |      6141 |   1978.849 |    0.32224 |
@@ -1661,19 +1661,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      29607 |   0.027951 | 0.0023096  |    -2.4345 |     9.4255 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      78489 | 2.4994e-05 | 0.0014503  |  -0.020325 |    -1.1194 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      31720 | 1.3087e-05 | 0.0014187  | -0.0076326 |    -1.0581 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      78489 | 2.9387e-05 | 0.0014577  |  -0.024027 |    -1.1286 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      41980 | 1.2394e-05 | 0.0014386  |   -0.01212 |    -1.0901 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      71400 | 1.5173e-05 | 0.0015268  |  -0.012722 |    -1.2355 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      28628 |  1.179e-05 | 0.0015404  |  -0.012605 |    -1.2522 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      71400 | 2.9333e-05 | 0.0015127  |  -0.023365 |    -1.2127 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      38686 | 2.5871e-05 | 0.0015228  |   -0.02506 |    -1.2247 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.7904e-05 | 0.0012535  |  -0.024771 |   -0.83221 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3092 | 1.5642e-05 | 0.0011420  |   0.022958 |   -0.65878 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.7904e-05 | 0.0012535  |  -0.024771 |   -0.83221 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 2.9554e-05 | 0.0012743  |  -0.026244 |   -0.85244 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3294 |-2.5317e-05 | 0.0011701  |  0.0019807 |   -0.68086 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      78489 | 2.4874e-05 | 0.0014503  |  -0.020326 |    -1.1194 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      31720 |  1.287e-05 | 0.0014189  | -0.0076369 |    -1.0582 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      78489 | 2.9303e-05 | 0.0014578  |  -0.024023 |    -1.1286 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      41980 |  1.223e-05 | 0.0014387  |  -0.012141 |    -1.0901 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      71400 | 1.4764e-05 | 0.0015267  |  -0.012663 |    -1.2355 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      28628 | 1.1004e-05 | 0.0015404  |  -0.012448 |    -1.2522 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      71400 | 2.9024e-05 | 0.0015127  |  -0.023333 |    -1.2127 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      38686 | 2.5294e-05 | 0.0015229  |  -0.025003 |    -1.2248 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.8453e-05 | 0.0012539  |  -0.024286 |   -0.83184 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3092 | 1.6542e-05 | 0.0011428  |   0.024481 |   -0.65756 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.8453e-05 | 0.0012539  |  -0.024286 |   -0.83184 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 3.0159e-05 | 0.0012747  |  -0.025721 |   -0.85208 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3294 |-2.4311e-05 | 0.0011710  |  0.0036298 |   -0.67949 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      71400 |     3.1187 | 1.8142     |     0.0256 |    -1.1994 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7089 |     3.1328 | 1.7921     | -0.0015522 |    -1.1874 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      71400 |   0.039592 | 0.011541   |   -0.66573 |   -0.56175 |
@@ -2226,37 +2226,37 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      34858 |   0.027156 | 0.0043454  |    -1.7231 |     2.6998 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39118 | 5.2292e-06 | 0.0014567  |   -0.01291 |    -1.1216 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      19678 |-1.8709e-05 | 0.0014432  |   0.019766 |    -1.0912 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39118 | 5.2292e-06 | 0.0014567  |   -0.01291 |    -1.1216 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39118 | 5.0162e-06 | 0.0014569  |  -0.012904 |    -1.1215 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      19678 |-1.9106e-05 | 0.0014435  |   0.019738 |    -1.0912 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39118 | 5.0162e-06 | 0.0014569  |  -0.012904 |    -1.1215 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1640 | 7.4672e-05 | 0.0014403  |  -0.092596 |    -1.0983 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1640 | 7.4776e-05 | 0.0014402  |  -0.092262 |    -1.0987 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        813 | 0.00031241 | 0.0016324  |   -0.23267 |    -1.4296 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1698 | 0.00011692 | 0.0014932  |  -0.073158 |     -1.222 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2936 |-8.9314e-05 | 0.0013767  |   0.037291 |    -1.0065 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4812 |   3.64e-05 | 0.0014303  |  -0.042608 |    -1.1156 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8625 | -2.529e-05 | 0.0014579  |   0.035842 |     -1.133 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11377 | 1.7601e-05 | 0.0014590  |  -0.019926 |    -1.0981 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6772 |  -1.75e-05 | 0.0014819  |  -0.020064 |    -1.1544 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8625 |-2.5266e-05 | 0.0014579  |   0.036065 |    -1.1333 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11377 |  1.669e-05 | 0.0014595  |   -0.02015 |    -1.0978 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6772 |-1.7166e-05 | 0.0014821  |  -0.020078 |    -1.1541 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1640 | 7.4672e-05 | 0.0014403  |  -0.092596 |    -1.0983 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1640 | 7.4776e-05 | 0.0014402  |  -0.092262 |    -1.0987 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        813 | 0.00031241 | 0.0016324  |   -0.23267 |    -1.4296 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1698 | 0.00011692 | 0.0014932  |  -0.073158 |     -1.222 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2936 |-8.9314e-05 | 0.0013767  |   0.037291 |    -1.0065 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4812 |   3.64e-05 | 0.0014303  |  -0.042608 |    -1.1156 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8625 | -2.529e-05 | 0.0014579  |   0.035842 |     -1.133 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11377 | 1.7601e-05 | 0.0014590  |  -0.019926 |    -1.0981 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6772 |  -1.75e-05 | 0.0014819  |  -0.020064 |    -1.1544 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      78489 | 2.9387e-05 | 0.0014577  |  -0.024027 |    -1.1286 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      41980 | 1.2394e-05 | 0.0014386  |   -0.01212 |    -1.0901 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      78489 | 2.9387e-05 | 0.0014577  |  -0.024027 |    -1.1286 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8625 |-2.5266e-05 | 0.0014579  |   0.036065 |    -1.1333 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11377 |  1.669e-05 | 0.0014595  |   -0.02015 |    -1.0978 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6772 |-1.7166e-05 | 0.0014821  |  -0.020078 |    -1.1541 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      78489 | 2.9303e-05 | 0.0014578  |  -0.024023 |    -1.1286 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      41980 |  1.223e-05 | 0.0014387  |  -0.012141 |    -1.0901 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      78489 | 2.9303e-05 | 0.0014578  |  -0.024023 |    -1.1286 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      78489 |     3.1199 | 1.8122     |   0.023182 |    -1.1983 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      78489 |   0.040205 | 0.011410   |   -0.74393 |   -0.45042 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      39371 | 5.0026e-05 | 0.0014583  |  -0.033601 |    -1.1344 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      22302 | 3.7049e-05 | 0.0014344  |   -0.03724 |    -1.0868 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      39371 | 5.0026e-05 | 0.0014583  |  -0.033601 |    -1.1344 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      39371 | 5.0053e-05 | 0.0014583  |  -0.033593 |    -1.1345 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      22302 | 3.7076e-05 | 0.0014345  |  -0.037251 |    -1.0869 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      39371 | 5.0053e-05 | 0.0014583  |  -0.033593 |    -1.1345 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1763 |-4.2006e-05 | 0.0014369  |   0.066976 |    -1.0442 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2264,9 +2264,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1209 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2324 | 9.9913e-05 | 0.0015132  |   -0.11075 |    -1.1668 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4760 | 9.7974e-05 | 0.0014607  |  -0.084328 |    -1.1199 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8533 | 0.00012234 | 0.0014609  |  -0.096302 |    -1.1269 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12260 | 2.8607e-06 | 0.0014747  |   0.013668 |     -1.158 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7463 | 3.2148e-06 | 0.0014132  |  0.0077692 |    -1.0979 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8533 | 0.00012236 | 0.0014609  |  -0.096424 |     -1.127 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12260 | 2.9513e-06 | 0.0014747  |   0.013764 |     -1.158 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7463 | 3.1852e-06 | 0.0014133  |  0.0078034 |    -1.0981 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1763 |-4.2006e-05 | 0.0014369  |   0.066976 |    -1.0442 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2274,9 +2274,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1209 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2324 | 9.9913e-05 | 0.0015132  |   -0.11075 |    -1.1668 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4760 | 9.7974e-05 | 0.0014607  |  -0.084328 |    -1.1199 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8533 | 0.00012234 | 0.0014609  |  -0.096302 |    -1.1269 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12260 | 2.8607e-06 | 0.0014747  |   0.013668 |     -1.158 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7463 | 3.2148e-06 | 0.0014132  |  0.0077692 |    -1.0979 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8533 | 0.00012236 | 0.0014609  |  -0.096424 |     -1.127 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12260 | 2.9513e-06 | 0.0014747  |   0.013764 |     -1.158 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7463 | 3.1852e-06 | 0.0014133  |  0.0078034 |    -1.0981 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4964 | 4.8279e-05 | 0.0014427  |  -0.047219 |    -1.1071 |
@@ -2420,7 +2420,7 @@ RiTkGeomEffsLong                       INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsLong/Rich2Gas/proton/eff    | "Rich2Gas proton Geom. Eff. (>0)"             |        190 |    0.67495 | 0.073617   |    -1.1014 |     2.4139 |
 RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeomEffsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         25 |      0.665 | 0.058515   |     0.3402 |   -0.66246 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         25 |     0.6654 | 0.058342   |    0.32648 |   -0.64617 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        457 |    0.66489 | 0.054706   |    -1.8073 |     6.5633 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        150 |     0.6748 | 0.051581   |   -0.65014 |     1.0504 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        457 |    0.66863 | 0.060425   |     -1.801 |     5.9363 |
@@ -2467,7 +2467,7 @@ RiTkSignalYieldsLong                   INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0);Photon..." |        190 |     16.531 | 10.680     |    0.10438 |    -1.2244 |
 RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         25 |     31.888 | 19.532     |   0.061596 |    -1.3122 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         25 |      31.92 | 19.559     |   0.060097 |    -1.3179 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        457 |     59.714 | 5.2271     |    -1.4896 |       5.37 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        150 |     38.208 | 16.780     |   -0.58958 |   -0.49947 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        457 |     46.698 | 13.048     |   -0.78828 |   -0.20237 |
@@ -2494,10 +2494,10 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        418 |     3.1259 | 17.420     |   -0.27227 |    0.41348 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        418 |     3.0966 | 17.187     |   -0.23506 |    0.44331 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        418 |     3.0941 | 17.191     |   -0.23527 |    0.44193 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        457 |    -18.232 | 17.662     |   0.089113 |   -0.46128 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        418 |     3.0172 | 16.435     |   -0.35929 |     0.7578 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        457 |    -4.5329 | 10.214     |   0.071499 |     3.4812 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        457 |    -4.5329 | 10.214     |   0.071556 |     3.4807 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        418 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        418 |      3.368 | 17.092     |   -0.27237 |    0.50394 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2531,11 +2531,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1771 |  -0.017956 | 0.23690    |    0.13303 |   -0.39785 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43605 |   0.020338 | 0.70123    |     2.4368 |     67.958 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43605 |   0.020329 | 0.70123    |     2.4369 |      67.96 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      11565 |   -0.01022 | 0.22976    |   0.034131 |   -0.18054 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38947 |  0.0011561 | 0.53054    |  -0.023174 |     117.98 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33471 |   0.012517 | 0.52192    |     4.4697 |     62.217 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5035 |  -0.016246 | 0.22495    |   0.096305 |   -0.68108 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38947 |  0.0011459 | 0.53053    |  -0.023152 |     117.99 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33471 |   0.012505 | 0.52191    |       4.47 |     62.222 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5035 |  -0.016326 | 0.22495    |   0.097087 |   -0.68079 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichPIDMonDownstream10to70/evOK         | "Event Success V Failures;Event has PIDs;..." |         89 |    0.95506 | 0.20718    |    -4.3928 |     17.297 |
@@ -3060,7 +3060,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | ALL/vertex/ppull                              | "p pull"                                      |      20192 | -0.0087983 | 0.99786    |    0.39073 |     6.0589 |
  | ALL/vertex/qop_res                            | "qop"                                         |      20192 |-0.00088889 | 0.011848   |    0.11946 |    -1.1835 |
  | ALL/vertex/qoppull                            | "qop pull"                                    |      20192 | -0.0044378 | 0.26032    |    -5.0538 |     165.78 |
- | ALL/vertex/txpull                             | "tx pull"                                     |      20192 |   0.012989 | 1.3554     |   0.047083 |     1.7619 |
+ | ALL/vertex/txpull                             | "tx pull"                                     |      20192 |   0.012994 | 1.3554     |   0.047087 |      1.762 |
  | ALL/vertex/txres                              | "tx resolution"                               |      20192 | 2.2368e-06 | 0.00076541 |-0.00030464 |     1.7339 |
  | ALL/vertex/typull                             | "ty pull"                                     |      20192 |-0.00016539 | 1.4232     |  -0.015988 |     1.6385 |
  | ALL/vertex/tyres                              | "ty resolution"                               |      20192 | 1.8243e-06 | 0.00079542 |  -0.013593 |     1.4094 |
@@ -3289,8 +3289,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4552 |      55708 | 21431.     |     1.1335 |    0.56836 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7089 |     8879.2 | 10620.     |     4.0581 |     23.099 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        451 |      58419 | 19160.     |    0.95676 |   -0.20549 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7089 |     8879.3 | 10620.     |     4.0581 |     23.099 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        451 |      58419 | 19160.     |    0.95677 |    -0.2055 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        451 |     9764.6 | 11595.     |     3.4685 |     16.776 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        451 |      24130 | 15739.     |     2.3742 |     6.7389 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        451 |      10735 | 12141.     |     3.2701 |     14.883 |
@@ -3347,13 +3347,13 @@ RiMCTkResLong                          INFO 1D profile histograms in directory "
 RiMCTkResUpstream                      INFO 1D profile histograms in directory "RiMCTkResUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |         10 |      13833 | 6776.6     |   -0.68946 |    -1.4297 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39513 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39512 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         77 |      17991 | 14241.     |     2.1682 |     7.2303 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         77 | 1.8707e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         77 | 1.8708e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        289 |      20828 | 18155.     |     2.0404 |     6.0075 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        289 | 1.2012e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        289 | 1.2011e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         52 |      25298 | 22411.     |     1.3914 |    0.97937 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |     -60486 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |     -60517 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      54393 | 9745.3     |   -0.70898 |    -1.2183 |
@@ -3384,12 +3384,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        180 |      56315 | 18073.     |     0.6713 |   -0.62771 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56534 |   -0.95197 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |       9435 | 10701.     |       3.07 |     12.513 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      24979 | 14527.     |     1.8636 |     3.7396 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11119 | 11558.     |     2.7402 |     9.9275 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12859 | 12168.     |     2.5285 |     8.3888 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37403 | 16008.     |      1.231 |     1.0583 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57146 |   -0.96665 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |     9437.2 | 10715.     |     3.0829 |     12.651 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      24990 | 14568.     |      1.877 |     3.8139 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11122 | 11574.     |     2.7528 |     10.047 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12862 | 12187.     |     2.5411 |      8.498 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37432 | 16084.     |      1.245 |     1.1007 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      53951 | 9986.7     |   -0.63839 |    -1.3253 |
@@ -3420,12 +3420,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        192 |      56075 | 18108.     |    0.67865 |   -0.61403 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57993 |   -0.92795 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |       9435 | 10701.     |       3.07 |     12.513 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        149 |      24880 | 14510.     |     1.8688 |     3.7694 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11087 | 11545.     |      2.745 |     9.9631 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        421 |      12801 | 12150.     |     2.5343 |       8.43 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         66 |      37217 | 16001.     |     1.2384 |     1.0828 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58628 |   -0.94176 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |     9437.2 | 10715.     |     3.0829 |     12.651 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        149 |      24891 | 14550.     |     1.8821 |      3.844 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11090 | 11561.     |     2.7576 |     10.083 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        421 |      12804 | 12169.     |     2.5469 |     8.5394 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         66 |      37246 | 16077.     |     1.2524 |     1.1256 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      53887 | 9849.7     |    -0.6168 |    -1.3483 |
@@ -3456,12 +3456,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        180 |      56271 | 18055.     |    0.67931 |   -0.60195 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      56966 | 14706.     |    0.61715 |   -0.86093 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |     9551.8 | 10838.     |     3.0468 |      12.25 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      25142 | 14622.     |     1.8458 |     3.6441 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11227 | 11695.     |      2.721 |     9.7237 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12976 | 12309.     |       2.51 |     8.2041 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37730 | 16296.     |     1.2012 |    0.92985 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57076 | 14871.     |    0.62431 |   -0.87404 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        450 |       9554 | 10852.     |     3.0591 |      12.38 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      25153 | 14662.     |     1.8585 |     3.7138 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        450 |      11230 | 11711.     |      2.733 |     9.8359 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12980 | 12327.     |     2.5219 |     8.3062 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37760 | 16372.     |     1.2143 |    0.96744 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |        372 |-1.6265e+13 | 0.0000     |          0 |          0 |
@@ -3500,12 +3500,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       6944 |   0.027899 | 0.0028742  |    -2.3541 |     7.1048 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1771 |-1.1878e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43605 |-3.3913e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      11565 |-1.6374e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38947 | 2.9865e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33471 | 5.0857e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5035 |-9.3495e+11 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1771 |-2.1073e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43605 |-1.5694e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      11565 |-2.1234e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38947 | 1.6612e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33471 | 3.3983e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5035 |-9.6626e+11 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1577 |     1.1552 | 1.0291     |    0.84914 |    0.97941 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1552 |   0.047494 | 0.0071983  |     -2.022 |     4.1187 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -3693,15 +3693,15 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4140 | 0.00044994 | 0.062399   |    0.11237 |     2.2888 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2355 | -0.0023653 | 0.13025    |   0.084986 |    -1.6171 |
  | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4086 |  0.0014537 | 0.071720   |     -0.229 |     1.1505 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4140 | 5.2722e-07 | 0.077826   |    0.11813 |     1.0531 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4140 | 5.2106e-07 | 0.077826   |    0.11813 |     1.0531 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2656 |    0.18373 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4381 |    0.50843 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4436 |   -0.26915 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2346 | 0.00069799 | 0.10885    |  -0.010312 |    -1.3158 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4077 |  0.0021568 | 0.056744   |   -0.12875 |     2.2385 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4131 | 0.00042311 | 0.061766   |    0.11265 |     2.3685 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2346 |  0.0012591 | 0.12304    |  -0.015393 |    -1.5113 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4077 | 0.00043095 | 0.074683   |   -0.10653 |    0.99263 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2346 |   0.001259 | 0.12304    |  -0.015393 |    -1.5113 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4077 | 0.00043096 | 0.074683   |   -0.10653 |    0.99263 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4131 | -0.0018963 | 0.080106   |   0.083013 |     1.1427 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4376 | -0.0010931 | 0.053443   |  -0.045386 |     1.7888 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4431 |   0.007912 | 0.057227   |    0.44685 |      1.789 |
@@ -3738,10 +3738,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       3187 |      10343 | 12789.     |     2.6598 |     7.9334 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       3210 |   0.016144 | 2.1084     |   0.002611 |    -1.0934 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        489 |      10220 | 11974.     |      2.632 |     7.9615 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        498 |  -0.023224 | 1.8137     |  0.0074842 |    -1.0811 |
- | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        459 |      2.667 | 0.53427    |     1.1382 |    0.95461 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        489 |       5557 | 5618.9     |     6.5706 |      62.78 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        498 |  -0.024346 | 1.8168     |  -0.029969 |    -1.0139 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        498 |  -0.023225 | 1.8137     |  0.0074849 |    -1.0811 |
+ | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        459 |      2.667 | 0.53426    |     1.1382 |    0.95461 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        489 |       5557 | 5618.9     |     6.5707 |     62.781 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        498 |  -0.024349 | 1.8168     |  -0.029967 |    -1.0139 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6141 |     8326.7 | 11942.     |     1.7466 |     1.9978 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6141 |   -0.10942 | 1.8056     |   0.029543 |    -1.1587 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       4278 |     3.1664 | 0.95970    |    0.52295 |    -1.1726 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 3ab7971de6a..b7a5ac58e7b 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -292,7 +292,7 @@ TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has
    | BeforeMagnetRegion/Rich1/lvRich1Mirror1Master           | X0 | 12      0.00010177602   0.00023102938 0               0.000810144 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | mm | 105     45.751938           65.074414 0.46506893          315.106 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 105     0.13056566         0.18669417 0                  0.903066 |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 867     0.013996561       0.050288989 4.654602e-11       0.438150 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 867     0.013996562       0.050288989 4.654602e-11       0.438150 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | X0 | 867     0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | mm | 1       0.091978466                 0 0.091978466       0.0919784 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | X0 | 1       0                           0 0                           |
@@ -1321,9 +1321,9 @@ TrackBestTrackCreator_4472c1b6         INFO Number of counters : 32
  | "Ttrack.ghostProbability"                       |      2994 |   274.4687 |   0.091673 |
  | "Ttrack.numOutliers"                            |      2994 |        976 |    0.32599 |
  |*"Upstream.badChisq"                             |       688 |        181 |( 26.30814 +- 1.678652)% |
- | "Upstream.chisqProbSum"                         |       688 |   206.9273 |    0.30077 |
+ | "Upstream.chisqProbSum"                         |       688 |   206.9274 |    0.30077 |
  |*"Upstream.flipCharge"                           |       688 |         16 |( 2.325581 +- 0.5745952)% |
- | "Upstream.ghostProbability"                     |       688 |   204.9677 |    0.29792 |
+ | "Upstream.ghostProbability"                     |       688 |   204.9678 |    0.29792 |
  | "Upstream.numOutliers"                          |       688 |        538 |    0.78198 |
  |*"Velo.badChisq"                                 |      5852 |       1363 |( 23.29118 +- 0.5525432)% |
  | "Velo.chisqProbSum"                             |      5852 |   1873.694 |    0.32018 |
@@ -1701,19 +1701,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      34643 |   0.028099 | 0.0023346  |     -2.532 |     10.175 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      87024 | 2.4515e-05 | 0.0014037  | -0.0088344 |    -1.0198 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      40271 | 1.6431e-05 | 0.0013633  |  0.0032538 |   -0.94198 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      87024 | 1.7587e-05 | 0.0014266  | -0.0066094 |    -1.0596 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      52639 | 2.7731e-06 | 0.0013993  |  0.0099764 |     -1.012 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79518 | 5.4549e-05 | 0.0015254  |  -0.045757 |    -1.2424 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      36847 | 5.3659e-05 | 0.0015277  |  -0.048805 |    -1.2564 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79518 | 4.7402e-05 | 0.0015212  |  -0.041303 |    -1.2322 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      48726 | 3.8155e-05 | 0.0015221  |  -0.031763 |    -1.2445 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-3.8219e-05 | 0.0011045  |   0.041279 |   -0.40094 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3424 |-6.1265e-05 | 0.00092580 |    0.05641 |   -0.11998 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-3.8219e-05 | 0.0011045  |   0.041279 |   -0.40094 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-6.7586e-05 | 0.0011084  |   0.047389 |   -0.39273 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3913 |-9.9824e-05 | 0.00095058 | -0.0030621 |   -0.13806 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      87024 | 2.4243e-05 | 0.0014035  | -0.0089588 |    -1.0197 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      40271 | 1.6395e-05 | 0.0013633  |  0.0032043 |   -0.94186 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      87024 | 1.7325e-05 | 0.0014265  | -0.0066943 |    -1.0596 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      52639 |  2.744e-06 | 0.0013994  |   0.009914 |    -1.0119 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79518 | 5.4143e-05 | 0.0015252  |  -0.045805 |    -1.2423 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      36847 | 5.3629e-05 | 0.0015278  |  -0.048886 |    -1.2563 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      79518 | 4.7048e-05 | 0.0015211  |  -0.041337 |    -1.2322 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      48726 | 3.8133e-05 | 0.0015222  |  -0.031855 |    -1.2444 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-3.8201e-05 | 0.0011044  |   0.041428 |   -0.40085 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3424 |-6.1311e-05 | 0.00092576 |   0.056609 |   -0.11975 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-3.8201e-05 | 0.0011044  |   0.041428 |   -0.40085 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7506 |-6.7576e-05 | 0.0011084  |    0.04755 |   -0.39267 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3913 |-9.9873e-05 | 0.00095053 | -0.0028816 |    -0.1378 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      79518 |     3.1255 | 1.8122     |   0.018632 |    -1.1932 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7506 |      3.126 | 1.8134     |  0.0084382 |    -1.2074 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      79518 |   0.039186 | 0.011732   |   -0.64199 |   -0.61787 |
@@ -2268,101 +2268,101 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      87841 |   0.026995 | 0.0044867  |    -1.6258 |     2.3222 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44193 | 3.0866e-06 | 0.0014272  |  -0.011207 |     -1.066 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      26111 |-6.2785e-06 | 0.0013987  |  0.0037676 |    -1.0071 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44193 | 3.0866e-06 | 0.0014272  |  -0.011207 |     -1.066 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44193 | 2.7894e-06 | 0.0014271  |   -0.01136 |    -1.0659 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      26111 |-6.3296e-06 | 0.0013988  |  0.0035985 |    -1.0069 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      44193 | 2.7894e-06 | 0.0014271  |   -0.01136 |    -1.0659 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2231 | 0.00015234 | 0.0013718  |   -0.10452 |   -0.96415 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2231 | 0.00015248 | 0.0013719  |   -0.10457 |   -0.96421 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1499 | 0.00044562 | 0.0014600  |   -0.45664 |   -0.98629 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2684 |-5.2283e-05 | 0.0014888  |   0.039904 |    -1.2118 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4362 | 9.9385e-06 | 0.0014813  |  -0.046777 |    -1.1568 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9524 | 7.6798e-06 | 0.0014253  |  -0.016251 |    -1.0576 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14124 |-5.6783e-05 | 0.0014251  |   0.044259 |    -1.0508 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8592 |-2.6524e-06 | 0.0013845  |  0.0020274 |   -0.99064 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4362 | 9.8769e-06 | 0.0014813  |  -0.046694 |    -1.1569 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9524 | 7.6798e-06 | 0.0014254  |  -0.016205 |    -1.0576 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14124 |-5.7682e-05 | 0.0014245  |   0.043962 |    -1.0508 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8592 |-2.8213e-06 | 0.0013846  |   0.001464 |   -0.98994 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2231 | 0.00015234 | 0.0013718  |   -0.10452 |   -0.96415 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2231 | 0.00015248 | 0.0013719  |   -0.10457 |   -0.96421 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1499 | 0.00044562 | 0.0014600  |   -0.45664 |   -0.98629 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2684 |-5.2283e-05 | 0.0014888  |   0.039904 |    -1.2118 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4362 | 9.9385e-06 | 0.0014813  |  -0.046777 |    -1.1568 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9524 | 7.6798e-06 | 0.0014253  |  -0.016251 |    -1.0576 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14124 |-5.6783e-05 | 0.0014251  |   0.044259 |    -1.0508 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8592 |-2.6524e-06 | 0.0013845  |  0.0020274 |   -0.99064 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      87024 | 1.7587e-05 | 0.0014266  | -0.0066094 |    -1.0596 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      52639 | 2.7731e-06 | 0.0013993  |  0.0099764 |     -1.012 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      87024 | 1.7587e-05 | 0.0014266  | -0.0066094 |    -1.0596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4362 | 9.8769e-06 | 0.0014813  |  -0.046694 |    -1.1569 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9524 | 7.6798e-06 | 0.0014254  |  -0.016205 |    -1.0576 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      14124 |-5.7682e-05 | 0.0014245  |   0.043962 |    -1.0508 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8592 |-2.8213e-06 | 0.0013846  |   0.001464 |   -0.98994 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      87024 | 1.7325e-05 | 0.0014265  | -0.0066943 |    -1.0596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      52639 |  2.744e-06 | 0.0013994  |   0.009914 |    -1.0119 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      87024 | 1.7325e-05 | 0.0014265  | -0.0066943 |    -1.0596 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      87024 |     3.1256 | 1.8123     |   0.017751 |    -1.1944 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      87024 |    0.03981 | 0.011596   |   -0.72355 |   -0.50506 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42831 | 3.1193e-05 | 0.0014259  | -0.0022325 |    -1.0544 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      26528 |  1.144e-05 | 0.0013998  |   0.015878 |    -1.0171 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42831 | 3.1193e-05 | 0.0014259  | -0.0022325 |    -1.0544 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42831 | 3.0963e-05 | 0.0014257  | -0.0022506 |    -1.0544 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      26528 | 1.1432e-05 | 0.0013998  |   0.015921 |    -1.0171 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      42831 | 3.0963e-05 | 0.0014257  | -0.0022506 |    -1.0544 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2164 | 1.8973e-05 | 0.0014206  |  -0.039127 |    -1.0601 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        714 |   0.000208 | 0.0013724  |  -0.058162 |   -0.87409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1246 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2349 |    3.8e-05 | 0.0014573  |  -0.011936 |    -1.0806 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2349 | 3.7882e-05 | 0.0014572  |  -0.011721 |    -1.0804 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4539 |-2.2213e-05 | 0.0014412  |   0.025851 |    -1.0585 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8666 | 8.9274e-05 | 0.0014138  |  -0.027066 |    -1.0635 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      14099 | 1.7954e-05 | 0.0014338  |  0.0044262 |    -1.0685 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8619 | 1.2047e-06 | 0.0014076  |   0.025872 |    -0.9964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8666 | 8.9274e-05 | 0.0014139  |  -0.027143 |    -1.0636 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      14099 | 1.7206e-05 | 0.0014333  |  0.0044091 |    -1.0684 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8619 | 1.2608e-06 | 0.0014076  |   0.025858 |   -0.99633 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2164 | 1.8973e-05 | 0.0014206  |  -0.039127 |    -1.0601 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        714 |   0.000208 | 0.0013724  |  -0.058162 |   -0.87409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1246 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2349 |    3.8e-05 | 0.0014573  |  -0.011936 |    -1.0806 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2349 | 3.7882e-05 | 0.0014572  |  -0.011721 |    -1.0804 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4539 |-2.2213e-05 | 0.0014412  |   0.025851 |    -1.0585 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8666 | 8.9274e-05 | 0.0014138  |  -0.027066 |    -1.0635 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      14099 | 1.7954e-05 | 0.0014338  |  0.0044262 |    -1.0685 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8619 | 1.2047e-06 | 0.0014076  |   0.025872 |    -0.9964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8666 | 8.9274e-05 | 0.0014139  |  -0.027143 |    -1.0636 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      14099 | 1.7206e-05 | 0.0014333  |  0.0044091 |    -1.0684 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8619 | 1.2608e-06 | 0.0014076  |   0.025858 |   -0.99633 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 43
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1893e-05 | 0.0014038  |    0.01835 |    -1.0162 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1893e-05 | 0.0014038  |    0.01835 |    -1.0162 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1893e-05 | 0.0014038  |    0.01835 |    -1.0162 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1868e-05 | 0.0014039  |   0.018253 |    -1.0162 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1868e-05 | 0.0014039  |   0.018253 |    -1.0162 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17632 |-1.1868e-05 | 0.0014039  |   0.018253 |    -1.0162 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       7090 |-2.7069e-05 | 0.0014237  |   0.021386 |    -1.0272 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4789 |  1.126e-05 | 0.0013739  |  -0.015974 |   -0.98842 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       7090 |-2.7034e-05 | 0.0014238  |   0.021325 |    -1.0273 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4789 | 1.1197e-05 | 0.0013739  |  -0.016504 |   -0.98781 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       7090 |-2.7069e-05 | 0.0014237  |   0.021386 |    -1.0272 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4789 |  1.126e-05 | 0.0013739  |  -0.015974 |   -0.98842 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      36363 | 1.8839e-06 | 0.0013953  |   0.012434 |    -1.0012 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      36363 | 1.8839e-06 | 0.0013953  |   0.012434 |    -1.0012 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      36363 | 1.8839e-06 | 0.0013953  |   0.012434 |    -1.0012 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       7090 |-2.7034e-05 | 0.0014238  |   0.021325 |    -1.0273 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4789 | 1.1197e-05 | 0.0013739  |  -0.016504 |   -0.98781 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      36363 | 1.8897e-06 | 0.0013954  |   0.012417 |    -1.0012 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      36363 | 1.8897e-06 | 0.0013954  |   0.012417 |    -1.0012 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      36363 | 1.8897e-06 | 0.0013954  |   0.012417 |    -1.0012 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      36363 |     3.1329 | 1.8068     |  0.0061204 |    -1.1949 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      36363 |   0.039782 | 0.011658   |   -0.73111 |   -0.47992 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4143e-05 | 0.0013875  |  0.0076087 |   -0.98771 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4143e-05 | 0.0013875  |  0.0076087 |   -0.98771 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4143e-05 | 0.0013875  |  0.0076087 |   -0.98771 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4132e-05 | 0.0013876  |  0.0076668 |   -0.98765 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4132e-05 | 0.0013876  |  0.0076668 |   -0.98765 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      18731 | 1.4132e-05 | 0.0013876  |  0.0076668 |   -0.98765 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1127 | -1.717e-05 | 0.0013871  |   0.025791 |    -1.0022 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        225 |-0.00012143 | 0.0012416  |    0.24491 |   -0.61961 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        225 |  -0.000122 | 0.0012413  |     0.2461 |   -0.61714 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1048 |-4.5878e-05 | 0.0013408  |    0.11272 |   -0.85896 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4022 | 0.00010761 | 0.0013895  |  -0.034134 |     -1.021 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7566 | 6.7646e-06 | 0.0014002  |  -0.019291 |    -1.0093 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4022 | 0.00010753 | 0.0013896  |  -0.034134 |     -1.021 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7566 |  6.826e-06 | 0.0014002  |  -0.019197 |    -1.0091 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4703 |-3.8918e-05 | 0.0013824  |   0.034093 |   -0.95495 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1127 | -1.717e-05 | 0.0013871  |   0.025791 |    -1.0022 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        225 |-0.00012143 | 0.0012416  |    0.24491 |   -0.61961 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        225 |  -0.000122 | 0.0012413  |     0.2461 |   -0.61714 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1048 |-4.5878e-05 | 0.0013408  |    0.11272 |   -0.85896 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4022 | 0.00010761 | 0.0013895  |  -0.034134 |     -1.021 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7566 | 6.7646e-06 | 0.0014002  |  -0.019291 |    -1.0093 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4022 | 0.00010753 | 0.0013896  |  -0.034134 |     -1.021 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7566 |  6.826e-06 | 0.0014002  |  -0.019197 |    -1.0091 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4703 |-3.8918e-05 | 0.0013824  |   0.034093 |   -0.95495 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2553,7 +2553,7 @@ RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        448 |    0.57955 | 17.622     |   -0.25153 |   -0.12991 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        476 |    -17.427 | 15.950     |   -0.17161 |   -0.84213 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        448 |     1.1728 | 16.911     |   -0.21715 |    0.10802 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        475 |    -4.9232 | 9.0482     |   -0.23089 |     3.6163 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        475 |    -4.9253 | 9.0473     |    -0.2304 |     3.6186 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        448 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        448 |    0.88182 | 17.729     |   -0.24522 |  -0.054973 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2586,11 +2586,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
  | /RICH/RichMassRingsLong/Rich2Gas/proton/pntSe | "Rich2Gas proton Ring - Segment local poi..." |      21632 | -0.0008321 | 7.0056     |    0.87658 |    0.72198 |
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1416 |  -0.020621 | 0.20454    |    0.36555 |     -1.483 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43904 |   0.012595 | 0.64302    |     1.6983 |     58.996 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1416 |  -0.020904 | 0.20451    |    0.36849 |    -1.4806 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43904 |   0.012586 | 0.64302    |     1.6983 |     58.996 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12832 |  -0.020168 | 0.22027    |    0.13277 |   -0.80529 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38624 |  0.0037931 | 0.52427    |    0.89054 |     111.14 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33752 |-0.00018974 | 0.44427    |    0.92184 |     35.603 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38624 |  0.0037828 | 0.52427    |    0.89059 |     111.14 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33752 | -0.0002016 | 0.44427    |    0.92192 |     35.603 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5560 |  -0.021367 | 0.20512    |    0.19059 |    -1.5099 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2958,7 +2958,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        551 |      14622 | 16481.     |     2.1152 |     4.8106 |
  | Upstream/phi                                  | "phi"                                         |        551 | -0.0099208 | 1.8006     |   0.030956 |    -1.0535 |
  | Upstream/probChi2                             | "probChi2"                                    |        551 |    0.37599 | 0.31870    |    0.51278 |    -1.0991 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        551 |      14713 | 16835.     |      2.443 |     7.1854 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        551 |      14716 | 16837.     |     2.4416 |     7.1785 |
  | Upstream/pt                                   | "pt"                                          |        551 |     852.18 | 583.28     |     3.3669 |     15.074 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        551 | 4.1742e-06 | 0.00020985 |     0.0164 |   -0.52473 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        551 |    -4.7763 | 0.39107    |  -0.043883 |    -1.1755 |
@@ -3346,7 +3346,7 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4645 |      53902 | 18204.     |      1.185 |     1.1308 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7506 |     8006.7 | 10344.     |     4.4873 |     33.009 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7506 |     8006.6 | 10344.     |     4.4873 |      33.01 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        475 |      57238 | 24801.     |     1.3245 |    0.38146 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        475 |      10746 | 12254.     |     3.5133 |     19.687 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        475 |      24333 | 15495.     |     3.0358 |     12.625 |
@@ -3406,11 +3406,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |          8 |      18934 | 8263.8     |   -0.55182 |    -0.7941 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |          8 |     -48936 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         87 |      17396 | 10324.     |    0.39554 |   -0.70053 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         87 |      25982 | 6713.7     |    0.25137 |    -1.1592 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         87 |      25982 | 6713.7     |    0.25136 |    -1.1592 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        297 |      19683 | 16521.     |      2.266 |     8.0069 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        297 |      59930 | 33641.     |     -0.419 |   -0.94578 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        297 |      59930 | 33641.     |   -0.41898 |   -0.94581 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         52 |      25702 | 17835.     |    0.59775 |   -0.58183 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |      28865 | 11921.     |    0.30569 |     0.5729 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |      28865 | 11921.     |    0.30569 |    0.57287 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      54497 | 9606.3     |   -0.74084 |    -1.1152 |
@@ -3441,7 +3441,7 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        333 |      55280 | 16287.     |    0.72064 |   -0.36241 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      50887 | 13244.     |     1.1006 |     0.1678 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      50887 | 13244.     |     1.1006 |    0.16784 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        473 |      10199 | 10411.     |     2.2976 |      6.985 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        168 |      24298 | 11821.     |     1.6471 |     3.6789 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        472 |      11910 | 11007.     |     2.0436 |     5.6081 |
@@ -3477,7 +3477,7 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        348 |      55097 | 16318.     |    0.72401 |   -0.35298 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      50485 | 13204.     |     1.1322 |    0.25702 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      50485 | 13204.     |     1.1322 |    0.25706 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        473 |      10199 | 10411.     |     2.2977 |      6.985 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        172 |      24226 | 11817.     |     1.6486 |     3.6877 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        473 |      11879 | 10999.     |     2.0472 |      5.626 |
@@ -3513,7 +3513,7 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        333 |      55378 | 16342.     |     0.7161 |   -0.37561 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      51010 | 13118.     |      1.099 |    0.20253 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         24 |      51010 | 13118.     |      1.099 |    0.20257 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        473 |      10326 | 10515.     |      2.276 |     6.8336 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        168 |      24457 | 11932.     |     1.6227 |     3.5489 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        472 |      12040 | 11103.     |     2.0268 |     5.4983 |
@@ -3557,12 +3557,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       7933 |   0.027912 | 0.0028422  |    -2.3445 |     7.1236 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1416 | -6.676e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43904 |-1.7955e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12832 |-2.8473e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38624 |-6.1347e+11 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33752 | 3.5565e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5560 | 1.5168e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1416 | 8.5556e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43904 | -2.001e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12832 | 1.9471e+15 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38624 |-6.5348e+11 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33752 |-5.8499e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5560 | 4.6998e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1683 |     1.0812 | 0.94444    |     0.5708 |   0.096631 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1646 |   0.047614 | 0.0072000  |    -2.1713 |     4.8818 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -3748,19 +3748,19 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4752 |   -0.24532 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4806 |    -1.3736 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3034 |   0.022101 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4752 |   0.035509 | 0.11916    |    0.81773 |    -1.1113 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4806 |   0.086346 | 0.0000     |          0 |          0 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4752 |   0.035508 | 0.11916    |    0.81773 |    -1.1113 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4806 |   0.086343 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3039 |   -0.18784 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4753 |    0.59831 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4807 |  -0.014055 | 0.25384    |   0.040791 |    -2.5582 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3032 |  -0.039244 | 0.024220   |     119.08 |     323.95 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4750 |        4.6 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4807 |  -0.014056 | 0.25385    |   0.040799 |    -2.5582 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3032 |  -0.039245 | 0.024218   |      119.1 |     324.06 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4750 |     4.5999 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4804 |    0.15976 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3032 |    0.23256 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4750 |   -0.15791 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4804 |   -0.13582 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4753 |   0.090917 | 0.13590    |    -2.0846 |     3.0068 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4807 |   -0.50209 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4753 |    0.09092 | 0.13590    |    -2.0847 |     3.0072 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4807 |    -0.5021 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4750 |     0.1827 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4804 |    -10.227 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       8022 | -0.0023496 | 0.18386    |   0.042527 |   -0.68283 |
@@ -3795,9 +3795,9 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       2994 |   0.022325 | 2.1341     | -0.0085494 |    -1.1165 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        543 |      12094 | 15084.     |     2.5218 |     6.9235 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        551 |   0.013024 | 1.7845     |  -0.032547 |    -1.0047 |
- | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        517 |     3.1169 | 0.87714    |     0.5292 |    -1.0399 |
+ | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        517 |     3.1169 | 0.87714    |    0.52921 |    -1.0399 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        543 |      12021 | 15001.     |     2.6338 |     8.0451 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        551 |   0.014505 | 1.7825     | -0.0077653 |    -1.0042 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        551 |   0.014504 | 1.7825     | -0.0077653 |    -1.0042 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       5851 |     7849.8 | 11943.     |     1.8848 |     2.4241 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       5852 |   -0.12388 | 1.8127     |   0.035908 |    -1.1644 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       3984 |      3.056 | 0.91412    |    0.73265 |   -0.80382 |
@@ -3815,7 +3815,7 @@ TrackPV2HalfMonitor                    INFO 1D profile histograms in directory "
  | PV left-right delta z versus z                | "PV left-right delta z versus z"              |          2 |     66.227 | 19.641     |    0.38417 |    -1.8524 |
 TrackVPOverlapMonitor                  INFO 1D profile histograms in directory "TrackVPOverlapMonitor" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |        996 |     336.31 | 184.98     |   0.087024 |    -1.4724 |
+ | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |        996 |     336.31 | 184.98     |   0.087023 |    -1.4724 |
  | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |        996 |    -354.82 | 0.0000     |          0 |          0 |
 TrackVertexMonitor                     INFO 1D profile histograms in directory "TrackVertexMonitor" : 28
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
index b39d56ab517..6da07e054b0 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fast_reco_with_mcchecking.ref.x86_64_v3-opt
@@ -1273,9 +1273,9 @@ TrackBestTrackCreator_4472c1b6         INFO Number of counters : 32
  | "Ttrack.ghostProbability"                       |      3210 |   289.0763 |   0.090055 |
  | "Ttrack.numOutliers"                            |      3210 |       1072 |    0.33396 |
  |*"Upstream.badChisq"                             |       828 |        462 |( 55.79710 +- 1.725902)% |
- | "Upstream.chisqProbSum"                         |       828 |    131.112 |    0.15835 |
+ | "Upstream.chisqProbSum"                         |       828 |   131.1121 |    0.15835 |
  |*"Upstream.flipCharge"                           |       828 |         37 |( 4.468599 +- 0.7180317)% |
- | "Upstream.ghostProbability"                     |       828 |   423.4425 |    0.51140 |
+ | "Upstream.ghostProbability"                     |       828 |   423.4424 |    0.51140 |
  | "Upstream.numOutliers"                          |       828 |       1031 |     1.2452 |
  |*"Velo.badChisq"                                 |      6144 |       1373 |( 22.34701 +- 0.5314509)% |
  | "Velo.chisqProbSum"                             |      6144 |   1980.567 |    0.32236 |
@@ -1661,23 +1661,23 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      29553 |    0.02795 | 0.0023102  |    -2.4368 |     9.4308 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      80012 | 2.4385e-05 | 0.0014499  |  -0.020392 |    -1.1194 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      31955 | 1.2516e-05 | 0.0014183  | -0.0076832 |    -1.0582 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      80012 | 2.9454e-05 | 0.0014572  |  -0.024082 |    -1.1285 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      42334 | 1.2235e-05 | 0.0014381  |  -0.012023 |    -1.0901 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      72923 | 1.4304e-05 | 0.0015262  |  -0.012686 |    -1.2355 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      80012 | 2.4675e-05 | 0.0014500  |  -0.020388 |    -1.1195 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      31955 |  1.251e-05 | 0.0014183  | -0.0076716 |    -1.0582 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      80012 | 2.9576e-05 | 0.0014572  |  -0.024102 |    -1.1286 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      42334 |  1.224e-05 | 0.0014380  |  -0.012026 |    -1.0901 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      72923 | 1.4505e-05 | 0.0015263  |  -0.012705 |    -1.2355 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      28863 | 1.0558e-05 | 0.0015396  |  -0.012457 |    -1.2522 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      72923 | 2.9413e-05 | 0.0015120  |  -0.023471 |    -1.2126 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      39040 | 2.5369e-05 | 0.0015221  |  -0.024933 |    -1.2248 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.7894e-05 | 0.0012535  |  -0.024597 |    -0.8319 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3092 | 1.6366e-05 | 0.0011427  |   0.024589 |   -0.65736 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.7894e-05 | 0.0012535  |  -0.024597 |    -0.8319 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 2.9578e-05 | 0.0012743  |  -0.026075 |   -0.85209 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3294 |-2.4482e-05 | 0.0011709  |  0.0037023 |   -0.67922 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      72923 | 2.9398e-05 | 0.0015120  |  -0.023477 |    -1.2126 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      39040 | 2.5382e-05 | 0.0015221  |  -0.024951 |    -1.2247 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.8388e-05 | 0.0012538  |  -0.024283 |   -0.83187 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3092 | 1.6349e-05 | 0.0011427  |    0.02463 |    -0.6574 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 4.8388e-05 | 0.0012538  |  -0.024283 |   -0.83187 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7089 | 3.0123e-05 | 0.0012746  |   -0.02576 |   -0.85208 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3294 |-2.4501e-05 | 0.0011709  |  0.0037468 |   -0.67926 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      72923 |     3.1175 | 1.8153     |   0.025808 |    -1.2009 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7089 |     3.1328 | 1.7921     | -0.0015522 |    -1.1874 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      72923 |   0.039235 | 0.011778   |   -0.63814 |   -0.63925 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       7089 |   0.046289 | 0.0077210  |    -1.7298 |     2.5341 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       7089 |   0.046289 | 0.0077211  |    -1.7298 |     2.5341 |
 RiCKResDownstream                      INFO 1D histograms in directory "RiCKResDownstream" : 137
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResDownstream/Rich1Gas/bottom/ckRes | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39962 | 0.00010251 | 0.0014318  |  -0.077932 |    -1.0931 |
@@ -2226,9 +2226,9 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      34814 |   0.027166 | 0.0043415  |    -1.7318 |     2.7362 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39909 | 5.4713e-06 | 0.0014563  |  -0.012912 |    -1.1216 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      19819 |-1.8741e-05 | 0.0014427  |    0.01976 |    -1.0912 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39909 | 5.4713e-06 | 0.0014563  |  -0.012912 |    -1.1216 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39909 | 5.4713e-06 | 0.0014563  |  -0.012936 |    -1.1216 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      19819 |-1.8718e-05 | 0.0014427  |    0.01973 |    -1.0912 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      39909 | 5.4713e-06 | 0.0014563  |  -0.012936 |    -1.1216 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1645 | 7.4776e-05 | 0.0014399  |  -0.092361 |    -1.0989 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2236,9 +2236,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1716 | 0.00011692 | 0.0014929  |  -0.072275 |    -1.2226 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2984 |  -8.92e-05 | 0.0013769  |   0.037337 |    -1.0064 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4994 | 3.6627e-05 | 0.0014301  |  -0.042317 |    -1.1159 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8784 |-2.3797e-05 | 0.0014572  |    0.03599 |     -1.133 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11593 | 1.7743e-05 | 0.0014589  |  -0.020033 |    -1.0981 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6924 |-1.8869e-05 | 0.0014810  |   -0.02037 |     -1.154 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8784 |-2.3674e-05 | 0.0014572  |   0.035905 |     -1.133 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11593 | 1.7743e-05 | 0.0014589  |  -0.020005 |    -1.0983 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6924 |-1.9054e-05 | 0.0014810  |  -0.020421 |    -1.1541 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1645 | 7.4776e-05 | 0.0014399  |  -0.092361 |    -1.0989 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2246,36 +2246,36 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1716 | 0.00011692 | 0.0014929  |  -0.072275 |    -1.2226 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2984 |  -8.92e-05 | 0.0013769  |   0.037337 |    -1.0064 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4994 | 3.6627e-05 | 0.0014301  |  -0.042317 |    -1.1159 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8784 |-2.3797e-05 | 0.0014572  |    0.03599 |     -1.133 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11593 | 1.7743e-05 | 0.0014589  |  -0.020033 |    -1.0981 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6924 |-1.8869e-05 | 0.0014810  |   -0.02037 |     -1.154 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      80012 | 2.9454e-05 | 0.0014572  |  -0.024082 |    -1.1285 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      42334 | 1.2235e-05 | 0.0014381  |  -0.012023 |    -1.0901 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      80012 | 2.9454e-05 | 0.0014572  |  -0.024082 |    -1.1285 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8784 |-2.3674e-05 | 0.0014572  |   0.035905 |     -1.133 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11593 | 1.7743e-05 | 0.0014589  |  -0.020005 |    -1.0983 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6924 |-1.9054e-05 | 0.0014810  |  -0.020421 |    -1.1541 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      80012 | 2.9576e-05 | 0.0014572  |  -0.024102 |    -1.1286 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      42334 |  1.224e-05 | 0.0014380  |  -0.012026 |    -1.0901 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      80012 | 2.9576e-05 | 0.0014572  |  -0.024102 |    -1.1286 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      80012 |     3.1188 | 1.8133     |   0.023416 |    -1.1998 |
- | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      80012 |   0.039871 | 0.011647   |   -0.71766 |   -0.53001 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      40103 | 4.9954e-05 | 0.0014576  |  -0.033694 |    -1.1343 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      22515 | 3.6793e-05 | 0.0014339  |  -0.037062 |    -1.0869 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      40103 | 4.9954e-05 | 0.0014576  |  -0.033694 |    -1.1343 |
+ | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      80012 |   0.039871 | 0.011647   |   -0.71766 |   -0.53002 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      40103 | 5.0179e-05 | 0.0014577  |  -0.033715 |    -1.1343 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      22515 | 3.6784e-05 | 0.0014339  |  -0.037045 |    -1.0869 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      40103 | 5.0179e-05 | 0.0014577  |  -0.033715 |    -1.1343 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1774 | -4.185e-05 | 0.0014370  |   0.066971 |    -1.0446 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1237 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2356 |   9.93e-05 | 0.0015074  |   -0.11478 |    -1.1622 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4867 | 9.6514e-05 | 0.0014605  |  -0.082742 |    -1.1192 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8728 |  0.0001222 | 0.0014610  |  -0.096136 |    -1.1274 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12462 | 2.6435e-06 | 0.0014745  |    0.01366 |    -1.1576 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1237 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2356 | 0.00010483 | 0.0015103  |    -0.1148 |    -1.1624 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4867 |  9.643e-05 | 0.0014604  |  -0.082785 |    -1.1193 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8728 | 0.00012218 | 0.0014609  |  -0.096179 |    -1.1274 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12462 | 2.6435e-06 | 0.0014745  |   0.013665 |    -1.1577 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7616 | 2.8625e-06 | 0.0014112  |  0.0079359 |    -1.0986 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1774 | -4.185e-05 | 0.0014370  |   0.066971 |    -1.0446 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1237 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2356 |   9.93e-05 | 0.0015074  |   -0.11478 |    -1.1622 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4867 | 9.6514e-05 | 0.0014605  |  -0.082742 |    -1.1192 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8728 |  0.0001222 | 0.0014610  |  -0.096136 |    -1.1274 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12462 | 2.6435e-06 | 0.0014745  |    0.01366 |    -1.1576 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1237 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2356 | 0.00010483 | 0.0015103  |    -0.1148 |    -1.1624 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4867 |  9.643e-05 | 0.0014604  |  -0.082785 |    -1.1193 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8728 | 0.00012218 | 0.0014609  |  -0.096179 |    -1.1274 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      12462 | 2.6435e-06 | 0.0014745  |   0.013665 |    -1.1577 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7616 | 2.8625e-06 | 0.0014112  |  0.0079359 |    -1.0986 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2296,27 +2296,27 @@ RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1198 |-3.2933e-06 | 0.0014528  |    0.01223 |    -1.1014 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1926 | 9.1663e-05 | 0.0014709  |  -0.076287 |      -1.15 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1192 | 7.7107e-05 | 0.0014072  |  -0.074893 |    -1.0739 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      11074 |     3.1268 | 1.8144     |   0.011834 |    -1.2037 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62054 |   -0.66614 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62053 |   -0.66615 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2423,7 +2423,7 @@ RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         25 |     0.6626 | 0.059952   |    0.45207 |   -0.65735 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        456 |     0.6632 | 0.055174   |    -1.7011 |     6.1824 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        150 |    0.67327 | 0.051209   |   -0.77128 |     2.6246 |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        456 |    0.66671 | 0.061578   |    -1.5626 |     4.9181 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        456 |    0.66669 | 0.061655   |    -1.5689 |     4.9382 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/pion/eff  | "Rich1Gas pion Geom. Eff. (>0)"               |        417 |      0.668 | 0.060746   |    -1.2342 |     5.1153 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/proton/ef | "Rich1Gas proton Geom. Eff. (>0)"             |         70 |    0.65657 | 0.060229   |  -0.088948 |   -0.34387 |
 RiTkMaterialDownstream                 INFO 1D histograms in directory "RiTkMaterialDownstream" : 2
@@ -2470,7 +2470,7 @@ RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         25 |       32.4 | 20.025     |   0.049382 |    -1.3547 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        456 |     59.582 | 5.2521     |    -1.4365 |     5.1797 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        150 |     38.128 | 16.655     |   -0.59455 |   -0.44137 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        456 |     46.556 | 13.010     |    -0.7935 |   -0.18191 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        456 |     46.554 | 13.011     |   -0.79318 |   -0.18332 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0);Photon Y..." |        417 |     41.501 | 17.198     |   -0.71062 |   -0.57925 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0);Photon..." |         70 |     32.229 | 17.941     |   0.047838 |    -1.1008 |
 RichDLLsDownstream                     INFO 1D histograms in directory "RichDLLsDownstream" : 7
@@ -2493,13 +2493,13 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsLong/proton/dll                 | "proton DLL"                                  |       3908 |    -2.5468 | 20.501     |  -0.060348 |   -0.12268 |
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        417 |     2.8741 | 17.391     |   -0.25886 |    0.32944 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        417 |     2.8227 | 17.201     |   -0.22998 |    0.35575 |
+ | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        417 |     2.8765 | 17.389     |   -0.25903 |    0.33087 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        417 |     2.8252 | 17.199     |   -0.23014 |    0.35719 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        456 |    -18.251 | 17.666     |   0.068274 |   -0.56584 |
- | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        417 |     2.8186 | 16.371     |   -0.37238 |    0.70677 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        456 |    -4.2907 | 10.043     |    0.35698 |      3.367 |
+ | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        417 |     2.8211 | 16.369     |   -0.37257 |     0.7086 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        456 |    -4.2885 | 10.052     |    0.36645 |     3.4045 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        417 |        0.5 | 0.0000     |          0 |          0 |
- | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        417 |     3.1186 | 17.023     |    -0.2778 |    0.45233 |
+ | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        417 |      3.121 | 17.021     |   -0.27796 |    0.45388 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |        352 |  -0.036364 | 0.20348    |    0.56341 |    -1.2203 |
@@ -3289,8 +3289,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4551 |      55783 | 21428.     |     1.1311 |    0.56272 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7089 |       8879 | 10619.     |     4.0583 |     23.101 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        450 |      58419 | 19160.     |    0.95679 |   -0.20546 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7089 |     8879.1 | 10619.     |     4.0582 |     23.101 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        450 |      58419 | 19160.     |    0.95678 |   -0.20548 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        450 |     9778.5 | 11605.     |     3.4648 |     16.741 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        450 |      24130 | 15739.     |     2.3742 |     6.7391 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        450 |      10751 | 12149.     |     3.2669 |     14.855 |
@@ -3353,7 +3353,7 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        289 |      20828 | 18155.     |     2.0404 |     6.0075 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        289 | 1.2002e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         52 |      25298 | 22411.     |     1.3914 |    0.97937 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |     -60678 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         52 |     -60672 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      54393 | 9745.3     |   -0.70898 |    -1.2183 |
@@ -3384,12 +3384,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        179 |      56365 | 18061.     |    0.67041 |   -0.62924 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57147 |   -0.96664 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9450.9 | 10724.     |     3.0792 |     12.622 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      24989 | 14568.     |      1.877 |      3.814 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11138 | 11581.     |     2.7502 |     10.028 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12878 | 12191.     |     2.5396 |     8.4874 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37433 | 16084.     |      1.245 |     1.1007 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56535 |   -0.95196 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9448.7 | 10710.     |     3.0663 |     12.483 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      24978 | 14527.     |     1.8636 |     3.7397 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11135 | 11565.     |     2.7376 |     9.9087 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12875 | 12172.     |      2.527 |     8.3783 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37403 | 16008.     |      1.231 |     1.0583 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      53951 | 9986.7     |   -0.63839 |    -1.3253 |
@@ -3420,12 +3420,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        191 |      56126 | 18096.     |     0.6776 |   -0.61567 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58629 |   -0.94174 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9450.9 | 10724.     |     3.0792 |     12.622 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        149 |      24891 | 14550.     |     1.8822 |     3.8441 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11106 | 11568.     |     2.7549 |     10.064 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        420 |      12820 | 12173.     |     2.5453 |     8.5285 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         66 |      37247 | 16077.     |     1.2524 |     1.1256 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57994 |   -0.92794 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9448.7 | 10710.     |     3.0663 |     12.483 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        149 |      24880 | 14510.     |     1.8688 |     3.7695 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11103 | 11552.     |     2.7424 |     9.9441 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        420 |      12817 | 12155.     |     2.5328 |     8.4192 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         66 |      37218 | 16001.     |     1.2384 |     1.0828 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |          7 |      54088 | 9806.9     |   -0.66856 |    -1.2803 |
@@ -3456,12 +3456,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        179 |      56425 | 18136.     |    0.67058 |   -0.62522 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57232 | 14841.     |    0.61524 |   -0.87852 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9550.2 | 10883.     |     3.0856 |     12.586 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      25170 | 14764.     |     1.8689 |     3.7318 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11233 | 11751.     |     2.7567 |     9.9945 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12970 | 12367.     |     2.5472 |     8.4567 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37833 | 16489.     |     1.2163 |    0.94321 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57122 | 14676.     |    0.60816 |   -0.86477 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        449 |     9547.9 | 10868.     |     3.0725 |     12.448 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        143 |      25158 | 14722.     |     1.8557 |     3.6599 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        449 |      11230 | 11734.     |      2.744 |     9.8754 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12967 | 12347.     |     2.5346 |     8.3488 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         63 |      37800 | 16408.     |     1.2028 |    0.90526 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |        352 |  2.765e+13 | 0.0000     |          0 |          0 |
@@ -3500,12 +3500,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       6939 |   0.027902 | 0.0028704  |    -2.3548 |     7.1076 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1672 |-9.6198e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42232 |-3.6611e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10952 | 3.1712e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      36720 | 4.1491e+14 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31512 |  7.468e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4784 | 4.0026e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1672 |-8.7416e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42232 |-2.7261e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10952 | 4.0428e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      36720 | 3.4802e+14 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31512 |  9.309e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4784 | 2.0635e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1574 |     1.1552 | 1.0291     |    0.84914 |    0.97941 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1549 |     0.0475 | 0.0071981  |    -2.0265 |     4.1391 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -3691,21 +3691,21 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2353 | 0.00043055 | 0.10928    | -0.0017262 |    -1.3241 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4086 |  0.0022998 | 0.057174   |   -0.11914 |     2.1565 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4139 |  0.0004624 | 0.062405   |    0.10916 |     2.2931 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2353 | -0.0022919 | 0.13010    |   0.083445 |    -1.6152 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4086 |  0.0014204 | 0.071738   |   -0.22902 |     1.1409 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2353 |  -0.002292 | 0.13010    |   0.083445 |    -1.6152 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4086 |  0.0014205 | 0.071738   |   -0.22902 |     1.1409 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4139 |-0.00015624 | 0.077746   |    0.11556 |     1.0649 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2653 |    0.18241 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4380 |    0.49494 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4434 |   -0.32179 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2344 | 0.00073231 | 0.10875    |  -0.010979 |    -1.3146 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4434 |    -0.3218 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2344 |  0.0007323 | 0.10875    |  -0.010979 |    -1.3146 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4077 |   0.002153 | 0.056754   |    -0.1317 |     2.2299 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4130 | 0.00044008 | 0.061769   |     0.1083 |      2.373 |
  | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2344 |  0.0012953 | 0.12296    |  -0.015858 |    -1.5101 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4077 | 0.00041515 | 0.074671   |   -0.10868 |     0.9861 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4077 | 0.00041515 | 0.074671   |   -0.10868 |    0.98609 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4130 | -0.0020611 | 0.080032   |   0.079113 |     1.1522 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4376 |-0.00092071 | 0.053379   |  -0.062179 |     1.7741 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4430 |  0.0078305 | 0.057409   |    0.40812 |     1.8693 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4077 | -0.0060163 | 0.062070   |     -0.977 |    -1.3443 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4077 | -0.0060163 | 0.062070   |   -0.97699 |    -1.3443 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4130 |   0.022657 | 0.072520   |    0.53812 |      0.342 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7614 |  0.0018616 | 0.18813    |  -0.028604 |   -0.77884 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2059 |  0.0025734 | 0.063497   |    0.56567 |     1.9018 |
@@ -3738,10 +3738,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       3187 |      10358 | 12799.     |     2.6529 |     7.8934 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       3210 |    0.01485 | 2.1088     |  0.0037125 |     -1.094 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        488 |      10211 | 11963.     |     2.6351 |     7.9851 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        497 |  -0.022145 | 1.8124     |    0.00602 |     -1.079 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        497 |  -0.022146 | 1.8124     |  0.0060202 |     -1.079 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        459 |     2.6664 | 0.53419    |     1.1382 |    0.95646 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        488 |     5569.2 | 5622.7     |     6.5521 |     62.535 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        497 |  -0.024884 | 1.8176     |  -0.028387 |    -1.0155 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        488 |     5569.2 | 5622.8     |     6.5521 |     62.535 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        497 |  -0.024883 | 1.8176     |  -0.028387 |    -1.0155 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6143 |     8303.8 | 11933.     |     1.7522 |     2.0178 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6144 |   -0.10589 | 1.8037     |   0.026049 |    -1.1584 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       4275 |     3.1618 | 0.95917    |    0.52983 |     -1.164 |
@@ -3760,7 +3760,7 @@ TrackPV2HalfMonitor                    INFO 1D profile histograms in directory "
 TrackVPOverlapMonitor                  INFO 1D profile histograms in directory "TrackVPOverlapMonitor" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1011 |     304.26 | 223.12     |   -0.15755 |    -0.8945 |
- | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1011 |     157.38 | 55.920     |    -26.673 |    -6.2418 |
+ | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1011 |     157.38 | 55.920     |    -26.673 |    -6.2417 |
 TrackVertexMonitor                     INFO 1D profile histograms in directory "TrackVertexMonitor" : 28
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | PV forward-backward delta x versus z          | "PV forward-backward delta x versus z"        |        359 |     -12345 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
index 76f6deb074e..69399070a1a 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.armv8.1_a
@@ -3851,22 +3851,22 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2290 |  0.0011081 | 0.10875    |  -0.026396 |    -1.3254 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       3950 |  0.0021704 | 0.055859   |  -0.078892 |     2.3596 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4003 | 0.00048173 | 0.060549   |    0.13951 |     2.4478 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2290 | 0.00038741 | 0.13149    |   0.047985 |    -1.6462 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       3950 | 0.00069118 | 0.074770   |    -0.1649 |     1.0275 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2290 | 0.00038739 | 0.13149    |   0.047985 |    -1.6462 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       3950 | 0.00069115 | 0.074770   |    -0.1649 |     1.0275 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4003 |  0.0011528 | 0.078988   |    0.12955 |    0.85925 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2559 |    0.41263 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4213 |    0.48322 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4266 |    -0.2877 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2559 |    0.41264 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4213 |     0.4833 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4266 |   -0.28798 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2281 |  0.0010295 | 0.10839    |  -0.024208 |    -1.3213 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       3939 |  0.0019049 | 0.055428   |  -0.079149 |     2.4729 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       3992 | 0.00038695 | 0.060069   |    0.13886 |     2.5095 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2281 |  0.0027709 | 0.12153    |  -0.048442 |    -1.5055 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       3939 |-0.00089785 | 0.076265   |   -0.01692 |     1.0446 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2281 |  0.0027709 | 0.12153    |  -0.048441 |    -1.5055 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       3939 |-0.00089782 | 0.076265   |   -0.01692 |     1.0446 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       3992 | -0.0018669 | 0.081358   |    0.11009 |     0.9913 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4212 |-0.00060578 | 0.052369   |   -0.12813 |     1.9288 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4265 |  0.0055522 | 0.056153   |    0.34802 |     1.9906 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       3939 | -0.0088062 | 0.060479   |    -1.2771 |    -1.8166 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       3992 |   0.020441 | 0.071226   |    0.62201 |     0.5245 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4212 |-0.00060559 | 0.052369   |   -0.12806 |      1.929 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4265 |  0.0055524 | 0.056153   |    0.34804 |     1.9906 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       3939 |  -0.008807 | 0.060477   |    -1.2774 |    -1.8174 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       3992 |   0.020439 | 0.071223   |    0.62197 |    0.52457 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7206 | 0.00096173 | 0.18760    |  -0.018794 |   -0.78769 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       1949 |  0.0027409 | 0.064473   |    0.54029 |     1.7491 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       1918 |-0.00022631 | 0.064048   |   -0.66199 |     1.7528 |
@@ -3902,10 +3902,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        528 |      11678 | 14430.     |     2.8085 |     9.1397 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        540 |  -0.061436 | 1.8242     |   0.045423 |    -1.1342 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        528 |      10056 | 12771.     |     3.1646 |     11.755 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        540 |  -0.041834 | 1.8283     |   0.027711 |    -1.1029 |
- | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        499 |     2.6576 | 0.51804    |     1.1538 |     1.1568 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        540 |  -0.041835 | 1.8283     |   0.027712 |    -1.1029 |
+ | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        499 |     2.6576 | 0.51804    |     1.1538 |     1.1567 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        528 |     5627.7 | 5849.7     |     6.3198 |     56.707 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        540 |  -0.041988 | 1.8273     |   0.012713 |    -1.0527 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        540 |  -0.041991 | 1.8273     |   0.012716 |    -1.0527 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |       9348 |     9674.4 | 10747.     |     1.6206 |     2.0561 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |       9347 |  -0.049683 | 1.7961     |   0.012737 |    -1.1765 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       9348 |     8242.5 | 10511.     |     1.9374 |     3.1944 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 942eb7fb4f2..955e2a6b780 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_fastest_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -2840,7 +2840,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/HitVeloALayers                       | "Hit Velo-A layers"                           |       2718 |     16.084 | 5.1088     |  -0.059843 |   -0.93255 |
  | Upstream/HitVeloCLayers                       | "Hit Velo-C layers"                           |       2285 |     16.411 | 4.9312     |  -0.040854 |   -0.93887 |
  | Upstream/UTResidual                           | "UTresidual (rms-unbiased)"                   |       2388 | 0.00021776 | 0.052774   |   0.014506 |     1.0917 |
- | Upstream/UTresidualPull                       | "UT residual pull"                            |       2388 | -0.0020956 | 1.2113     |  -0.018732 |    0.16142 |
+ | Upstream/UTresidualPull                       | "UT residual pull"                            |       2388 | -0.0020117 | 1.2113     |  -0.018932 |    0.16128 |
  | Upstream/VPXResidual                          | "VPXresidual (rms-unbiased)"                  |       4921 | 1.8289e-05 | 0.013174   |   0.034532 |   -0.21985 |
  | Upstream/VPXresidualPull                      | "VPX residual pull"                           |       4921 | 0.00054867 | 1.0499     |   0.027652 |   -0.23244 |
  | Upstream/VPYResidual                          | "VPYresidual (rms-unbiased)"                  |       4921 |-3.7797e-05 | 0.013064   |   0.046862 |    -0.1809 |
@@ -2873,7 +2873,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        605 |      14315 | 16236.     |     2.2075 |     5.3679 |
  | Upstream/phi                                  | "phi"                                         |        605 |  -0.022744 | 1.7899     |   0.021006 |    -1.0468 |
  | Upstream/probChi2                             | "probChi2"                                    |        605 |    0.38408 | 0.31921    |    0.49593 |    -1.1305 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        605 |      14591 | 16691.     |       2.41 |     6.9385 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        605 |      14595 | 16692.     |     2.4087 |     6.9322 |
  | Upstream/pt                                   | "pt"                                          |        605 |     847.02 | 608.21     |     4.8308 |     38.258 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        605 | 2.5455e-06 | 0.00020828 |   0.047923 |   -0.55368 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        605 |    -4.7528 | 0.36858    |  -0.086625 |    -1.0671 |
@@ -3969,24 +3969,24 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-T/dy pull vs ty                          | "Velo-T dy pull vs ty"                        |        406 |   0.030162 | 0.10589    |    0.92376 |   -0.99047 |
  | Velo-T/dy vs tx                               | "Velo-T dy vs tx"                             |        298 |  -0.016547 | 0.19934    |    0.30333 |     -1.733 |
  | Velo-T/dy vs ty                               | "Velo-T dy vs ty"                             |        407 |   -0.14438 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2972 |  0.0051941 | 0.078138   |  -0.043484 |    0.18706 |
+ | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2972 |   0.005194 | 0.078138   |  -0.043484 |    0.18706 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4610 |  0.0073634 | 0.050226   |   -0.25872 |     5.8398 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4663 |  0.0023214 | 0.064335   |    0.77596 |     5.7145 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2972 |  0.0059849 | 0.12693    |   -0.35799 |       -1.2 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4610 |  0.0075085 | 0.099748   |       -0.3 |    0.41625 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2972 |  0.0059846 | 0.12693    |   -0.35798 |       -1.2 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4610 |  0.0075086 | 0.099748   |       -0.3 |    0.41625 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4663 |  -0.036321 | 0.10028    |    0.91795 |     2.0441 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2975 |   -0.11724 | 0.12259    |      1.318 |    0.20291 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2975 |   -0.11724 | 0.12259    |      1.318 |    0.20292 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4606 |     22.221 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4659 |   0.045816 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2972 |-0.00093999 | 0.078689   |  -0.049969 |    0.26497 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4659 |   0.045815 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2972 |-0.00093994 | 0.078689   |  -0.049969 |    0.26497 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4610 |  0.0036838 | 0.049559   |    -0.2798 |      5.579 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4663 |  0.0014692 | 0.063175   |    0.79688 |     6.1052 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2972 |    -0.1079 | 0.072917   |    0.90182 |     5.9748 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4610 |  -0.020332 | 0.095531   |    0.50025 |      0.873 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2972 |    -0.1079 | 0.072918   |    0.90184 |     5.9747 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4610 |  -0.020332 | 0.095531   |    0.50025 |    0.87298 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4663 |  -0.028773 | 0.10118    |    0.96647 |     2.6678 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4605 |   0.015034 | 0.16471    |    -1.0368 |   -0.71723 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4658 |    -1.4601 | 0.0000     |          0 |          0 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4610 |  -0.028932 | 0.18134    |    0.37219 |    -1.7728 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4605 |   0.015037 | 0.16471    |    -1.0369 |   -0.71716 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4658 |    -1.4602 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4610 |  -0.028931 | 0.18134    |    0.37219 |    -1.7728 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4663 |   -0.66531 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7644 |-0.00097632 | 0.18278    |   0.029115 |   -0.66783 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2036 | 1.4259e-05 | 0.062336   |   -0.69589 |     2.0454 |
@@ -4023,10 +4023,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        596 |      14309 | 16253.     |     2.2035 |     5.3488 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        605 |  -0.022744 | 1.7899     |   0.021006 |    -1.0468 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        596 |      12095 | 15594.     |     2.7876 |     8.8536 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        605 |  -0.020583 | 1.7845     |  -0.013457 |    -1.0163 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        605 |  -0.020583 | 1.7845     |  -0.013458 |    -1.0163 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        568 |     3.0832 | 0.86085    |    0.61984 |   -0.90074 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        596 |      11775 | 15259.     |     2.7878 |     8.9077 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        605 |  -0.024635 | 1.7982     |   0.016342 |    -1.0303 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        605 |  -0.024635 | 1.7982     |   0.016341 |    -1.0303 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |       9339 |       9665 | 10740.     |     1.6239 |     2.0699 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |       9339 |  -0.045541 | 1.7961     |  0.0094611 |    -1.1763 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       9339 |     8225.8 | 10503.     |     1.9435 |     3.2219 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
index 9b5849f706b..bbf57087b19 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.armv8.1_a
@@ -3633,21 +3633,21 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4097 |   0.001984 | 0.055535   |   -0.11117 |     2.2289 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4150 | 0.00066177 | 0.060537   |    0.11835 |     2.4487 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2325 |  0.0015765 | 0.13267    |   0.028401 |    -1.6673 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4097 |-0.00042281 | 0.072902   |   -0.23134 |     0.9968 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4097 |-0.00042283 | 0.072902   |   -0.23133 |     0.9968 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4150 | 0.00058383 | 0.078616   |    0.11432 |    0.93106 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2621 |     6.8513 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4388 |    0.37104 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4441 |   -0.22291 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2621 |     6.8524 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4388 |    0.37108 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4441 |   -0.22312 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2324 |  0.0014969 | 0.10943    |  -0.026416 |    -1.3378 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4093 |  0.0019222 | 0.054948   |   -0.12491 |     2.3415 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4146 | 0.00074171 | 0.059866   |    0.10933 |     2.5445 |
  | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2324 |  0.0018816 | 0.12304    |  -0.024199 |    -1.5254 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4093 |-0.00077729 | 0.074640   |   -0.12303 |     1.0072 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4093 |-0.00077726 | 0.074640   |   -0.12303 |     1.0072 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4146 | -0.0027091 | 0.081072   |   0.094634 |     1.0719 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4381 |-0.00052463 | 0.052305   |    -0.1637 |     1.6842 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4434 |  0.0062873 | 0.056268   |    0.34853 |     1.8351 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4093 | -0.0097071 | 0.059877   |    -1.4669 |    -2.6752 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4146 |   0.022048 | 0.072076   |    0.49599 |    0.35336 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4381 |-0.00052445 | 0.052305   |   -0.16364 |     1.6844 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4434 |  0.0062875 | 0.056269   |    0.34855 |     1.8352 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4093 | -0.0097079 | 0.059876   |    -1.4672 |    -2.6762 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4146 |   0.022046 | 0.072074   |    0.49594 |    0.35341 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7364 | 0.00080517 | 0.19051    |  -0.031523 |   -0.83625 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       1976 |  0.0022436 | 0.064352   |    0.57892 |     1.8861 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       1972 | 0.00072617 | 0.062325   |   -0.63371 |     1.8944 |
@@ -3683,10 +3683,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        494 |      11652 | 14143.     |     2.6636 |     7.9536 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        505 |  -0.052132 | 1.8414     |   0.046315 |    -1.1457 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        494 |      10087 | 12706.     |     3.0718 |     10.879 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        505 |   -0.02587 | 1.8342     |   0.021974 |    -1.0936 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        505 |  -0.025871 | 1.8342     |   0.021975 |    -1.0936 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        466 |     2.6526 | 0.51874    |      1.176 |     1.2481 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        494 |     5601.3 | 5658.4     |     6.3249 |     58.832 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        505 |  -0.013753 | 1.8365     | -0.0067246 |    -1.0453 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        505 |  -0.013757 | 1.8365     |  -0.006722 |    -1.0453 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |       9348 |     9674.4 | 10747.     |     1.6206 |     2.0561 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |       9347 |  -0.049683 | 1.7961     |   0.012737 |    -1.1765 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       9348 |     8242.5 | 10511.     |     1.9374 |     3.1944 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
index e523b9085f2..4df88eafad6 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_pr_kf_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -350,7 +350,7 @@ TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 535     0.094563131        0.13296881 0                  0.903066 |
    | BeforeMagnetRegion/VP/PipeSections/lvVeloDownStreamPipe | mm | 1       2.8505405e-14               0 2.8505405e-14   2.8505405e- |
    | BeforeMagnetRegion/VP/PipeSections/lvVeloDownStreamPipe | X0 | 1       3.2146042e-16               0 3.2146042e-16   3.2146042e- |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 3410    0.017715065       0.060024663 2.4614753e-11       1.24253 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 3410    0.017715066       0.060024663 2.4614753e-11       1.24253 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | X0 | 3410    0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter18            | mm | 4       0.87494748           1.111208 0.030879822         2.78628 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter18            | X0 | 4       0                           0 0                           |
@@ -2862,7 +2862,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/HitVeloALayers                       | "Hit Velo-A layers"                           |       2603 |     16.125 | 5.1200     |  -0.070439 |   -0.94105 |
  | Upstream/HitVeloCLayers                       | "Hit Velo-C layers"                           |       2182 |     16.366 | 4.9490     |  -0.035871 |   -0.94034 |
  | Upstream/UTResidual                           | "UTresidual (rms-unbiased)"                   |       2262 | 0.00022104 | 0.052927   |   0.011379 |     1.1105 |
- | Upstream/UTresidualPull                       | "UT residual pull"                            |       2262 |-0.00088496 | 1.2138     |  -0.016617 |    0.18333 |
+ | Upstream/UTresidualPull                       | "UT residual pull"                            |       2262 |-0.00079646 | 1.2138     |  -0.016829 |    0.18319 |
  | Upstream/VPXResidual                          | "VPXresidual (rms-unbiased)"                  |       4710 | 2.5478e-05 | 0.013106   |   0.028996 |   -0.21829 |
  | Upstream/VPXresidualPull                      | "VPX residual pull"                           |       4710 |  0.0013588 | 1.0444     |   0.022544 |   -0.23025 |
  | Upstream/VPYResidual                          | "VPYresidual (rms-unbiased)"                  |       4710 |-3.9066e-05 | 0.013064   |   0.047112 |   -0.17179 |
@@ -2895,7 +2895,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        573 |      14461 | 16398.     |     2.2011 |     5.3168 |
  | Upstream/phi                                  | "phi"                                         |        573 | -0.0023027 | 1.7970     |  0.0099873 |    -1.0439 |
  | Upstream/probChi2                             | "probChi2"                                    |        573 |    0.38595 | 0.32064    |    0.47618 |    -1.1564 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        573 |      14742 | 16891.     |     2.4022 |     6.8496 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        573 |      14745 | 16893.     |      2.401 |     6.8432 |
  | Upstream/pt                                   | "pt"                                          |        573 |     851.22 | 610.93     |       4.92 |     39.359 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        573 | 1.9895e-06 | 0.00020868 |   0.058686 |   -0.52539 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        573 |    -4.7546 | 0.37150    |  -0.069801 |    -1.0811 |
@@ -3701,21 +3701,21 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3033 |  0.0038736 | 0.080769   |   -0.28914 |    0.22717 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4784 |  0.0066771 | 0.045986   |    -1.2284 |     4.5251 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4837 |  0.0017861 | 0.063742   |    0.46789 |     6.0699 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3033 |  -0.007472 | 0.14034    |   -0.23863 |     -1.622 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3033 | -0.0074723 | 0.14035    |   -0.23862 |    -1.6221 |
  | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4784 |  -0.009528 | 0.080063   |    -1.2044 |  -0.068728 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4837 |  -0.038264 | 0.099274   |    0.77657 |     2.1031 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3035 |   -0.15759 | 0.041261   |    -10.016 |    -149.98 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3035 |   -0.15759 | 0.041261   |    -10.016 |    -149.97 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4782 |   -0.38399 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4835 |  -0.021419 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3033 | -0.0019193 | 0.081160   |   -0.27394 |    0.19882 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4783 |  0.0041894 | 0.044357   |    -1.4256 |     3.8838 |
- | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4836 | 0.00058215 | 0.061908   |     0.5123 |     6.6898 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3033 |  -0.095127 | 0.097862   |    0.74219 |    0.54034 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4783 |  -0.021899 | 0.076995   |   -0.84647 |   -0.25165 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4835 |  -0.021418 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3033 | -0.0019192 | 0.081160   |   -0.27394 |    0.19881 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4783 |  0.0041895 | 0.044357   |    -1.4256 |     3.8838 |
+ | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4836 | 0.00058216 | 0.061908   |     0.5123 |     6.6898 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3033 |  -0.095127 | 0.097862   |    0.74219 |    0.54032 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4783 |  -0.021899 | 0.076995   |   -0.84648 |   -0.25163 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4836 |  -0.042108 | 0.094319   |     1.1228 |     4.8298 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4778 |  -0.028819 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4831 |    0.81427 | 0.0000     |          0 |          0 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4783 |  -0.084763 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4778 |   -0.02882 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4831 |    0.81426 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4783 |  -0.084764 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4836 |     4.2744 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7752 | -0.0015243 | 0.18516    |   0.038106 |   -0.72266 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2080 |  0.0009766 | 0.060747   |   -0.66072 |      2.158 |
@@ -3752,9 +3752,9 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbMatchVsMom                   | "chi2 prob upstream-downstream match vers..." |        564 |      14461 | 16419.     |     2.1965 |     5.2913 |
  | Upstream/chi2ProbMatchVsPhi                   | "chi2 prob upstream-downstream match vers..." |        573 | -0.0023027 | 1.7970     |  0.0099873 |    -1.0439 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        564 |      12212 | 15730.     |     2.7823 |     8.7952 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        573 | 0.00081573 | 1.7932     |  -0.031961 |    -1.0129 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        573 |  0.0008159 | 1.7932     |  -0.031962 |    -1.0129 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        537 |     3.0936 | 0.86934    |    0.58495 |   -0.95756 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        564 |      11951 | 15417.     |     2.7739 |     8.7872 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        564 |      11951 | 15417.     |     2.7739 |     8.7871 |
  | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        573 |   0.022468 | 1.8084     |  -0.024429 |    -1.0339 |
  | Velo/chi2ProbMatchVsMom                       | "chi2 prob upstream-downstream match vers..." |       9339 |       9665 | 10740.     |     1.6239 |     2.0699 |
  | Velo/chi2ProbMatchVsPhi                       | "chi2 prob upstream-downstream match vers..." |       9339 |  -0.045541 | 1.7961     |  0.0094611 |    -1.1763 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
index 882d6d90ed5..4a830df0863 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.armv8.1_a
@@ -3036,7 +3036,7 @@ TrackResCheckerBestUpstream            INFO 1D histograms in directory "TrackRes
  | ALL/vertex/dpoverp                            | "dp/p"                                        |        470 |  -0.007355 | 0.028572   |    0.25144 |    -1.1092 |
  | ALL/vertex/ppull                              | "p pull"                                      |        470 |   -0.40084 | 1.8869     |   0.083822 |   -0.19655 |
  | ALL/vertex/qoppull                            | "qop pull"                                    |        470 |    -3.2607 | 2.1264     |     2.3033 |     4.4235 |
- | ALL/vertex/txpull                             | "tx pull"                                     |        470 |  -0.027981 | 1.1167     |   -0.29205 |     1.9525 |
+ | ALL/vertex/txpull                             | "tx pull"                                     |        470 |  -0.027551 | 1.1163     |    -0.2923 |     1.9582 |
  | ALL/vertex/txres                              | "tx resolution"                               |        470 |-5.9491e-06 | 0.00051753 |   -0.17553 |     2.9816 |
  | ALL/vertex/typull                             | "ty pull"                                     |        470 | -0.0023422 | 1.0730     |   -0.17483 |     1.9017 |
  | ALL/vertex/tyres                              | "ty resolution"                               |        470 |-1.0495e-05 | 0.00047588 |    0.13624 |     2.2962 |
@@ -3619,16 +3619,16 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4164 |  0.0019291 | 0.057022   |    -0.1237 |     2.1213 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4217 | 0.00055435 | 0.062364   |    0.11069 |     2.2892 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2360 | -0.0013328 | 0.13004    |   0.061271 |      -1.62 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4164 |   0.000445 | 0.071051   |   -0.25187 |      1.131 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4217 | 9.7979e-05 | 0.077519   |    0.11592 |     1.0443 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4164 | 0.00044498 | 0.071051   |   -0.25187 |      1.131 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4217 | 9.7964e-05 | 0.077519   |    0.11592 |     1.0443 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2674 |      0.188 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4473 |    0.56897 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4526 |   -0.37981 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2349 | 0.00025353 | 0.10947    | -0.0028369 |    -1.3328 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4153 |  0.0018965 | 0.056550   |   -0.14047 |     2.2224 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4206 | 0.00043996 | 0.061822   |     0.1125 |     2.3716 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2349 | 0.00071349 | 0.12361    | -0.0050158 |    -1.5297 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4153 |-0.00014904 | 0.074057   |   -0.14204 |     1.0287 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2349 | 0.00071348 | 0.12361    | -0.0050157 |    -1.5297 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4153 |-0.00014902 | 0.074057   |   -0.14204 |     1.0287 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4206 | -0.0035265 | 0.080400   |   0.080286 |     1.1562 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4464 | -0.0014085 | 0.053269   |  -0.070636 |     1.6574 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4517 |  0.0064849 | 0.057016   |     0.2325 |     1.6192 |
@@ -3665,10 +3665,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       8055 |      10249 | 11215.     |     2.8042 |     10.065 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       8097 | -0.0099056 | 2.0738     |  0.0058565 |    -1.0571 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        493 |      10271 | 11951.     |     2.6182 |     7.8976 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        501 | -0.0048334 | 1.8300     |   0.018892 |    -1.0948 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        501 | -0.0048348 | 1.8300     |   0.018893 |    -1.0948 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        462 |     2.6612 | 0.52426    |     1.1398 |     1.0863 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        493 |     5605.3 | 5682.5     |     6.3895 |       59.5 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        501 | -0.0024463 | 1.8353     |  -0.018793 |     -1.025 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        493 |     5605.3 | 5682.6     |     6.3895 |     59.501 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        501 | -0.0024493 | 1.8353     |  -0.018791 |     -1.025 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      11112 |     8221.4 | 10461.     |     1.9464 |     3.2531 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |      11110 |  -0.061818 | 1.7997     |   0.010107 |    -1.1672 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       8890 |     3.2122 | 0.84546    |    0.46854 |   -0.93547 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
index 00cd3e669c1..43bf8c8fbe5 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-detdesc-opt
@@ -1429,7 +1429,7 @@ TrackEventFitterUpstream               INFO Number of counters : 8
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fit Failure Rate"                              |       701 |          0 |( 0.000000 +- 0.000000)% |
  | "badChisq"                                      |       701 |        181 |    0.25820 |    0.43765 |      0.0000 |      1.0000 |
- | "chisqprobSum"                                  |       701 |   213.8855 |    0.30511 |    0.32466 |      0.0000 |     0.99998 |
+ | "chisqprobSum"                                  |       701 |   213.8856 |    0.30511 |    0.32466 |      0.0000 |     0.99998 |
  | "flipCharge"                                    |       701 |         16 |   0.022825 |    0.14934 |      0.0000 |      1.0000 |
  | "nBadInput"                                     |        89 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
  | "nFitted"                                       |        89 |        701 |     7.8764 |     5.5765 |      0.0000 |      26.000 |
@@ -2886,7 +2886,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        564 |      14725 | 16531.     |     2.0868 |     4.6281 |
  | Upstream/phi                                  | "phi"                                         |        564 | -0.0086895 | 1.8091     |   0.031698 |    -1.0663 |
  | Upstream/probChi2                             | "probChi2"                                    |        564 |    0.37801 | 0.31943    |    0.50038 |    -1.1221 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        564 |      14867 | 16910.     |     2.3887 |     6.8266 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        564 |      14871 | 16912.     |     2.3874 |     6.8202 |
  | Upstream/pt                                   | "pt"                                          |        564 |     850.18 | 556.82     |     3.1888 |     13.754 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        564 | 4.8936e-06 | 0.00020914 |   0.017345 |   -0.47619 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        564 |    -4.7793 | 0.39189    |  -0.034124 |    -1.1719 |
@@ -3686,22 +3686,22 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-T/dy vs tx                               | "Velo-T dy vs tx"                             |        414 |   -0.15483 | 0.16849    |     2.4598 |     4.0831 |
  | Velo-T/dy vs ty                               | "Velo-T dy vs ty"                             |        540 |   0.010633 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3059 |  -0.073511 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4849 |   -0.14139 | 0.049175   |     35.054 |     419.05 |
+ | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4849 |   -0.14139 | 0.049175   |     35.054 |     419.03 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4903 |    -0.2916 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3059 |   0.012384 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4849 |    0.08208 | 0.10247    |    0.90655 |    -2.6861 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4903 |   0.086659 | 0.0000     |          0 |          0 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3059 |   0.012385 | 0.0000     |          0 |          0 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4849 |    0.08208 | 0.10247    |    0.90665 |    -2.6864 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4903 |   0.086656 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3062 |   -0.23914 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4850 |     1.6512 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4904 |   -0.19961 | 1.0897     |    0.50756 |    -2.8006 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3057 |    -0.0616 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4904 |   -0.19969 | 1.0898     |    0.50776 |    -2.8005 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3057 |  -0.061601 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4847 |   -0.28876 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4901 |    0.29905 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3057 |    0.24916 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4847 |   -0.61854 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4847 |   -0.61855 | 0.0000     |          0 |          0 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4901 |   -0.39943 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4845 |    0.38257 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4899 |    -1.2159 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4845 |    0.38259 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4899 |     -1.216 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4847 |  -0.025856 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4901 |     1.4529 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7968 | -0.0020838 | 0.18543    |   0.048119 |   -0.71755 |
@@ -3738,7 +3738,7 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        564 |   0.012398 | 1.8027     |  -0.029296 |    -1.0292 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        530 |     3.1182 | 0.87576    |     0.5272 |     -1.035 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        556 |      12068 | 14961.     |     2.6215 |     7.9596 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        564 |   0.041107 | 1.8036     |  -0.026116 |    -1.0368 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        564 |   0.041107 | 1.8036     |  -0.026115 |    -1.0368 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      11105 |     8206.8 | 10455.     |     1.9516 |     3.2771 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |      11105 |  -0.062521 | 1.8021     |   0.011179 |     -1.171 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       8883 |     3.2103 | 0.84465    |    0.47037 |   -0.93183 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
index 3681533ef53..bf67004f7bf 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_light_reco_with_mcchecking.ref.x86_64_v3-opt
@@ -1371,7 +1371,7 @@ TrackEventFitterUpstream               INFO Number of counters : 8
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  |*"Fit Failure Rate"                              |       835 |          0 |( 0.000000 +- 0.000000)% |
  | "badChisq"                                      |       835 |        462 |    0.55329 |    0.49715 |      0.0000 |      1.0000 |
- | "chisqprobSum"                                  |       835 |   133.3857 |    0.15974 |    0.27430 |      0.0000 |     0.99915 |
+ | "chisqprobSum"                                  |       835 |   133.3858 |    0.15974 |    0.27430 |      0.0000 |     0.99915 |
  | "flipCharge"                                    |       835 |         37 |   0.044311 |    0.20579 |      0.0000 |      1.0000 |
  | "nBadInput"                                     |        89 |          0 |     0.0000 |     0.0000 |      0.0000 |      0.0000 |
  | "nFitted"                                       |        89 |        835 |     9.3820 |     6.7599 |      0.0000 |      29.000 |
@@ -3617,23 +3617,23 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-T/dy vs ty                               | "Velo-T dy vs ty"                             |        632 |    0.06326 | 0.095008   |     1.4704 |    -3.1758 |
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2357 | 0.00023973 | 0.10972    |-0.00092339 |    -1.3353 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4163 |  0.0019061 | 0.057043   |   -0.12545 |     2.1109 |
- | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4215 | 0.00057611 | 0.062372   |    0.10743 |     2.2938 |
+ | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4215 | 0.00057612 | 0.062372   |    0.10743 |     2.2938 |
  | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2357 | -0.0014559 | 0.12990    |   0.062241 |    -1.6179 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4163 | 0.00039001 | 0.071058   |   -0.25103 |     1.1223 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4215 | -6.914e-05 | 0.077428   |    0.11305 |     1.0573 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4163 | 0.00039004 | 0.071058   |   -0.25103 |     1.1223 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4215 |-6.9131e-05 | 0.077428   |    0.11305 |     1.0573 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2671 |    0.18813 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4472 |    0.55712 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4524 |   -0.45149 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2346 | 0.00013307 | 0.10939    | -0.0017471 |    -1.3322 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4152 |  0.0018813 | 0.056563   |   -0.14286 |     2.2128 |
+ | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4472 |    0.55713 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4524 |    -0.4515 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2346 | 0.00013307 | 0.10939    |  -0.001747 |    -1.3322 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4152 |  0.0018814 | 0.056563   |   -0.14286 |     2.2128 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4204 | 0.00045729 | 0.061832   |    0.10843 |     2.3755 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2346 | 0.00061916 | 0.12357    | -0.0043283 |    -1.5295 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4152 |-0.00017585 | 0.074053   |   -0.14376 |      1.021 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2346 | 0.00061914 | 0.12357    |  -0.004328 |    -1.5295 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4152 |-0.00017582 | 0.074053   |   -0.14375 |      1.021 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4204 | -0.0037319 | 0.080325   |   0.076989 |     1.1665 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4464 | -0.0012956 | 0.053179   |  -0.084418 |     1.6447 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4464 | -0.0012956 | 0.053179   |  -0.084417 |     1.6447 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4516 |  0.0062971 | 0.057064   |    0.21233 |     1.6689 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4152 | -0.0078523 | 0.061621   |    -1.0731 |    -1.8231 |
- | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4204 |   0.019522 | 0.073034   |    0.32752 |    0.32603 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4152 | -0.0078522 | 0.061621   |    -1.0731 |    -1.8231 |
+ | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4204 |   0.019522 | 0.073034   |    0.32753 |    0.32603 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7610 |  0.0013454 | 0.18960    |  -0.032672 |   -0.80009 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2055 |  0.0021915 | 0.063418   |    0.56092 |     1.8934 |
  | curvatureRatioTToLongVsTxPos                  | "curvature ratio T to Long versus tx for pos" |       2039 |  0.0006477 | 0.062072   |   -0.67119 |     2.0219 |
@@ -3665,10 +3665,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       8055 |      10249 | 11216.     |     2.8042 |     10.064 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       8097 |   -0.01027 | 2.0737     |  0.0060247 |    -1.0571 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        492 |      10265 | 11936.     |      2.621 |      7.923 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        500 |  -0.002657 | 1.8287     |   0.016215 |    -1.0933 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        500 | -0.0026573 | 1.8287     |   0.016216 |    -1.0933 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        462 |     2.6607 | 0.52425    |     1.1394 |     1.0865 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        492 |     5617.8 | 5686.4     |      6.371 |     59.263 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        500 | -0.0028963 | 1.8362     |  -0.017396 |    -1.0267 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        500 | -0.0028959 | 1.8362     |  -0.017396 |    -1.0267 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |      11114 |     8214.5 | 10459.     |     1.9475 |     3.2577 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |      11113 |  -0.060798 | 1.7991     |  0.0084295 |    -1.1665 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       8891 |     3.2111 | 0.84570    |    0.46995 |   -0.93381 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.armv8.1_a
index f91ae028458..7b427150bb6 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.armv8.1_a
@@ -1211,7 +1211,7 @@ TrackResCheckerBestUpstream            INFO 1D histograms in directory "TrackRes
  | ALL/BegRich1/qoppull                          | "qop pull"                                    |        186 |   -0.19802 | 0.0000     |          0 |          0 |
  | ALL/BegRich1/txpull                           | "tx pull"                                     |        186 |   -0.36241 | 3.0397     |    0.30076 |    -1.1937 |
  | ALL/BegRich1/txres                            | "tx resolution"                               |        186 | 0.00025634 | 0.0011951  |    -0.4577 |   -0.31859 |
- | ALL/BegRich1/typull                           | "ty pull"                                     |        186 |    0.47098 | 1.9052     |    -0.3106 |    0.29282 |
+ | ALL/BegRich1/typull                           | "ty pull"                                     |        186 |    0.47043 | 1.9052     |   -0.30974 |    0.29241 |
  | ALL/BegRich1/tyres                            | "ty resolution"                               |        186 | 0.00013426 | 0.00066528 |   -0.19839 |     2.7235 |
  | ALL/BegRich1/xpull                            | "x pull"                                      |        186 |   -0.94509 | 2.0631     |    0.34394 |   -0.10543 |
  | ALL/BegRich1/xres                             | "x resolution / mm"                           |        186 |  -0.081763 | 0.17582    |    0.46751 |   -0.33988 |
@@ -1327,7 +1327,7 @@ TrackResCheckerBestUpstreamV3          INFO 1D histograms in directory "TrackRes
  | ALL/BegRich1/qoppull                          | "qop pull"                                    |        186 |   -0.19802 | 0.0000     |          0 |          0 |
  | ALL/BegRich1/txpull                           | "tx pull"                                     |        186 |   -0.36241 | 3.0397     |    0.30076 |    -1.1937 |
  | ALL/BegRich1/txres                            | "tx resolution"                               |        186 | 0.00025634 | 0.0011951  |    -0.4577 |   -0.31859 |
- | ALL/BegRich1/typull                           | "ty pull"                                     |        186 |    0.47098 | 1.9052     |    -0.3106 |    0.29282 |
+ | ALL/BegRich1/typull                           | "ty pull"                                     |        186 |    0.47043 | 1.9052     |   -0.30974 |    0.29241 |
  | ALL/BegRich1/tyres                            | "ty resolution"                               |        186 | 0.00013426 | 0.00066528 |   -0.19839 |     2.7235 |
  | ALL/BegRich1/xpull                            | "x pull"                                      |        186 |   -0.94509 | 2.0631     |    0.34394 |   -0.10543 |
  | ALL/BegRich1/xres                             | "x resolution / mm"                           |        186 |  -0.081763 | 0.17582    |    0.46751 |   -0.33988 |
@@ -1373,7 +1373,7 @@ TrackResCheckerBestUpstreamV3          INFO 1D histograms in directory "TrackRes
  | ALL/vertex/ppull                              | "p pull"                                      |        186 |   -0.14017 | 1.7564     |   -0.41686 |   -0.24761 |
  | ALL/vertex/qoppull                            | "qop pull"                                    |        186 |    -2.5743 | 2.3762     |-6.7064e-16 |         -2 |
  | ALL/vertex/txpull                             | "tx pull"                                     |        186 |  -0.062082 | 1.0844     |   -0.42825 |     2.3302 |
- | ALL/vertex/txres                              | "tx resolution"                               |        186 | -9.901e-06 | 0.00040125 |   0.030725 |      3.426 |
+ | ALL/vertex/txres                              | "tx resolution"                               |        186 |-9.6334e-06 | 0.00040117 |   0.028905 |     3.4307 |
  | ALL/vertex/typull                             | "ty pull"                                     |        186 |   0.042815 | 1.0066     |    0.24034 |     1.0552 |
  | ALL/vertex/tyres                              | "ty resolution"                               |        186 | 2.9435e-05 | 0.00042912 |    0.74141 |     5.0343 |
  | ALL/vertex/ypull                              | "y pull"                                      |        186 |    -1.3861 | 0.0000     |          0 |          0 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.x86_64_v3-opt
index d0b8990f87a..1b1426d4a9d 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_pr_kf_tool_example.ref.x86_64_v3-opt
@@ -1218,7 +1218,7 @@ TrackResCheckerBestUpstream            INFO 1D histograms in directory "TrackRes
  | ALL/BegRich1/ypull                            | "y pull"                                      |        187 |    -2.0765 | 1.7551     |    0.31053 |   -0.69445 |
  | ALL/BegRich1/yres                             | "y resolution / mm"                           |        187 |   -0.19583 | 0.19446    |     1.1619 |    0.77478 |
  | ALL/EndRich1/dpoverp                          | "dp/p"                                        |        187 |  -0.006082 | 0.027584   |    0.34904 |   -0.98982 |
- | ALL/EndRich1/ppull                            | "p pull"                                      |        187 |   -0.17258 | 1.7858     |   -0.41918 |   -0.17931 |
+ | ALL/EndRich1/ppull                            | "p pull"                                      |        187 |   -0.17202 | 1.7843     |   -0.41462 |    -0.1926 |
  | ALL/EndRich1/qoppull                          | "qop pull"                                    |        187 |   -0.19802 | 0.0000     |          0 |          0 |
  | ALL/EndRich1/txpull                           | "tx pull"                                     |        187 |    -1.0584 | 3.3554     |    0.57975 |    -1.2136 |
  | ALL/EndRich1/txres                            | "tx resolution"                               |        187 | 0.00030794 | 0.0012631  |   -0.30318 |    -0.9033 |
@@ -1334,7 +1334,7 @@ TrackResCheckerBestUpstreamV3          INFO 1D histograms in directory "TrackRes
  | ALL/BegRich1/ypull                            | "y pull"                                      |        187 |    -2.0765 | 1.7551     |    0.31053 |   -0.69445 |
  | ALL/BegRich1/yres                             | "y resolution / mm"                           |        187 |   -0.19583 | 0.19446    |     1.1619 |    0.77478 |
  | ALL/EndRich1/dpoverp                          | "dp/p"                                        |        187 |  -0.006082 | 0.027584   |    0.34904 |   -0.98982 |
- | ALL/EndRich1/ppull                            | "p pull"                                      |        187 |   -0.17258 | 1.7858     |   -0.41918 |   -0.17931 |
+ | ALL/EndRich1/ppull                            | "p pull"                                      |        187 |   -0.17202 | 1.7843     |   -0.41462 |    -0.1926 |
  | ALL/EndRich1/qoppull                          | "qop pull"                                    |        187 |   -0.19802 | 0.0000     |          0 |          0 |
  | ALL/EndRich1/txpull                           | "tx pull"                                     |        187 |    -1.0584 | 3.3554     |    0.57975 |    -1.2136 |
  | ALL/EndRich1/txres                            | "tx resolution"                               |        187 | 0.00030794 | 0.0012631  |   -0.30318 |    -0.9033 |
@@ -1343,7 +1343,7 @@ TrackResCheckerBestUpstreamV3          INFO 1D histograms in directory "TrackRes
  | ALL/EndRich1/xpull                            | "x pull"                                      |        187 |    -1.2141 | 2.3574     |    0.41375 |   -0.66209 |
  | ALL/EndRich1/xres                             | "x resolution / mm"                           |        187 |  -0.079208 | 0.14338    |    0.59515 |    0.21697 |
  | ALL/EndRich1/ypull                            | "y pull"                                      |        187 |    -1.0168 | 1.4537     |   -0.24215 |   -0.45508 |
- | ALL/EndRich1/yres                             | "y resolution / mm"                           |        187 |   -0.10273 | 0.19663    |    0.47504 |   -0.55387 |
+ | ALL/EndRich1/yres                             | "y resolution / mm"                           |        187 |   -0.10264 | 0.19682    |    0.47888 |    -0.5444 |
  | ALL/FirstMeasurement/dpoverp                  | "dp/p"                                        |        185 | -0.0063366 | 0.027879   |    0.33631 |    -1.0107 |
  | ALL/FirstMeasurement/ppull                    | "p pull"                                      |        185 |   -0.13962 | 1.7552     |   -0.41772 |   -0.24015 |
  | ALL/FirstMeasurement/qoppull                  | "qop pull"                                    |        185 |    -2.5743 | 2.3762     |-6.7064e-16 |         -2 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
index 36541ad70bf..00ede92be46 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref
@@ -3910,10 +3910,10 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1636 | 1.0024e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42172 | 1.4174e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42172 | 1.3681e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10652 |-9.1881e+11 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37136 |-9.5769e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31692 | 2.6811e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37136 |-9.5127e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      31692 | 2.6179e+13 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4720 | 2.3029e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1535 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1509 |    0.04746 | 0.0072297  |    -2.0162 |     4.0918 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
index 9dc9d0c0490..36d9d121a90 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.armv8.1_a
@@ -1284,7 +1284,7 @@ TrackBestTrackCreator_3652aaaf         INFO Number of counters : 32
  |*"Upstream.badChisq"                             |       816 |        455 |( 55.75980 +- 1.738698)% |
  | "Upstream.chisqProbSum"                         |       816 |   128.5162 |    0.15750 |
  |*"Upstream.flipCharge"                           |       816 |         37 |( 4.534314 +- 0.7283403)% |
- | "Upstream.ghostProbability"                     |       816 |   417.8332 |    0.51205 |
+ | "Upstream.ghostProbability"                     |       816 |    417.833 |    0.51205 |
  | "Upstream.numOutliers"                          |       816 |       1019 |     1.2488 |
  |*"Velo.badChisq"                                 |      6084 |       1364 |( 22.41946 +- 0.5346805)% |
  | "Velo.chisqProbSum"                             |      6084 |   1956.208 |    0.32153 |
@@ -1664,19 +1664,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      30158 |   0.027964 | 0.0023061  |    -2.4406 |     9.5009 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      74303 | 2.4812e-05 | 0.0014506  |  -0.019115 |    -1.1206 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      29996 |  1.318e-05 | 0.0014194  | -0.0048927 |    -1.0597 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38576 | 1.5281e-05 | 0.0014369  | -0.0099208 |    -1.0896 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 1.3249e-05 | 0.0015273  | -0.0097766 |    -1.2362 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27029 |  1.022e-05 | 0.0015425  | -0.0083074 |    -1.2547 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 2.9424e-05 | 0.0015121  |  -0.020414 |    -1.2136 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35430 | 2.9764e-05 | 0.0015225  |   -0.02345 |    -1.2258 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1171e-05 | 0.0012578  |   -0.02643 |   -0.84227 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.8886e-05 | 0.0011454  |    0.02401 |   -0.67009 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1171e-05 | 0.0012578  |   -0.02643 |   -0.84227 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.2615e-05 | 0.0012796  |  -0.027909 |    -0.8641 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.3696e-05 | 0.0011751  |  0.0028078 |   -0.69373 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      74303 | 2.4683e-05 | 0.0014507  |   -0.01912 |    -1.1206 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      29996 |  1.295e-05 | 0.0014196  | -0.0048983 |    -1.0598 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38576 | 1.5105e-05 | 0.0014371  | -0.0099464 |    -1.0897 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 1.2814e-05 | 0.0015273  | -0.0097163 |    -1.2362 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27029 | 9.3832e-06 | 0.0015425  | -0.0081363 |    -1.2547 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      67395 | 2.9097e-05 | 0.0015121  |   -0.02038 |    -1.2136 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35430 | 2.9137e-05 | 0.0015226  |  -0.023388 |    -1.2258 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1733e-05 | 0.0012582  |   -0.02595 |   -0.84192 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9823e-05 | 0.0011463  |   0.025554 |   -0.66887 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1733e-05 | 0.0012582  |   -0.02595 |   -0.84192 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.3236e-05 | 0.0012800  |  -0.027392 |   -0.86374 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2645e-05 | 0.0011760  |  0.0044794 |   -0.69236 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      67395 |     3.1168 | 1.8129     |   0.028477 |    -1.1976 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       6908 |     3.1343 | 1.7895     | -0.0025063 |    -1.1838 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      67395 |   0.039682 | 0.011520   |   -0.67564 |    -0.5459 |
@@ -2229,37 +2229,37 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      35707 |   0.027179 | 0.0043057  |    -1.7269 |     2.7582 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 |  5.731e-06 | 0.0014547  |  -0.012863 |    -1.1208 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18444 |-1.4277e-05 | 0.0014387  |   0.017776 |    -1.0868 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 |  5.731e-06 | 0.0014547  |  -0.012863 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 | 5.5102e-06 | 0.0014549  |  -0.012859 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18444 |-1.4695e-05 | 0.0014390  |   0.017739 |    -1.0868 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      37383 | 5.5102e-06 | 0.0014549  |  -0.012859 |    -1.1208 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7464e-05 | 0.0014383  |  -0.094991 |    -1.0964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7571e-05 | 0.0014381  |  -0.094644 |    -1.0968 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        803 | 0.00027761 | 0.0016222  |   -0.21451 |    -1.4353 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1593 | 0.00013605 | 0.0014822  |   -0.10605 |    -1.2166 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2756 |-8.9289e-05 | 0.0013763  |   0.059504 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4621 | 2.8814e-05 | 0.0014318  |  -0.041701 |    -1.1196 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3343e-05 | 0.0014612  |   0.037782 |    -1.1388 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.8717e-05 | 0.0014532  |  -0.027857 |    -1.0929 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4474e-05 | 0.0014769  | -0.0097939 |    -1.1465 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3318e-05 | 0.0014612  |    0.03801 |    -1.1391 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.7768e-05 | 0.0014538  |  -0.028112 |    -1.0926 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4127e-05 | 0.0014771  | -0.0098002 |    -1.1462 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7464e-05 | 0.0014383  |  -0.094991 |    -1.0964 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1602 | 7.7571e-05 | 0.0014381  |  -0.094644 |    -1.0968 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        350 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        803 | 0.00027761 | 0.0016222  |   -0.21451 |    -1.4353 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1593 | 0.00013605 | 0.0014822  |   -0.10605 |    -1.2166 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2756 |-8.9289e-05 | 0.0013763  |   0.059504 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4621 | 2.8814e-05 | 0.0014318  |  -0.041701 |    -1.1196 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3343e-05 | 0.0014612  |   0.037782 |    -1.1388 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.8717e-05 | 0.0014532  |  -0.027857 |    -1.0929 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4474e-05 | 0.0014769  | -0.0097939 |    -1.1465 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38576 | 1.5281e-05 | 0.0014369  | -0.0099208 |    -1.0896 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      74303 | 3.0224e-05 | 0.0014573  |  -0.022201 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8246 |-2.3318e-05 | 0.0014612  |    0.03801 |    -1.1391 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      10854 | 2.7768e-05 | 0.0014538  |  -0.028112 |    -1.0926 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6463 |-3.4127e-05 | 0.0014771  | -0.0098002 |    -1.1462 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38576 | 1.5105e-05 | 0.0014371  | -0.0099464 |    -1.0897 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      74303 | 3.0135e-05 | 0.0014574  |  -0.022197 |    -1.1301 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      74303 |     3.1184 | 1.8108     |   0.025635 |    -1.1963 |
- | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      74303 |   0.040306 | 0.011379   |    -0.7568 |   -0.42674 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1632e-05 | 0.0014592  |  -0.030573 |    -1.1382 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20132 | 3.9762e-05 | 0.0014350  |  -0.032782 |      -1.09 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1632e-05 | 0.0014592  |  -0.030573 |    -1.1382 |
+ | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      74303 |   0.040306 | 0.011379   |    -0.7568 |   -0.42675 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1661e-05 | 0.0014592  |  -0.030565 |    -1.1383 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20132 | 3.9792e-05 | 0.0014351  |  -0.032795 |    -1.0901 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      36920 | 5.1661e-05 | 0.0014592  |  -0.030565 |    -1.1383 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1745 |-4.1036e-05 | 0.0014340  |   0.070176 |    -1.0405 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2267,9 +2267,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1204 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2230 | 9.1032e-05 | 0.0015193  |   -0.10595 |    -1.1853 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4436 | 9.1789e-05 | 0.0014691  |  -0.077864 |    -1.1354 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012753 | 0.0014610  |  -0.093498 |    -1.1231 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 | 8.4941e-06 | 0.0014707  |   0.012916 |    -1.1601 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.864e-06 | 0.0014185  |   0.014278 |    -1.1066 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012756 | 0.0014610  |  -0.093627 |    -1.1232 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 |   8.59e-06 | 0.0014707  |   0.013019 |    -1.1601 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.832e-06 | 0.0014186  |   0.014314 |    -1.1068 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         68 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1745 |-4.1036e-05 | 0.0014340  |   0.070176 |    -1.0405 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        286 |-0.00016373 | 0.0015361  |    0.25093 |    -1.3826 |
@@ -2277,9 +2277,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1204 | 5.1133e-05 | 0.0014392  |  -0.040055 |    -1.1494 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2230 | 9.1032e-05 | 0.0015193  |   -0.10595 |    -1.1853 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4436 | 9.1789e-05 | 0.0014691  |  -0.077864 |    -1.1354 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012753 | 0.0014610  |  -0.093498 |    -1.1231 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 | 8.4941e-06 | 0.0014707  |   0.012916 |    -1.1601 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.864e-06 | 0.0014185  |   0.014278 |    -1.1066 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7898 | 0.00012756 | 0.0014610  |  -0.093627 |    -1.1232 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11399 |   8.59e-06 | 0.0014707  |   0.013019 |    -1.1601 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6949 |  2.832e-06 | 0.0014186  |   0.014314 |    -1.1068 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4964 | 4.8279e-05 | 0.0014427  |  -0.047219 |    -1.1071 |
@@ -2423,7 +2423,7 @@ RiTkGeomEffsLong                       INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsLong/Rich2Gas/proton/eff    | "Rich2Gas proton Geom. Eff. (>0)"             |        204 |    0.67353 | 0.072225   |     -1.047 |     2.3952 |
 RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeomEffsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |    0.66208 | 0.057914   |    0.44316 |   -0.47724 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |     0.6625 | 0.057753   |    0.42844 |   -0.46343 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        446 |    0.66469 | 0.055122   |     -1.803 |     6.4691 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        142 |    0.67521 | 0.050969   |   -0.66295 |     1.2811 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        446 |    0.66839 | 0.060894   |    -1.7928 |     5.8414 |
@@ -2470,7 +2470,7 @@ RiTkSignalYieldsLong                   INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0);Photon..." |        204 |     16.596 | 10.727     |    0.11302 |    -1.2396 |
 RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |       30.6 | 18.865     |   0.093038 |     -1.283 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |     30.633 | 18.898     |   0.092182 |     -1.289 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        446 |     59.708 | 5.2691     |    -1.4865 |     5.2887 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        142 |      38.13 | 16.988     |   -0.61475 |   -0.55268 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        446 |     46.488 | 13.094     |   -0.76863 |   -0.24556 |
@@ -2497,10 +2497,10 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        407 |     3.2337 | 17.266     |   -0.22166 |    0.39055 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        407 |     3.1181 | 17.183     |   -0.21845 |    0.46088 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        407 |     3.1156 | 17.186     |   -0.21867 |    0.45945 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        446 |    -18.546 | 17.644     |     0.1269 |   -0.41857 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        407 |     2.9131 | 16.376     |    -0.3619 |     0.7888 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        446 |    -4.6416 | 10.308     |   0.099241 |     3.4028 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        446 |    -4.6416 | 10.308     |   0.099298 |     3.4023 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        407 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        407 |     3.3317 | 17.120     |   -0.24899 |    0.49546 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2534,11 +2534,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 |  -0.019332 | 0.22474    |    0.18048 |   -0.64885 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |   0.020863 | 0.70798    |     2.4255 |     66.962 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |   0.020854 | 0.70798    |     2.4256 |     66.964 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |  -0.011041 | 0.22914    |   0.045132 |   -0.16426 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 |  0.0012661 | 0.53541    |   -0.02214 |     116.74 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 |   0.012981 | 0.52763    |      4.456 |     61.303 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |  -0.017112 | 0.22088    |      0.114 |    -0.8024 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 |  0.0012555 | 0.53540    |  -0.022118 |     116.75 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 |   0.012969 | 0.52762    |     4.4562 |     61.308 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |  -0.017195 | 0.22088    |    0.11482 |   -0.80207 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichPIDMonDownstream10to70/evOK         | "Event Success V Failures;Event has PIDs;..." |         89 |    0.97753 | 0.14821    |    -6.4438 |     39.523 |
@@ -3321,10 +3321,10 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Ttrack/vertex/xres                            | "x resolution / mm"                           |       2666 |    -0.0178 | 0.19874    |    0.25006 |   -0.75232 |
  | Ttrack/vertex/ypull                           | "y pull"                                      |       2666 |  -0.074865 | 1.4458     |  0.0023602 |    0.79436 |
  | Ttrack/vertex/yres                            | "y resolution / mm"                           |       2666 |  -0.027124 | 0.23406    |    0.13784 |    -1.1486 |
- | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        457 | -0.0072066 | 0.027949   |    0.23503 |    -1.1395 |
+ | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        457 | -0.0071904 | 0.027934   |    0.23504 |    -1.1379 |
  | Upstream/BegRich1/ppull                       | "p pull"                                      |        457 |   -0.39839 | 1.8807     |   0.076425 |   -0.16636 |
  | Upstream/BegRich1/qoppull                     | "qop pull"                                    |        457 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/BegRich1/txpull                      | "tx pull"                                     |        457 |   -0.73152 | 2.9746     |    0.37981 |    -1.1696 |
+ | Upstream/BegRich1/txpull                      | "tx pull"                                     |        457 |   -0.73056 | 2.9744     |    0.37896 |    -1.1696 |
  | Upstream/BegRich1/txres                       | "tx resolution"                               |        457 | 0.00034687 | 0.0011067  |   -0.61363 |   0.048765 |
  | Upstream/BegRich1/typull                      | "ty pull"                                     |        457 |    0.33244 | 1.8684     |-0.00075447 |   -0.17659 |
  | Upstream/BegRich1/tyres                       | "ty resolution"                               |        457 | 0.00012952 | 0.00071169 |   0.033209 |     1.7982 |
@@ -3352,7 +3352,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/EndVelo/tyres                        | "ty resolution"                               |        457 | 7.3272e-05 | 0.00050452 |   0.071926 |      3.968 |
  | Upstream/EndVelo/xpull                        | "x pull"                                      |        457 |    -2.0045 | 2.0494     |    0.69107 |    0.02111 |
  | Upstream/EndVelo/xres                         | "x resolution / mm"                           |        457 |   -0.11446 | 0.18374    |    0.49369 |   -0.39519 |
- | Upstream/EndVelo/ypull                        | "y pull"                                      |        457 |     -1.783 | 1.5853     |    0.37098 |    0.54827 |
+ | Upstream/EndVelo/ypull                        | "y pull"                                      |        457 |    -1.7826 | 1.5847     |    0.37228 |    0.54997 |
  | Upstream/EndVelo/yres                         | "y resolution / mm"                           |        457 |   -0.20358 | 0.17552    |      1.116 |    0.55203 |
  | Upstream/FirstMeasurement/dpoverp             | "dp/p"                                        |        454 | -0.0062165 | 0.028237   |    0.22555 |     -1.096 |
  | Upstream/FirstMeasurement/ppull               | "p pull"                                      |        454 |   -0.40052 | 1.8625     |   0.087453 |   -0.14896 |
@@ -3382,7 +3382,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/vertex/dpoverp                       | "dp/p"                                        |        457 | -0.0068828 | 0.028296   |    0.24947 |    -1.1087 |
  | Upstream/vertex/ppull                         | "p pull"                                      |        457 |   -0.40308 | 1.8774     |   0.077028 |   -0.15839 |
  | Upstream/vertex/qoppull                       | "qop pull"                                    |        457 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/vertex/txpull                        | "tx pull"                                     |        457 |   -0.01484 | 1.1072     |   -0.29855 |     2.1214 |
+ | Upstream/vertex/txpull                        | "tx pull"                                     |        457 |  -0.014619 | 1.1069     |   -0.29826 |     2.1252 |
  | Upstream/vertex/txres                         | "tx resolution"                               |        457 |-1.9671e-06 | 0.00051975 |   -0.17521 |     2.9963 |
  | Upstream/vertex/typull                        | "ty pull"                                     |        457 | -0.0048191 | 1.0650     |   -0.27087 |     1.8233 |
  | Upstream/vertex/tyres                         | "ty resolution"                               |        457 |-9.5957e-06 | 0.00047744 |      0.124 |     2.3018 |
@@ -3701,7 +3701,7 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.9 | 10659.     |     4.1659 |      23.78 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        441 |      58419 | 19160.     |    0.95676 |   -0.20549 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        441 |      58419 | 19160.     |    0.95677 |    -0.2055 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        441 |     9703.7 | 11682.     |     3.4812 |     16.703 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        441 |      24537 | 16033.     |     2.2978 |     6.2822 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        441 |      10683 | 12249.     |     3.2741 |     14.742 |
@@ -3758,13 +3758,13 @@ RiMCTkResLong                          INFO 1D profile histograms in directory "
 RiMCTkResUpstream                      INFO 1D profile histograms in directory "RiMCTkResUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |         10 |      13833 | 6776.6     |   -0.68946 |    -1.4297 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39513 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39512 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         75 |      18091 | 14319.     |      2.149 |     7.1021 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         75 | 2.4987e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         75 | 2.4988e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        285 |      20904 | 18318.     |     2.0174 |     5.8364 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        285 | 1.0865e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         49 |      26225 | 23581.     |     1.2321 |    0.44706 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 |  1.807e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.8066e+05 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      55870 | 12552.     |    0.83251 |  0.0039786 |
@@ -3795,12 +3795,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        192 |      56179 | 17968.     |    0.65609 |   -0.64797 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56534 |   -0.95197 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9369.1 | 10772.     |       3.09 |     12.515 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25405 | 14755.     |     1.7971 |     3.4386 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11067 | 11666.     |     2.7462 |      9.829 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12833 | 12312.     |     2.5213 |     8.2134 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37697 | 15995.     |     1.2206 |     1.0316 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57146 |   -0.96665 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9371.3 | 10787.     |     3.1028 |     12.652 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25416 | 14797.     |     1.8104 |       3.51 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11070 | 11683.     |     2.7587 |      9.947 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12836 | 12331.     |     2.5337 |     8.3202 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37727 | 16072.     |     1.2347 |     1.0734 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         58 |      55623 | 12604.     |    0.82814 |   0.018014 |
@@ -3831,12 +3831,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        204 |      55940 | 18003.     |    0.66379 |   -0.63471 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57993 |   -0.92795 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9369.1 | 10772.     |       3.09 |     12.515 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25302 | 14739.     |      1.802 |     3.4659 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11035 | 11652.     |     2.7513 |     9.8662 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12774 | 12293.     |     2.5275 |     8.2568 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37515 | 15991.     |     1.2271 |      1.054 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58628 |   -0.94176 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9371.3 | 10787.     |     3.1028 |     12.652 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25313 | 14781.     |     1.8153 |     3.5375 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11038 | 11669.     |     2.7637 |     9.9845 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        411 |      12777 | 12312.     |     2.5399 |     8.3639 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37544 | 16068.     |     1.2412 |     1.0962 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      56052 | 12525.     |    0.82303 |  0.0021587 |
@@ -3867,12 +3867,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        192 |      56152 | 17958.     |    0.66509 |   -0.62279 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      56966 | 14706.     |    0.61715 |   -0.86093 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |       9488 | 10912.     |     3.0648 |      12.24 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25559 | 14839.     |     1.7826 |     3.3604 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11179 | 11806.     |     2.7252 |     9.6166 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12955 | 12455.     |     2.5013 |     8.0242 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38000 | 16283.     |     1.1914 |    0.90551 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57076 | 14871.     |    0.62431 |   -0.87404 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        440 |     9490.2 | 10926.     |      3.077 |     12.368 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25570 | 14880.     |     1.7953 |     3.4275 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        440 |      11182 | 11822.     |      2.737 |     9.7271 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        401 |      12959 | 12474.     |      2.513 |     8.1241 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38030 | 16360.     |     1.2046 |     0.9426 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3459 |-9.9991e+13 | 0.0000     |          0 |          0 |
@@ -3911,14 +3911,14 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       7129 |   0.027906 | 0.0028677  |    -2.3605 |     7.1718 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 | -2.347e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |-2.6761e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |-6.9787e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 | 2.0183e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 | 4.3959e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |-1.2911e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1676 |-3.2212e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      42558 |-1.5648e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10923 |-5.9825e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      37936 | 1.5515e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      32491 | 3.0805e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4827 |-1.2999e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1532 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1507 |   0.047463 | 0.0072253  |    -2.0191 |     4.1077 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1507 |   0.047464 | 0.0072253  |    -2.0191 |     4.1077 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichPIDMonDownstream10to70/electron/use | "electron Fraction of Tracks with RICH1 I..." |         28 |      19214 | 14290.     |     2.3487 |     4.2526 |
@@ -4108,21 +4108,21 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2370 | 9.1547e-05 | 0.10943    |  0.0043542 |    -1.3296 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4173 |  0.0021263 | 0.056969   |   -0.12688 |     2.1324 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4227 | 0.00054743 | 0.062355   |    0.10678 |     2.2671 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2370 |  -0.001836 | 0.12987    |   0.072346 |    -1.6156 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 | 0.00056501 | 0.070929   |   -0.24679 |     1.1389 |
- | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4227 |-6.1385e-06 | 0.077591   |    0.11992 |     1.0555 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2370 |  -0.001836 | 0.12987    |   0.072345 |    -1.6156 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 |   0.000565 | 0.070929   |   -0.24679 |     1.1389 |
+ | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4227 | -6.144e-06 | 0.077591   |    0.11992 |     1.0555 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2678 |    0.21282 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4475 |    0.53954 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4530 |    -0.2867 | 0.0000     |          0 |          0 |
  | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2362 | 0.00041085 | 0.10889    | -0.0049074 |    -1.3196 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4165 |  0.0020084 | 0.056483   |   -0.14021 |     2.2298 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4219 | 0.00049385 | 0.061659   |     0.1042 |     2.3652 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2362 | 0.00050105 | 0.12375    |  0.0003883 |    -1.5282 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-4.2748e-05 | 0.074157   |   -0.13431 |     1.0095 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2362 | 0.00050104 | 0.12375    | 0.00038842 |    -1.5282 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-4.2742e-05 | 0.074157   |   -0.13431 |     1.0095 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4219 | -0.0030109 | 0.079815   |   0.097411 |     1.2062 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 |   -0.00151 | 0.053420   |  -0.060756 |     1.6998 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4523 |  0.0082759 | 0.057553   |    0.44167 |     1.6701 |
- | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 | -0.0076698 | 0.061716   |    -1.0006 |     -1.652 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 | -0.0015099 | 0.053420   |  -0.060755 |     1.6998 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4523 |  0.0082759 | 0.057553   |    0.44168 |     1.6701 |
+ | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4165 | -0.0076697 | 0.061716   |    -1.0006 |     -1.652 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4219 |   0.024798 | 0.071653   |    0.60489 |   0.046332 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       7850 |  0.0012004 | 0.18942    |  -0.031627 |   -0.79258 |
  | curvatureRatioTToLongVsTxNeg                  | "curvature ratio T to Long versus tx for neg" |       2125 |  0.0024655 | 0.062986   |    0.56734 |     1.9374 |
@@ -4155,10 +4155,10 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsMom                          | "chi2 prob versus momentum"                   |       2822 |     8139.8 | 8980.7     |     3.2084 |     15.157 |
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       2837 |   0.034418 | 2.1274     | -0.0098799 |    -1.1084 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        479 |      10232 | 12084.     |     2.6231 |     7.8265 |
- | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        486 |  -0.027645 | 1.8169     |   0.013054 |    -1.0707 |
+ | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        486 |  -0.027647 | 1.8169     |   0.013054 |    -1.0707 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        447 |     2.6561 | 0.52846    |     1.1642 |     1.0727 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        479 |     5525.6 | 5647.7     |     6.6061 |     62.855 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        486 |  -0.033865 | 1.8195     |  -0.023433 |    -1.0042 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        479 |     5525.6 | 5647.7     |     6.6062 |     62.855 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        486 |  -0.033868 | 1.8195     |  -0.023431 |    -1.0042 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6084 |     8207.9 | 11854.     |     1.7728 |     2.1026 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6084 |   -0.11337 | 1.8081     |   0.032512 |    -1.1615 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       4233 |     3.1562 | 0.95664    |    0.53914 |     -1.152 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
index db1f2a73936..12101960f48 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-detdesc-opt
@@ -294,7 +294,7 @@ TransportSvc                        SUCCESS  GEOMETRY ERRORS: 'Recover'  map has
    | BeforeMagnetRegion/Rich1/lvRich1Mirror1Master           | X0 | 11      0.00011103033   0.00023916921 0               0.000810144 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | mm | 117     40.421118           65.920598 0.46504249          315.106 |
    | BeforeMagnetRegion/Rich1/lvRich1SubMaster               | X0 | 117     0.11539325         0.18906154 0                  0.903066 |
-   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 1936    0.01381654        0.047314374 1.3194389e-11       1.15514 |
+   | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | mm | 1936    0.013816541       0.047314374 1.3194389e-11       1.15514 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilCompTnTUnit        | X0 | 1936    0                           0 0                           |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | mm | 5       0.15687276           0.232458 0.017163744        0.618694 |
    | BeforeMagnetRegion/VP/RFFoil/lvRFFoilInter19            | X0 | 5       0                           0 0                           |
@@ -1327,7 +1327,7 @@ TrackBestTrackCreator_3652aaaf         INFO Number of counters : 32
  |*"Upstream.badChisq"                             |       680 |        180 |( 26.47059 +- 1.691835)% |
  | "Upstream.chisqProbSum"                         |       680 |   203.8682 |    0.29981 |
  |*"Upstream.flipCharge"                           |       680 |         16 |( 2.352941 +- 0.5812737)% |
- | "Upstream.ghostProbability"                     |       680 |   203.2289 |    0.29887 |
+ | "Upstream.ghostProbability"                     |       680 |    203.229 |    0.29887 |
  | "Upstream.numOutliers"                          |       680 |        535 |    0.78676 |
  |*"Velo.badChisq"                                 |      5803 |       1356 |( 23.36722 +- 0.5555006)% |
  | "Velo.chisqProbSum"                             |      5803 |   1856.365 |    0.31990 |
@@ -1699,19 +1699,19 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      34877 |     0.0281 | 0.0023348  |    -2.5386 |     10.232 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      84853 | 2.5277e-05 | 0.0014051  |  -0.010033 |    -1.0228 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      39039 | 1.7466e-05 | 0.0013642  | 0.00096113 |   -0.94465 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51047 | 2.7012e-06 | 0.0014006  |  0.0086361 |    -1.0145 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 5.6517e-05 | 0.0015248  |  -0.048402 |    -1.2407 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35741 | 5.7365e-05 | 0.0015263  |   -0.05442 |     -1.253 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 4.8942e-05 | 0.0015204  |  -0.043776 |    -1.2295 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      47260 | 4.0075e-05 | 0.0015210  |  -0.035361 |    -1.2417 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0151e-05 | 0.0011107  |    0.04324 |   -0.41657 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3298 |-6.6313e-05 | 0.00093120 |   0.057896 |   -0.12955 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0151e-05 | 0.0011107  |    0.04324 |   -0.41657 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-7.0552e-05 | 0.0011155  |   0.050701 |   -0.41028 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3787 |-0.00010667 | 0.00095680 |-0.00031171 |   -0.15209 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      84853 | 2.5014e-05 | 0.0014050  |  -0.010183 |    -1.0227 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      39039 | 1.7455e-05 | 0.0013643  | 0.00086754 |    -0.9445 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      51047 | 2.6926e-06 | 0.0014006  |   0.008537 |    -1.0144 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 5.6107e-05 | 0.0015246  |  -0.048455 |    -1.2406 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35741 | 5.7342e-05 | 0.0015264  |  -0.054511 |    -1.2529 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      77486 | 4.8584e-05 | 0.0015203  |  -0.043815 |    -1.2294 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      47260 | 4.0058e-05 | 0.0015211  |  -0.035461 |    -1.2416 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0095e-05 | 0.0011106  |    0.04331 |    -0.4165 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3298 |-6.6297e-05 | 0.00093116 |   0.057953 |   -0.12936 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |-4.0095e-05 | 0.0011106  |    0.04331 |    -0.4165 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       7367 |  -7.05e-05 | 0.0011154  |   0.050773 |   -0.41023 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3787 |-0.00010666 | 0.00095676 |-0.00027709 |   -0.15187 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      77486 |     3.1244 | 1.8125     |   0.020295 |    -1.1929 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       7367 |       3.13 | 1.8112     |  0.0050379 |    -1.2045 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      77486 |   0.039199 | 0.011741   |    -0.6421 |   -0.62141 |
@@ -2266,37 +2266,37 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      88266 |   0.026988 | 0.0044928  |    -1.6213 |     2.2946 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.9522e-06 | 0.0014256  |  -0.012523 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      25624 |-7.0996e-06 | 0.0013972  |   0.002827 |    -1.0027 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.9522e-06 | 0.0014256  |  -0.012523 |    -1.0615 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.6509e-06 | 0.0014255  |  -0.012681 |    -1.0614 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      25624 |-7.1515e-06 | 0.0013973  |  0.0026548 |    -1.0025 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      43404 | 2.6509e-06 | 0.0014255  |  -0.012681 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 |  0.0001498 | 0.0013644  |   -0.10525 |   -0.95246 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 | 0.00014994 | 0.0013645  |   -0.10529 |   -0.95252 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1458 | 0.00042866 | 0.0014626  |   -0.43835 |   -0.99005 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2591 |-5.4825e-05 | 0.0014817  |   0.039013 |    -1.1954 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8128e-05 | 0.0014788  |  -0.065747 |      -1.15 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011936 |     -1.055 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.3468e-05 | 0.0014252  |    0.03862 |    -1.0492 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.3601e-06 | 0.0013847  |  0.0061811 |   -0.98867 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8065e-05 | 0.0014789  |  -0.065664 |    -1.1502 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011888 |    -1.0551 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.4381e-05 | 0.0014246  |   0.038315 |    -1.0492 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.5297e-06 | 0.0013848  |  0.0056163 |   -0.98797 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         72 |  0.0004615 | 0.0016122  |   -0.81456 |   -0.89584 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 |  0.0001498 | 0.0013644  |   -0.10525 |   -0.95246 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2197 | 0.00014994 | 0.0013645  |   -0.10529 |   -0.95252 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        340 |-8.1152e-05 | 0.0016138  |   -0.15032 |    -1.4494 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022211 | 0.0015060  |   -0.13883 |    -1.1923 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        761 | 0.00022286 | 0.0015053  |    -0.1391 |    -1.1904 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1458 | 0.00042866 | 0.0014626  |   -0.43835 |   -0.99005 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2591 |-5.4825e-05 | 0.0014817  |   0.039013 |    -1.1954 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8128e-05 | 0.0014788  |  -0.065747 |      -1.15 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011936 |     -1.055 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.3468e-05 | 0.0014252  |    0.03862 |    -1.0492 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.3601e-06 | 0.0013847  |  0.0061811 |   -0.98867 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51047 | 2.7012e-06 | 0.0014006  |  0.0086361 |    -1.0145 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      84853 | 1.8024e-05 | 0.0014276  | -0.0077696 |     -1.061 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4254 | 2.8065e-05 | 0.0014789  |  -0.065664 |    -1.1502 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       9350 | 2.5518e-06 | 0.0014241  |  -0.011888 |    -1.0551 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      13875 |-5.4381e-05 | 0.0014246  |   0.038315 |    -1.0492 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8502 |-6.5297e-06 | 0.0013848  |  0.0056163 |   -0.98797 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      51047 | 2.6926e-06 | 0.0014006  |   0.008537 |    -1.0144 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      84853 | 1.7768e-05 | 0.0014275  | -0.0078776 |     -1.061 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      84853 |     3.1249 | 1.8124     |   0.018971 |    -1.1939 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      84853 |   0.039821 | 0.011599   |   -0.72434 |   -0.50628 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2453e-05 | 0.0014294  | -0.0034159 |    -1.0615 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25423 | 1.2408e-05 | 0.0014038  |   0.014116 |    -1.0266 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2453e-05 | 0.0014294  | -0.0034159 |    -1.0615 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2242e-05 | 0.0014292  | -0.0034743 |    -1.0614 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      25423 | 1.2443e-05 | 0.0014038  |   0.014091 |    -1.0266 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      41449 | 3.2242e-05 | 0.0014292  | -0.0034743 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2156 | 1.7852e-05 | 0.0014213  |  -0.037001 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
@@ -2304,9 +2304,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1240 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2252 | 4.4806e-05 | 0.0014756  |  -0.026818 |    -1.1126 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4325 |-2.4027e-05 | 0.0014511  |   0.025404 |    -1.0796 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0336e-05 | 0.0014149  |  -0.027352 |    -1.0621 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3962e-05 | 0.0014396  |  0.0061011 |      -1.08 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2015e-05 | 0.0014050  |   0.022668 |   -0.99596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0379e-05 | 0.0014149  |  -0.027479 |    -1.0621 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3225e-05 | 0.0014391  |   0.006031 |    -1.0798 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2073e-05 | 0.0014050  |   0.022655 |    -0.9959 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         96 |-0.00055545 | 0.0014025  |    0.62288 |   -0.98479 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2156 | 1.7852e-05 | 0.0014213  |  -0.037001 |    -1.0614 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        323 | 0.00025082 | 0.0012021  |  -0.098391 |   -0.96498 |
@@ -2314,53 +2314,53 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1240 | 4.2857e-05 | 0.0015053  |  -0.012474 |    -1.2065 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2252 | 4.4806e-05 | 0.0014756  |  -0.026818 |    -1.1126 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4325 |-2.4027e-05 | 0.0014511  |   0.025404 |    -1.0796 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0336e-05 | 0.0014149  |  -0.027352 |    -1.0621 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3962e-05 | 0.0014396  |  0.0061011 |      -1.08 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2015e-05 | 0.0014050  |   0.022668 |   -0.99596 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8276 | 9.0379e-05 | 0.0014149  |  -0.027479 |    -1.0621 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      13689 | 1.3225e-05 | 0.0014391  |   0.006031 |    -1.0798 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8362 | 1.2073e-05 | 0.0014050  |   0.022655 |    -0.9959 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 43
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 | -1.146e-05 | 0.0014033  |   0.016595 |    -1.0146 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      17505 |-1.1436e-05 | 0.0014034  |   0.016498 |    -1.0145 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6106e-05 | 0.0014224  |   0.016317 |    -1.0217 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1116e-05 | 0.0013747  |  -0.015649 |   -0.99084 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 |    0.00014 | 0.0014028  |  -0.041477 |    -1.0737 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6071e-05 | 0.0014224  |   0.016255 |    -1.0218 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1052e-05 | 0.0013747  |  -0.016179 |   -0.99023 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1416 | 0.00014024 | 0.0014030  |  -0.041582 |    -1.0738 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         25 | -0.0010256 | 0.0010503  |    0.39877 |   -0.96312 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         60 |-0.00044778 | 0.0014068  |    0.47138 |    -1.1106 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         78 | -0.0006084 | 0.0014360  |    0.52949 |   -0.76953 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        163 | -0.0004907 | 0.0011792  |    0.31878 |   -0.77953 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |-5.7143e-06 | 0.0013928  |   0.038668 |   -0.98149 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0319e-05 | 0.0014006  |   0.019727 |    -1.0034 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6106e-05 | 0.0014224  |   0.016317 |    -1.0217 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1116e-05 | 0.0013747  |  -0.015649 |   -0.99084 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.4867e-06 | 0.0013977  |   0.010299 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        592 |     -6e-06 | 0.0013930  |   0.039024 |    -0.9823 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       3419 |-2.0276e-05 | 0.0014007  |   0.019767 |    -1.0034 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6964 |-2.6071e-05 | 0.0014224  |   0.016255 |    -1.0218 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4788 | 1.1052e-05 | 0.0013747  |  -0.016179 |   -0.99023 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      35131 | 2.5227e-06 | 0.0013977  |   0.010233 |    -1.0065 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      35131 |     3.1376 | 1.8087     |  0.0021491 |     -1.196 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      35131 |   0.039758 | 0.011667   |   -0.72603 |   -0.49296 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5647e-05 | 0.0013921  |  0.0046743 |   -0.99888 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      17626 | 1.5693e-05 | 0.0013922  |  0.0046416 |   -0.99878 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1119 |-1.9116e-05 | 0.0013882  |   0.029505 |    -1.0038 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.0676e-05 | 0.0012898  |    0.15392 |   -0.73665 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        953 |-6.7498e-05 | 0.0013501  |    0.11522 |   -0.90668 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035051 |    -1.0152 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.6189e-06 | 0.0014099  |  -0.016984 |      -1.03 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035146 |     -1.015 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.4894e-06 | 0.0014099  |  -0.017011 |    -1.0298 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4446 |-2.0269e-05 | 0.0013753  |   0.029018 |   -0.95041 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1119 |-1.9116e-05 | 0.0013882  |   0.029505 |    -1.0038 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 |-0.00099171 | 0.0015889  |     1.4354 |     0.7591 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        200 |-7.0676e-05 | 0.0012898  |    0.15392 |   -0.73665 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        953 |-6.7498e-05 | 0.0013501  |    0.11522 |   -0.90668 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035051 |    -1.0152 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.6189e-06 | 0.0014099  |  -0.016984 |      -1.03 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       3712 | 0.00011092 | 0.0013902  |  -0.035146 |     -1.015 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7156 |-1.4894e-06 | 0.0014099  |  -0.017011 |    -1.0298 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4446 |-2.0269e-05 | 0.0013753  |   0.029018 |   -0.95041 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2551,7 +2551,7 @@ RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        442 |    0.63563 | 17.640     |   -0.25588 |   -0.11851 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        470 |    -17.535 | 15.965     |    -0.1588 |   -0.83985 |
  | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        442 |     1.2378 | 16.877     |   -0.23161 |    0.13321 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        469 |    -4.9691 | 9.0966     |   -0.21866 |     3.5598 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        469 |    -4.9712 | 9.0957     |   -0.21816 |     3.5622 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        442 |        0.5 | 0.0000     |          0 |          0 |
  | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        442 |     1.0253 | 17.649     |   -0.23267 |  -0.063059 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
@@ -2584,11 +2584,11 @@ RichMassRingsLong                      INFO 1D histograms in directory "RichMass
  | /RICH/RichMassRingsLong/Rich2Gas/proton/pntSe | "Rich2Gas proton Ring - Segment local poi..." |      21896 |-0.00086774 | 6.9731     |    0.88184 |    0.75363 |
 RichMassRingsUpstream                  INFO 1D histograms in directory "RichMassRingsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  -0.021512 | 0.20460    |    0.37902 |    -1.4633 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |   0.012846 | 0.64607    |     1.6949 |     58.593 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  -0.021802 | 0.20457    |    0.38205 |    -1.4608 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |   0.012836 | 0.64607    |     1.6949 |     58.593 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 |  -0.020389 | 0.21899    |     0.1383 |   -0.84869 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |  0.0040533 | 0.52674    |    0.88915 |      110.5 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | -1.203e-05 | 0.44640    |    0.92156 |     35.413 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |  0.0040428 | 0.52674    |    0.88921 |      110.5 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | -2.406e-05 | 0.44640    |    0.92163 |     35.413 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 |  -0.021746 | 0.20192    |    0.21436 |    -1.7158 |
 RichPIDMonDownstream10to70             INFO 1D histograms in directory "RichPIDMonDownstream10to70" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2956,7 +2956,7 @@ TrackMonitor                           INFO 1D histograms in directory "TrackMon
  | Upstream/p                                    | "momentum"                                    |        544 |      14521 | 16433.     |     2.1439 |     4.9703 |
  | Upstream/phi                                  | "phi"                                         |        544 |  -0.014553 | 1.8054     |   0.036427 |    -1.0559 |
  | Upstream/probChi2                             | "probChi2"                                    |        544 |    0.37518 | 0.31941    |    0.51228 |    -1.1091 |
- | Upstream/pscatter                             | "momentum used for material corrections"      |        544 |      14660 | 16849.     |     2.4615 |     7.2795 |
+ | Upstream/pscatter                             | "momentum used for material corrections"      |        544 |      14664 | 16851.     |     2.4601 |     7.2725 |
  | Upstream/pt                                   | "pt"                                          |        544 |     846.14 | 559.78     |     3.2192 |     13.931 |
  | Upstream/qop_firststate                       | "q/p of first state/hit"                      |        544 | 5.5147e-06 | 0.00021042 |  0.0068329 |   -0.53278 |
  | Upstream/qoperrorAtFirst                      | "10log(qop error) at first measurement"       |        544 |    -4.7747 | 0.39134    |  -0.050515 |     -1.172 |
@@ -3809,8 +3809,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4766 |      53747 | 18217.     |     1.1886 |     1.1378 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7367 |     7945.1 | 10287.     |     4.5632 |     34.017 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        469 |      57721 | 24894.     |     1.2956 |    0.29746 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       7367 |       7945 | 10287.     |     4.5633 |     34.017 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        469 |      57721 | 24894.     |     1.2956 |    0.29745 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        469 |      10673 | 12231.     |     3.5684 |      20.18 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        469 |      24299 | 15595.     |     3.0539 |     12.607 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        469 |      11690 | 12718.     |     3.4116 |     18.487 |
@@ -3869,11 +3869,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |          8 |      18934 | 8263.8     |   -0.55182 |    -0.7941 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |          8 |     -48936 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         86 |      17452 | 10308.     |    0.39221 |   -0.69805 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         86 |      26188 | 6392.6     |    0.58672 |     -2.176 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         86 |      26188 | 6392.6     |    0.58671 |     -2.176 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        293 |      19450 | 16597.     |     2.3268 |     8.2199 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        293 |      60220 | 34165.     |   -0.44892 |   -0.98163 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        293 |      60219 | 34165.     |   -0.44889 |   -0.98166 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         51 |      25966 | 17956.     |    0.56108 |    -0.6299 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         51 |      28891 | 11916.     |    0.30337 |    0.57871 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         51 |      28891 | 11916.     |    0.30337 |    0.57868 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         11 |      52965 | 8983.4     |   -0.49869 |    -1.2041 |
@@ -3904,7 +3904,7 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        337 |      55171 | 16310.     |    0.72332 |   -0.35959 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51145 | 13232.     |     1.0869 |    0.13028 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51145 | 13232.     |     1.0869 |    0.13032 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10120 | 10356.     |     2.3372 |     7.2761 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        164 |      24222 | 11857.     |     1.6851 |     3.7827 |
  | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        466 |      11824 | 10960.     |     2.0815 |     5.8546 |
@@ -3940,7 +3940,7 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        352 |      54986 | 16341.     |    0.72702 |   -0.34992 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      50754 | 13198.     |     1.1163 |    0.21392 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      50754 | 13198.     |     1.1163 |    0.21396 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10120 | 10356.     |     2.3372 |     7.2761 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        168 |      24150 | 11852.     |     1.6867 |     3.7931 |
  | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        467 |      11793 | 10951.     |     2.0851 |      5.873 |
@@ -3976,7 +3976,7 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        337 |      55277 | 16364.     |    0.71852 |   -0.37319 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51252 | 13102.     |     1.0875 |    0.16982 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         23 |      51252 | 13102.     |     1.0876 |    0.16986 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        467 |      10236 | 10451.     |     2.3196 |     7.1542 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        164 |      24345 | 11966.     |     1.6671 |     3.6728 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        466 |      11945 | 11048.     |     2.0683 |     5.7693 |
@@ -4020,12 +4020,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       8064 |   0.027915 | 0.0028385  |    -2.3563 |     7.2292 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |-6.4094e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |-1.8422e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 |-8.1706e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-1.7433e+12 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 | 5.7591e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 | 4.8772e+11 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1376 |  8.799e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      43360 |-2.0365e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      12536 | 2.7151e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      38120 |-1.9515e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      33272 |-3.9389e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       5408 |  2.052e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1658 |     1.0798 | 0.94431    |    0.57747 |    0.12061 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1621 |   0.047612 | 0.0071905  |    -2.1658 |     4.8553 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -4210,20 +4210,20 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       3057 |  -0.071565 | 0.0000     |          0 |          0 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4850 |  -0.096737 | 0.088042   |     5.0541 |     20.354 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4904 |   -0.19685 | 0.0000     |          0 |          0 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3057 |    0.01643 | 0.015956   |     403.28 |    -3407.5 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4850 |   0.070502 | 0.10351    |    0.63858 |     -1.379 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       3057 |    0.01643 | 0.015957   |     403.25 |    -3407.1 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4850 |   0.070501 | 0.10351    |    0.63858 |     -1.379 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4904 |   0.021206 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       3062 |   -0.19453 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4851 |    0.94968 | 0.0000     |          0 |          0 |
- | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4905 |  -0.068978 | 0.33954    |    0.47766 |    -2.5937 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3055 |  -0.064835 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4848 |   -0.14784 | 0.13802    |     5.1538 |     15.088 |
- | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4902 |     2.3635 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3055 |     0.2609 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4848 |    -15.292 | 0.0000     |          0 |          0 |
- | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4902 |   -0.34903 | 0.0000     |          0 |          0 |
- | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4848 |    0.14306 | 0.10428    |     -5.691 |     24.648 |
- | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4902 |   -0.60022 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4905 |  -0.068981 | 0.33954    |    0.47768 |    -2.5937 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       3055 |  -0.064836 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4848 |   -0.14784 | 0.13802    |      5.154 |     15.089 |
+ | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4902 |     2.3634 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       3055 |    0.26089 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4848 |    -15.302 | 0.0000     |          0 |          0 |
+ | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4902 |   -0.34904 | 0.0000     |          0 |          0 |
+ | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4848 |    0.14306 | 0.10427    |    -5.6916 |     24.653 |
+ | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4902 |   -0.60023 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs tx                              | "Velo-UT dy vs tx"                            |       4848 |   0.048933 | 0.0000     |          0 |          0 |
  | Velo-UT/dy vs ty                              | "Velo-UT dy vs ty"                            |       4902 |     4.6865 | 0.0000     |          0 |          0 |
  | curvatureRatioTToLongVsQoP                    | "curvature ratio T to Long versus q/p"        |       8218 |  -0.001917 | 0.18526    |   0.045919 |   -0.70796 |
@@ -4258,9 +4258,9 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Ttrack/chi2ProbVsPhi                          | "chi2 prob versus phi"                        |       2826 |   0.039388 | 2.1371     |  -0.013273 |    -1.1224 |
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        536 |      12026 | 15035.     |     2.5481 |     7.1076 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        544 |  0.0063562 | 1.7896     |  -0.026379 |    -1.0062 |
- | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        510 |     3.1131 | 0.87913    |    0.53142 |    -1.0472 |
+ | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        510 |     3.1131 | 0.87914    |    0.53142 |    -1.0472 |
  | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        536 |      11910 | 14952.     |     2.6756 |     8.3163 |
- | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        544 |   0.015314 | 1.7899     | -0.0088242 |    -1.0126 |
+ | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        544 |   0.015313 | 1.7899     | -0.0088241 |    -1.0126 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       5802 |     7780.1 | 11904.     |     1.9009 |     2.4876 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       5803 |   -0.12833 | 1.8135     |   0.039812 |    -1.1668 |
  | Velo/chi2ProbVsEta                            | "chi2 prob versus eta"                        |       3944 |     3.0493 | 0.91332    |    0.74801 |   -0.77874 |
diff --git a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
index 142bb382428..295c2eb0073 100644
--- a/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/hlt2_reco_baseline_with_mcchecking_mpp_with_bfield.ref.x86_64_v3-opt
@@ -1282,9 +1282,9 @@ TrackBestTrackCreator_3652aaaf         INFO Number of counters : 32
  | "Ttrack.ghostProbability"                       |      2838 |   271.3132 |   0.095600 |
  | "Ttrack.numOutliers"                            |      2838 |        939 |    0.33087 |
  |*"Upstream.badChisq"                             |       815 |        455 |( 55.82822 +- 1.739484)% |
- | "Upstream.chisqProbSum"                         |       815 |   128.5401 |    0.15772 |
+ | "Upstream.chisqProbSum"                         |       815 |   128.5402 |    0.15772 |
  |*"Upstream.flipCharge"                           |       815 |         37 |( 4.539877 +- 0.7292127)% |
- | "Upstream.ghostProbability"                     |       815 |   418.2279 |    0.51316 |
+ | "Upstream.ghostProbability"                     |       815 |   418.2278 |    0.51316 |
  | "Upstream.numOutliers"                          |       815 |       1020 |     1.2515 |
  |*"Velo.badChisq"                                 |      6088 |       1365 |( 22.42116 +- 0.5345192)% |
  | "Velo.chisqProbSum"                             |      6088 |   1958.504 |    0.32170 |
@@ -1664,23 +1664,23 @@ RiCKMCResLong                          INFO 1D histograms in directory "RiCKMCRe
  | /RICH/RiCKMCResLong/Rich2Gas/thetaRecTrue     | "Rich2Gas Reconstructed CKTheta - MC true..." |      30104 |   0.027963 | 0.0023066  |    -2.4428 |     9.5065 |
 RiCKMCResUpstream                      INFO 1D histograms in directory "RiCKMCResUpstream" : 17
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      75794 |  2.419e-05 | 0.0014502  |  -0.019208 |    -1.1207 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      30231 | 1.2638e-05 | 0.0014190  | -0.0050061 |    -1.0599 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38907 |  1.516e-05 | 0.0014364  | -0.0098865 |    -1.0897 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 1.2345e-05 | 0.0015268  | -0.0097533 |    -1.2363 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAll     | "Rich1Gas Rec-Exp CKTheta - True Type;del..." |      75794 | 2.4493e-05 | 0.0014503  |  -0.019204 |    -1.1207 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllBeta | "Rich1Gas Rec-Exp CKTheta - True Type - 0..." |      30231 | 1.2632e-05 | 0.0014190  | -0.0049938 |    -1.0599 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type;del..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResAllPion | "Rich1Gas Rec-Exp CKTheta - Pion Type - 0..." |      38907 | 1.5165e-05 | 0.0014364  | -0.0098898 |    -1.0897 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFake    | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 1.2557e-05 | 0.0015269  | -0.0097732 |    -1.2363 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakeBet | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      27264 | 8.9839e-06 | 0.0015417  | -0.0082123 |    -1.2548 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 2.9537e-05 | 0.0015114  |  -0.020564 |    -1.2135 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35761 | 2.9271e-05 | 0.0015217  |  -0.023381 |    -1.2258 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1182e-05 | 0.0012578  |  -0.026292 |   -0.84193 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9676e-05 | 0.0011462  |   0.025606 |    -0.6686 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1182e-05 | 0.0012578  |  -0.026292 |   -0.84193 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.2664e-05 | 0.0012796  |  -0.027781 |    -0.8637 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2784e-05 | 0.0011759  |  0.0044873 |   -0.69201 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      68886 | 2.9521e-05 | 0.0015114  |   -0.02057 |    -1.2135 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResFakePio | "Rich1Gas Rec-Exp CKTheta - MC fake photo..." |      35761 | 2.9286e-05 | 0.0015217  |    -0.0234 |    -1.2258 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrue    | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1688e-05 | 0.0012582  |  -0.025983 |   -0.84191 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueBet | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       2967 | 1.9658e-05 | 0.0011462  |   0.025648 |   -0.66865 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueInn | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 5.1688e-05 | 0.0012582  |  -0.025983 |   -0.84191 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       6908 | 3.3224e-05 | 0.0012800  |  -0.027474 |    -0.8637 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTruePio | "Rich1Gas Rec-Exp CKTheta - MC true photo..." |       3146 |-2.2803e-05 | 0.0011759  |  0.0045336 |   -0.69206 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecFake   | "Rich1Gas Reconstructed CKPhi - MC fake p..." |      68886 |     3.1152 | 1.8142     |   0.028994 |    -1.1992 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/phiRecTrue   | "Rich1Gas Reconstructed CKPhi - MC true p..." |       6908 |     3.1343 | 1.7895     | -0.0025063 |    -1.1838 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecFake | "Rich1Gas Reconstructed CKTheta - MC fake..." |      68886 |   0.039305 | 0.011771   |   -0.64618 |    -0.6294 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       6908 |   0.046308 | 0.0076576  |    -1.7475 |      2.655 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/thetaRecTrue | "Rich1Gas Reconstructed CKTheta - MC true..." |       6908 |   0.046308 | 0.0076577  |    -1.7474 |     2.6549 |
 RiCKResDownstream                      INFO 1D histograms in directory "RiCKResDownstream" : 137
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiCKResDownstream/Rich1Gas/bottom/ckRes | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      56426 |  7.448e-05 | 0.0014256  |  -0.067304 |    -1.0923 |
@@ -2229,9 +2229,9 @@ RiCKResLongTight                       INFO 1D histograms in directory "RiCKResL
  | /RICH/RiCKResLongTight/Rich2Gas/thetaRec      | "Rich2Gas Reconstructed CKTheta - All pho..." |      35662 |   0.027189 | 0.0043018  |    -1.7355 |     2.7949 |
 RiCKResUpstream                        INFO 1D histograms in directory "RiCKResUpstream" : 51
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012863 |    -1.1208 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18579 | -1.431e-05 | 0.0014382  |   0.017772 |    -1.0868 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012863 |    -1.1208 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012888 |    -1.1209 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      18579 |-1.4286e-05 | 0.0014382  |   0.017742 |    -1.0868 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/ckResAl | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      38159 | 5.9823e-06 | 0.0014543  |  -0.012888 |    -1.1209 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1607 | 7.7571e-05 | 0.0014378  |  -0.094745 |    -1.0971 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2239,9 +2239,9 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1611 | 0.00013605 | 0.0014819  |   -0.10504 |    -1.2173 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2797 |-8.9169e-05 | 0.0013765  |   0.059543 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4801 | 2.9048e-05 | 0.0014317  |  -0.041406 |      -1.12 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1797e-05 | 0.0014605  |   0.037926 |    -1.1389 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027967 |     -1.093 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.5907e-05 | 0.0014759  |  -0.010153 |    -1.1461 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1671e-05 | 0.0014605  |   0.037839 |    -1.1388 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027938 |    -1.0931 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/In | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.6099e-05 | 0.0014759  |  -0.010211 |    -1.1463 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |         90 |-0.00053114 | 0.0014052  |   -0.22818 |    -1.3293 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1607 | 7.7571e-05 | 0.0014378  |  -0.094745 |    -1.0971 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |        353 | 0.00061822 | 0.0012583  |   -0.95854 |   -0.06326 |
@@ -2249,36 +2249,36 @@ RiCKResUpstream                        INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1611 | 0.00013605 | 0.0014819  |   -0.10504 |    -1.2173 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       2797 |-8.9169e-05 | 0.0013765  |   0.059543 |    -1.0038 |
  | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       4801 | 2.9048e-05 | 0.0014317  |  -0.041406 |      -1.12 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1797e-05 | 0.0014605  |   0.037926 |    -1.1389 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027967 |     -1.093 |
- | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.5907e-05 | 0.0014759  |  -0.010153 |    -1.1461 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38907 |  1.516e-05 | 0.0014364  | -0.0098865 |    -1.0897 |
- | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      75794 | 3.0322e-05 | 0.0014567  |  -0.022298 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       8405 |-2.1671e-05 | 0.0014605  |   0.037839 |    -1.1388 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |      11065 | 2.8864e-05 | 0.0014532  |  -0.027938 |    -1.0931 |
+ | /RICH/RiCKResUpstream/Rich1Gas/bottom/cols/ck | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       6614 |-3.6099e-05 | 0.0014759  |  -0.010211 |    -1.1463 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAll       | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllBetaCu | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      38907 | 1.5165e-05 | 0.0014364  | -0.0098898 |    -1.0897 |
+ | /RICH/RiCKResUpstream/Rich1Gas/ckResAllInner  | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      75794 |  3.045e-05 | 0.0014568  |  -0.022319 |    -1.1301 |
  | /RICH/RiCKResUpstream/Rich1Gas/phiRec         | "Rich1Gas Reconstructed CKPhi - All photo..." |      75794 |     3.1169 | 1.8119     |   0.026158 |    -1.1979 |
  | /RICH/RiCKResUpstream/Rich1Gas/thetaRec       | "Rich1Gas Reconstructed CKTheta - All pho..." |      75794 |   0.039954 | 0.011631   |   -0.72877 |   -0.51274 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1609e-05 | 0.0014585  |  -0.030744 |    -1.1381 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20328 | 3.9571e-05 | 0.0014344  |  -0.032717 |    -1.0901 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1609e-05 | 0.0014585  |  -0.030744 |    -1.1381 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1848e-05 | 0.0014586  |  -0.030768 |    -1.1381 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      20328 | 3.9561e-05 | 0.0014344  |  -0.032698 |    -1.0902 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/ckResAllPe | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      37635 | 5.1848e-05 | 0.0014586  |  -0.030768 |    -1.1381 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1756 | -4.088e-05 | 0.0014342  |   0.070171 |    -1.0409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.0333e-05 | 0.0015132  |   -0.11026 |    -1.1806 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0222e-05 | 0.0014688  |  -0.076122 |    -1.1345 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012741 | 0.0014611  |  -0.093494 |    -1.1235 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012828 |    -1.1597 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.6263e-05 | 0.0015163  |   -0.11033 |    -1.1807 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0129e-05 | 0.0014687  |  -0.076166 |    -1.1346 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012739 | 0.0014611  |  -0.093539 |    -1.1235 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012833 |    -1.1598 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/Inner | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7102 | 2.6112e-06 | 0.0014163  |   0.014405 |    -1.1074 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         69 | 0.00056333 | 0.0011184  |   -0.30852 |    -1.3802 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1756 | -4.088e-05 | 0.0014342  |   0.070171 |    -1.0409 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        290 |-0.00016373 | 0.0015358  |      0.252 |    -1.3835 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 |  0.0003413 | 0.0014416  |   -0.39329 |    -1.0471 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.9186e-05 | 0.0014367  |  -0.055931 |    -1.1515 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.0333e-05 | 0.0015132  |   -0.11026 |    -1.1806 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0222e-05 | 0.0014688  |  -0.076122 |    -1.1345 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012741 | 0.0014611  |  -0.093494 |    -1.1235 |
- | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012828 |    -1.1597 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        696 | 0.00034048 | 0.0014408  |   -0.39401 |    -1.0458 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1232 | 6.8893e-05 | 0.0014362  |  -0.057052 |    -1.1528 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2262 | 9.6263e-05 | 0.0015163  |   -0.11033 |    -1.1807 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       4543 | 9.0129e-05 | 0.0014687  |  -0.076166 |    -1.1346 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       8076 | 0.00012739 | 0.0014611  |  -0.093539 |    -1.1235 |
+ | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |      11601 | 8.3215e-06 | 0.0014706  |   0.012833 |    -1.1598 |
  | /RICH/RiCKResUpstream/Rich1Gas/top/cols/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       7102 | 2.6112e-06 | 0.0014163  |   0.014405 |    -1.1074 |
 RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResUpstreamTight" : 39
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2299,27 +2299,27 @@ RiCKResUpstreamTight                   INFO 1D histograms in directory "RiCKResU
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1198 |-3.2933e-06 | 0.0014528  |    0.01223 |    -1.1014 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1926 | 9.1663e-05 | 0.0014709  |  -0.076287 |      -1.15 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/bottom/co | "Rich1Gas bottom Rec-Exp CKTheta - All ph..." |       1192 | 7.7107e-05 | 0.0014072  |  -0.074893 |    -1.0739 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.5031e-06 | 0.0014306  |  -0.024869 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAll  | "Rich1Gas Rec-Exp CKTheta - All photons;d..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllB | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/ckResAllI | "Rich1Gas Rec-Exp CKTheta - All photons -..." |      11074 | 3.4829e-06 | 0.0014306  |  -0.024829 |    -1.0816 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/phiRec    | "Rich1Gas Reconstructed CKPhi - All photo..." |      11074 |     3.1268 | 1.8144     |   0.011834 |    -1.2037 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62054 |   -0.66614 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0475e-05 | 0.0014203  | -0.0093961 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/thetaRec  | "Rich1Gas Reconstructed CKTheta - All pho..." |      11074 |   0.038981 | 0.011846   |   -0.62053 |   -0.66615 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/ckRes | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       6089 |-3.0511e-05 | 0.0014203  |  -0.009325 |    -1.0609 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        374 |-2.9611e-05 | 0.0014141  |  -0.011705 |    -1.0912 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         40 | -0.0011895 | 0.00075889 |     1.1833 |    0.80368 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |         88 | 0.00046429 | 0.0015550  |   -0.37345 |    -1.0379 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |        405 | 9.1342e-05 | 0.0014133  |   -0.21523 |   -0.92648 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1477 |   0.000143 | 0.0014117  |   -0.13348 |    -1.0578 |
- | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2122e-05 | 0.0014256  |   0.027934 |    -1.0154 |
+ | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       2216 |-5.2244e-05 | 0.0014257  |   0.028177 |    -1.0155 |
  | /RICH/RiCKResUpstreamTight/Rich1Gas/top/cols/ | "Rich1Gas top Rec-Exp CKTheta - All photo..." |       1489 |-0.00026367 | 0.0013905  |    0.16224 |    -1.0432 |
 RiTkDetectableYieldsDownstream         INFO 1D histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
@@ -2426,7 +2426,7 @@ RiTkGeomEffsUpstream                   INFO 1D histograms in directory "RiTkGeom
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/deuteron/ | "Rich1Gas deuteron Geom. Eff. (>0)"           |         24 |    0.65875 | 0.058081   |    0.54927 |   -0.37747 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/electron/ | "Rich1Gas electron Geom. Eff. (>0)"           |        445 |    0.66304 | 0.055327   |    -1.7214 |     6.2416 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/kaon/eff  | "Rich1Gas kaon Geom. Eff. (>0)"               |        142 |     0.6731 | 0.050531   |   -0.86048 |     3.0728 |
- | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        445 |    0.66648 | 0.061768   |    -1.5751 |       4.96 |
+ | /RICH/RiTkGeomEffsUpstream/Rich1Gas/muon/eff  | "Rich1Gas muon Geom. Eff. (>0)"               |        445 |    0.66646 | 0.061847   |    -1.5814 |     4.9796 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/pion/eff  | "Rich1Gas pion Geom. Eff. (>0)"               |        406 |    0.66778 | 0.060980   |    -1.2414 |     5.1551 |
  | /RICH/RiTkGeomEffsUpstream/Rich1Gas/proton/ef | "Rich1Gas proton Geom. Eff. (>0)"             |         67 |    0.65724 | 0.059093   |   -0.14821 |   -0.17854 |
 RiTkMaterialDownstream                 INFO 1D histograms in directory "RiTkMaterialDownstream" : 2
@@ -2473,7 +2473,7 @@ RiTkSignalYieldsUpstream               INFO 1D histograms in directory "RiTkSign
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0);Phot..." |         24 |     31.067 | 19.320     |   0.075317 |    -1.3434 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0);Phot..." |        445 |     59.578 | 5.2731     |    -1.4499 |     5.2119 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0);Photon Y..." |        142 |     38.028 | 16.869     |    -0.6185 |    -0.5097 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        445 |     46.343 | 13.047     |   -0.77828 |   -0.22455 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0);Photon Y..." |        445 |     46.342 | 13.049     |   -0.77795 |   -0.22596 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0);Photon Y..." |        406 |     41.237 | 17.241     |   -0.69667 |   -0.60955 |
  | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0);Photon..." |         67 |     32.245 | 17.577     |  -0.031988 |    -1.1013 |
 RichDLLsDownstream                     INFO 1D histograms in directory "RichDLLsDownstream" : 7
@@ -2496,13 +2496,13 @@ RichDLLsLong                           INFO 1D histograms in directory "RichDLLs
  | /RICH/RichDLLsLong/proton/dll                 | "proton DLL"                                  |       3995 |    -2.3174 | 20.455     |  -0.070246 |   -0.11602 |
 RichDLLsUpstream                       INFO 1D histograms in directory "RichDLLsUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        406 |     2.9899 | 17.208     |    -0.2077 |    0.32827 |
- | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        406 |     2.8643 | 17.157     |   -0.20801 |    0.38038 |
+ | /RICH/RichDLLsUpstream/below_threshold/dll    | "below_threshold DLL"                         |        406 |     2.9925 | 17.206     |   -0.20785 |    0.32973 |
+ | /RICH/RichDLLsUpstream/deuteron/dll           | "deuteron DLL"                                |        406 |     2.8668 | 17.155     |   -0.20815 |    0.38187 |
  | /RICH/RichDLLsUpstream/electron/dll           | "electron DLL"                                |        445 |     -18.56 | 17.634     |    0.10609 |   -0.52457 |
- | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        406 |     2.7443 | 16.256     |   -0.36131 |    0.74091 |
- | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        445 |    -4.3984 | 10.134     |    0.38446 |     3.3038 |
+ | /RICH/RichDLLsUpstream/kaon/dll               | "kaon DLL"                                    |        406 |     2.7443 | 16.258     |   -0.36202 |    0.74154 |
+ | /RICH/RichDLLsUpstream/muon/dll               | "muon DLL"                                    |        445 |    -4.3962 | 10.143     |    0.39387 |     3.3411 |
  | /RICH/RichDLLsUpstream/pion/dll               | "pion DLL"                                    |        406 |        0.5 | 0.0000     |          0 |          0 |
- | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        406 |     3.0854 | 17.004     |   -0.24768 |    0.45549 |
+ | /RICH/RichDLLsUpstream/proton/dll             | "proton DLL"                                  |        406 |     3.0879 | 17.001     |   -0.24783 |    0.45706 |
 RichMassRingsDownstream                INFO 1D histograms in directory "RichMassRingsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3264 |   -0.02598 | 0.21853    |    0.27003 |   -0.77629 |
@@ -3324,7 +3324,7 @@ TrackResChecker__Event_TrackBest...    INFO 1D histograms in directory "TrackRes
  | Upstream/BegRich1/dpoverp                     | "dp/p"                                        |        456 | -0.0071904 | 0.027934   |    0.23504 |    -1.1379 |
  | Upstream/BegRich1/ppull                       | "p pull"                                      |        456 |   -0.40427 | 1.8781     |   0.079908 |   -0.15338 |
  | Upstream/BegRich1/qoppull                     | "qop pull"                                    |        456 |    -3.2178 | 2.1948     |     2.1871 |     3.8345 |
- | Upstream/BegRich1/txpull                      | "tx pull"                                     |        456 |   -0.73152 | 2.9746     |    0.37981 |    -1.1696 |
+ | Upstream/BegRich1/txpull                      | "tx pull"                                     |        456 |   -0.73056 | 2.9744     |    0.37896 |    -1.1696 |
  | Upstream/BegRich1/txres                       | "tx resolution"                               |        456 | 0.00035584 | 0.0010976  |   -0.60708 |   0.062502 |
  | Upstream/BegRich1/typull                      | "ty pull"                                     |        456 |    0.33681 | 1.8685     | -0.0056561 |   -0.17249 |
  | Upstream/BegRich1/tyres                       | "ty resolution"                               |        456 | 0.00013127 | 0.00071154 |   0.028832 |     1.8096 |
@@ -3700,8 +3700,8 @@ RiCKMCResLong                          INFO 1D profile histograms in directory "
  | /RICH/RiCKMCResLong/Rich2Gas/proton/ckexpVpto | "Rich2Gas proton Expected CK theta V trac..." |       4686 |      55481 | 21194.     |     1.1333 |    0.60418 |
 RiCKMCResUpstream                      INFO 1D profile histograms in directory "RiCKMCResUpstream" : 7
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.7 | 10659.     |     4.1661 |     23.783 |
- | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        440 |      58419 | 19160.     |    0.95679 |   -0.20546 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/ckResTrueVP  | "Rich1Gas <|Rec-Exp CKTheta|> V P - MC tr..." |       6908 |     8735.8 | 10659.     |      4.166 |     23.782 |
+ | /RICH/RiCKMCResUpstream/Rich1Gas/deuteron/cke | "Rich1Gas deuteron Expected CK theta V tr..." |        440 |      58419 | 19160.     |    0.95678 |   -0.20548 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/electron/cke | "Rich1Gas electron Expected CK theta V tr..." |        440 |     9717.8 | 11691.     |     3.4773 |     16.666 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/kaon/ckexpVp | "Rich1Gas kaon Expected CK theta V track ..." |        440 |      24537 | 16033.     |     2.2979 |     6.2823 |
  | /RICH/RiCKMCResUpstream/Rich1Gas/muon/ckexpVp | "Rich1Gas muon Expected CK theta V track ..." |        440 |      10699 | 12258.     |     3.2709 |     14.713 |
@@ -3760,11 +3760,11 @@ RiMCTkResUpstream                      INFO 1D profile histograms in directory "
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/mcp | "Rich1Gas electron MC V Reco Track Moment..." |         10 |      13833 | 6776.6     |   -0.68946 |    -1.4297 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/electron/pdi | "Rich1Gas electron (Rec-MC) V Reco Track ..." |         10 |      39301 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/mcpVrec | "Rich1Gas kaon MC V Reco Track Momentum;R..." |         74 |      18196 | 14319.     |     2.1503 |     7.1066 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         74 | 2.2866e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/kaon/pdiffVr | "Rich1Gas kaon (Rec-MC) V Reco Track Mome..." |         74 | 2.2867e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/mcpVrec | "Rich1Gas pion MC V Reco Track Momentum;R..." |        285 |      20904 | 18318.     |     2.0174 |     5.8364 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/pion/pdiffVr | "Rich1Gas pion (Rec-MC) V Reco Track Mome..." |        285 | 1.0858e+05 | 0.0000     |          0 |          0 |
  | /RICH/RiMCTkResUpstream/Rich1Gas/proton/mcpVr | "Rich1Gas proton MC V Reco Track Momentum..." |         49 |      26225 | 23581.     |     1.2321 |    0.44706 |
- | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.7983e+05 | 0.0000     |          0 |          0 |
+ | /RICH/RiMCTkResUpstream/Rich1Gas/proton/pdiff | "Rich1Gas proton (Rec-MC) V Reco Track Mo..." |         49 | 1.7982e+05 | 0.0000     |          0 |          0 |
 RiTkDetectableYieldsDownstream         INFO 1D profile histograms in directory "RiTkDetectableYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkDetectableYieldsDownstream/Rich1Gas | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      55870 | 12552.     |    0.83251 |  0.0039786 |
@@ -3795,12 +3795,12 @@ RiTkDetectableYieldsLong               INFO 1D profile histograms in directory "
  | /RICH/RiTkDetectableYieldsLong/Rich2Gas/proto | "Rich2Gas proton Photon Yield (>0) V P (M..." |        191 |      56225 | 17957.     |    0.65519 |   -0.64935 |
 RiTkDetectableYieldsUpstream           INFO 1D profile histograms in directory "RiTkDetectableYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57592 | 15059.     |    0.57147 |   -0.96664 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9385.1 | 10796.     |      3.099 |     12.621 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25416 | 14797.     |     1.8105 |     3.5101 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11086 | 11690.     |     2.7559 |     9.9271 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12853 | 12335.     |     2.5321 |     8.3089 |
- | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37727 | 16072.     |     1.2347 |     1.0734 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/d | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57480 | 14896.     |    0.56535 |   -0.95196 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/e | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9382.9 | 10781.     |     3.0861 |     12.484 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/k | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25404 | 14755.     |     1.7972 |     3.4387 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/m | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11083 | 11673.     |     2.7435 |     9.8092 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12850 | 12316.     |     2.5197 |     8.2021 |
+ | /RICH/RiTkDetectableYieldsUpstream/Rich1Gas/p | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      37698 | 15994.     |     1.2206 |     1.0316 |
 RiTkEmittedYieldsDownstream            INFO 1D profile histograms in directory "RiTkEmittedYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkEmittedYieldsDownstream/Rich1Gas/de | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         58 |      55623 | 12604.     |    0.82814 |   0.018014 |
@@ -3831,12 +3831,12 @@ RiTkEmittedYieldsLong                  INFO 1D profile histograms in directory "
  | /RICH/RiTkEmittedYieldsLong/Rich2Gas/proton/y | "Rich2Gas proton Photon Yield (>0) V P (M..." |        203 |      55987 | 17991.     |    0.66274 |   -0.63619 |
 RiTkEmittedYieldsUpstream              INFO 1D profile histograms in directory "RiTkEmittedYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57299 | 15092.     |    0.58629 |   -0.94174 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9385.1 | 10796.     |      3.099 |     12.621 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25313 | 14781.     |     1.8154 |     3.5377 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11054 | 11676.     |     2.7609 |     9.9644 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12794 | 12317.     |     2.5382 |     8.3523 |
- | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37546 | 16067.     |     1.2412 |     1.0962 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/deut | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57189 | 14930.     |    0.57994 |   -0.92794 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/elec | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9382.9 | 10781.     |     3.0861 |     12.484 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/kaon | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        142 |      25301 | 14739.     |     1.8021 |      3.466 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/muon | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11052 | 11659.     |     2.7485 |     9.8463 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/pion | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        410 |      12791 | 12298.     |     2.5258 |     8.2452 |
+ | /RICH/RiTkEmittedYieldsUpstream/Rich1Gas/prot | "Rich1Gas proton Photon Yield (>0) V P (M..." |         64 |      37516 | 15991.     |     1.2271 |      1.054 |
 RiTkSignalYieldsDownstream             INFO 1D profile histograms in directory "RiTkSignalYieldsDownstream" : 12
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RiTkSignalYieldsDownstream/Rich1Gas/deu | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         56 |      56048 | 12530.     |    0.82906 |  0.0061687 |
@@ -3867,12 +3867,12 @@ RiTkSignalYieldsLong                   INFO 1D profile histograms in directory "
  | /RICH/RiTkSignalYieldsLong/Rich2Gas/proton/yi | "Rich2Gas proton Photon Yield (>0) V P (M..." |        191 |      56294 | 18033.     |    0.65595 |   -0.64581 |
 RiTkSignalYieldsUpstream               INFO 1D profile histograms in directory "RiTkSignalYieldsUpstream" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57232 | 14841.     |    0.61524 |   -0.87852 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9487.2 | 10958.     |      3.103 |     12.571 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25598 | 14985.     |     1.8048 |     3.4414 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11186 | 11863.     |     2.7602 |     9.8815 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12951 | 12514.     |     2.5379 |     8.2713 |
- | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38105 | 16478.     |     1.2063 |    0.91731 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/deute | "Rich1Gas deuteron Photon Yield (>0) V P ..." |         18 |      57122 | 14676.     |    0.60816 |   -0.86477 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/elect | "Rich1Gas electron Photon Yield (>0) V P ..." |        439 |     9484.9 | 10942.     |     3.0901 |     12.435 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/kaon/ | "Rich1Gas kaon Photon Yield (>0) V P (MeV..." |        136 |      25585 | 14941.     |     1.7917 |     3.3722 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/muon/ | "Rich1Gas muon Photon Yield (>0) V P (MeV..." |        439 |      11183 | 11846.     |     2.7476 |     9.7642 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/pion/ | "Rich1Gas pion Photon Yield (>0) V P (MeV..." |        400 |      12947 | 12494.     |     2.5255 |     8.1658 |
+ | /RICH/RiTkSignalYieldsUpstream/Rich1Gas/proto | "Rich1Gas proton Photon Yield (>0) V P (M..." |         61 |      38072 | 16396.     |     1.1928 |     0.8799 |
 RichMassRingsDownstream                INFO 1D profile histograms in directory "RichMassRingsDownstream" : 16
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | /RICH/RichMassRingsDownstream/Rich1Gas/deuter | "Rich1Gas deuteron Ring - Segment local p..." |       3264 |  6.638e+12 | 0.0000     |          0 |          0 |
@@ -3911,12 +3911,12 @@ RichMassRingsLong                      INFO 1D profile histograms in directory "
  | /RICH/RichMassRingsLong/Rich2Gas/sepVckt      | "Rich2Gas Local Seperation V CK Theta"        |       7124 |   0.027908 | 0.0028641  |    -2.3611 |     7.1745 |
 RichMassRingsUpstream                  INFO 1D profile histograms in directory "RichMassRingsUpstream" : 8
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1584 | 2.0121e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      41240 |-3.6982e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10352 | 2.5766e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      35776 | -6.848e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      30592 | 1.7358e+13 | 0.0000     |          0 |          0 |
- | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4584 | 1.8492e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/deuteron | "Rich1Gas deuteron Ring - Segment local p..." |       1584 | 4.6715e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/electron | "Rich1Gas electron Ring - Segment local p..." |      41240 |-2.7862e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/kaon/pnt | "Rich1Gas kaon Ring - Segment local point..." |      10352 | 4.8344e+12 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/muon/pnt | "Rich1Gas muon Ring - Segment local point..." |      35776 |-1.3287e+14 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/pion/pnt | "Rich1Gas pion Ring - Segment local point..." |      30592 |  1.265e+13 | 0.0000     |          0 |          0 |
+ | /RICH/RichMassRingsUpstream/Rich1Gas/proton/p | "Rich1Gas proton Ring - Segment local poi..." |       4584 | 9.6793e+12 | 0.0000     |          0 |          0 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/ringReus | "Rich1Gas Ring Reuse (%) V Mass Hypothesi..." |       1529 |     1.1472 | 1.0174     |    0.81734 |    0.88904 |
  | /RICH/RichMassRingsUpstream/Rich1Gas/sepVckt  | "Rich1Gas Local Seperation V CK Theta"        |       1504 |   0.047469 | 0.0072252  |    -2.0236 |     4.1283 |
 RichPIDMonDownstream10to70             INFO 1D profile histograms in directory "RichPIDMonDownstream10to70" : 10
@@ -4108,17 +4108,17 @@ TrackFitMatchMonitor                   INFO 1D profile histograms in directory "
  | Velo-UT/dtx pull vs qop                       | "Velo-UT dtx pull vs qop"                     |       2368 | 0.00013611 | 0.10933    |  0.0035537 |    -1.3285 |
  | Velo-UT/dtx pull vs tx                        | "Velo-UT dtx pull vs tx"                      |       4173 |  0.0021167 | 0.056988   |   -0.12929 |     2.1222 |
  | Velo-UT/dtx pull vs ty                        | "Velo-UT dtx pull vs ty"                      |       4226 | 0.00056233 | 0.062360   |    0.10365 |     2.2715 |
- | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2368 | -0.0017643 | 0.12972    |   0.070815 |    -1.6137 |
- | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 | 0.00053289 | 0.070946   |   -0.24684 |     1.1293 |
+ | Velo-UT/dtx vs qop                            | "Velo-UT dtx vs qop"                          |       2368 | -0.0017644 | 0.12972    |   0.070815 |    -1.6137 |
+ | Velo-UT/dtx vs tx                             | "Velo-UT dtx vs tx"                           |       4173 |  0.0005329 | 0.070946   |   -0.24684 |     1.1293 |
  | Velo-UT/dtx vs ty                             | "Velo-UT dtx vs ty"                           |       4226 |-0.00015757 | 0.077512   |    0.11725 |     1.0672 |
- | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2675 |    0.20965 | 0.0000     |          0 |          0 |
+ | Velo-UT/dty vs qop                            | "Velo-UT dty vs qop"                          |       2675 |    0.20964 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs tx                             | "Velo-UT dty vs tx"                           |       4474 |    0.52325 | 0.0000     |          0 |          0 |
  | Velo-UT/dty vs ty                             | "Velo-UT dty vs ty"                           |       4528 |   -0.34309 | 0.0000     |          0 |          0 |
- | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2360 | 0.00044398 | 0.10879    | -0.0055543 |    -1.3185 |
+ | Velo-UT/dx pull vs qop                        | "Velo-UT dx pull vs qop"                      |       2360 | 0.00044397 | 0.10879    | -0.0055542 |    -1.3185 |
  | Velo-UT/dx pull vs tx                         | "Velo-UT dx pull vs tx"                       |       4165 |  0.0020044 | 0.056490   |   -0.14322 |     2.2213 |
  | Velo-UT/dx pull vs ty                         | "Velo-UT dx pull vs ty"                       |       4218 | 0.00051331 | 0.061662   |   0.099909 |     2.3697 |
- | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2360 | 0.00053567 | 0.12367    |-4.0883e-05 |    -1.5271 |
- | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-5.7996e-05 | 0.074143   |   -0.13656 |     1.0029 |
+ | Velo-UT/dx vs qop                             | "Velo-UT dx vs qop"                           |       2360 | 0.00053566 | 0.12367    |-4.0623e-05 |    -1.5271 |
+ | Velo-UT/dx vs tx                              | "Velo-UT dx vs tx"                            |       4165 |-5.7988e-05 | 0.074143   |   -0.13656 |     1.0029 |
  | Velo-UT/dx vs ty                              | "Velo-UT dx vs ty"                            |       4218 | -0.0031729 | 0.079738   |   0.093293 |     1.2161 |
  | Velo-UT/dy pull vs tx                         | "Velo-UT dy pull vs tx"                       |       4468 | -0.0013359 | 0.053363   |  -0.077547 |     1.6824 |
  | Velo-UT/dy pull vs ty                         | "Velo-UT dy pull vs ty"                       |       4522 |   0.008204 | 0.057753   |    0.40659 |     1.7528 |
@@ -4157,7 +4157,7 @@ TrackMonitor                           INFO 1D profile histograms in directory "
  | Upstream/chi2ProbVeloVsMom                    | "chi2 prob for velo segment versus momentum"  |        478 |      10222 | 12072.     |     2.6263 |     7.8506 |
  | Upstream/chi2ProbVeloVsPhi                    | "chi2 prob for velo segment versus phi"       |        485 |  -0.026527 | 1.8155     |   0.011539 |    -1.0686 |
  | Upstream/chi2ProbVsEta                        | "chi2 prob versus eta"                        |        447 |     2.6555 | 0.52839    |     1.1641 |     1.0744 |
- | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        478 |     5538.1 | 5651.6     |      6.587 |     62.604 |
+ | Upstream/chi2ProbVsMom                        | "chi2 prob versus momentum"                   |        478 |     5538.1 | 5651.6     |     6.5871 |     62.604 |
  | Upstream/chi2ProbVsPhi                        | "chi2 prob versus phi"                        |        485 |  -0.034411 | 1.8203     |   -0.02182 |    -1.0059 |
  | Velo/chi2ProbVeloVsMom                        | "chi2 prob for velo segment versus momentum"  |       6087 |       8191 | 11849.     |     1.7765 |     2.1149 |
  | Velo/chi2ProbVeloVsPhi                        | "chi2 prob for velo segment versus phi"       |       6088 |   -0.10956 | 1.8060     |   0.028603 |    -1.1609 |
@@ -4176,7 +4176,7 @@ TrackPV2HalfMonitor                    INFO 1D profile histograms in directory "
  | PV left-right delta z versus z                | "PV left-right delta z versus z"              |          2 |     60.019 | 17.332     |     1.1517 |   -0.67357 |
 TrackVPOverlapMonitor                  INFO 1D profile histograms in directory "TrackVPOverlapMonitor" : 2
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1022 |     302.85 | 213.99     |  -0.076584 |   -0.68694 |
+ | breakpoint delta-x vs z                       | "breakpoint delta-x vs z"                     |       1022 |     302.85 | 213.99     |  -0.076585 |   -0.68694 |
  | breakpoint delta-y vs z                       | "breakpoint delta-y vs z"                     |       1022 |     159.21 | 65.355     |    -14.832 |     11.929 |
 TrackVertexMonitor                     INFO 1D profile histograms in directory "TrackVertexMonitor" : 28
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
-- 
GitLab


From e304f7cf24762bbd106682aa2fa074539bff1555 Mon Sep 17 00:00:00 2001
From: RefBot <lhcbsoft@cern.ch>
Date: Wed, 12 Feb 2025 10:02:06 +0100
Subject: [PATCH 26/31] Update References for: Moore!4331 based on
 lhcb-master-mr/12555

[skip ci]
---
 .../tests/refs/legacy_rec_hlt1_reco_velo_only.ref      | 10 +++++-----
 .../refs/legacy_rec_hlt1_reco_velo_only.ref.armv8.1_a  | 10 +++++-----
 .../refs/legacy_rec_hlt1_reco_velo_only.ref.detdesc    | 10 +++++-----
 ...y_rec_hlt1_reco_velo_only.ref.x86_64_v3-detdesc-opt | 10 +++++-----
 .../legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-opt   | 10 +++++-----
 5 files changed, 25 insertions(+), 25 deletions(-)

diff --git a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref
index 00b82757635..bf55f2990c7 100644
--- a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref
+++ b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref
@@ -3,15 +3,15 @@ ApplicationMgr                         INFO Application Manager Terminated succe
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |      1000 |
- | "Nb events removed"                             |       129 |
+ | "Nb events removed"                             |       127 |
 HLTControlFlowMgr                      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Processed events"                              |      1000 |
 MDFIOAlg                               INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#banks in raw event"                           |      1000 |     809193 |     809.19 |    0.99587 |      808.00 |      816.00 |
- | "event size statistics (KBytes)"                |      1017 |     200013 |     196.67 |     90.955 |      30.000 |      805.00 |
+ | "#banks in raw event"                           |      1000 |     809160 |     809.16 |    0.94255 |      808.00 |      813.00 |
+ | "event size statistics (KBytes)"                |      1011 |     196171 |     194.04 |     87.822 |      28.000 |      571.00 |
 VeloClusterTrackingSIMD_9d6e67b1       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Clusters"                       |       871 |    1643658 |     1887.1 |
- | "Nb of Produced Tracks"                         |       871 |     183787 |     211.01 |
+ | "Nb of Produced Clusters"                       |       873 |    1621649 |     1857.6 |
+ | "Nb of Produced Tracks"                         |       873 |     180322 |     206.55 |
diff --git a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.armv8.1_a b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.armv8.1_a
index 3fa2157c887..6d30b25465f 100644
--- a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.armv8.1_a
+++ b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.armv8.1_a
@@ -3,15 +3,15 @@ ApplicationMgr                         INFO Application Manager Terminated succe
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |      1000 |
- | "Nb events removed"                             |       129 |
+ | "Nb events removed"                             |       127 |
 HLTControlFlowMgr                      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Processed events"                              |      1000 |
 MDFIOAlg                               INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#banks in raw event"                           |      1000 |     809193 |     809.19 |    0.99587 |      808.00 |      816.00 |
- | "event size statistics (KBytes)"                |      1017 |     200013 |     196.67 |     90.955 |      30.000 |      805.00 |
+ | "#banks in raw event"                           |      1000 |     809160 |     809.16 |    0.94255 |      808.00 |      813.00 |
+ | "event size statistics (KBytes)"                |      1011 |     196171 |     194.04 |     87.822 |      28.000 |      571.00 |
 VeloClusterTrackingSIMD_9d6e67b1       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Clusters"                       |       871 |    1643658 |     1887.1 |
- | "Nb of Produced Tracks"                         |       871 |     183779 |     211.00 |
+ | "Nb of Produced Clusters"                       |       873 |    1621649 |     1857.6 |
+ | "Nb of Produced Tracks"                         |       873 |     180320 |     206.55 |
diff --git a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.detdesc b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.detdesc
index 49ffb6fc94c..0f018cdcb6e 100644
--- a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.detdesc
@@ -3,15 +3,15 @@ ApplicationMgr                         INFO Application Manager Terminated succe
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |      1000 |
- | "Nb events removed"                             |       129 |
+ | "Nb events removed"                             |       127 |
 HLTControlFlowMgr                      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Processed events"                              |      1000 |
 MDFIOAlg                               INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#banks in raw event"                           |      1000 |     809193 |     809.19 |    0.99587 |      808.00 |      816.00 |
- | "event size statistics (KBytes)"                |      1017 |     200013 |     196.67 |     90.955 |      30.000 |      805.00 |
+ | "#banks in raw event"                           |      1000 |     809160 |     809.16 |    0.94255 |      808.00 |      813.00 |
+ | "event size statistics (KBytes)"                |      1011 |     196171 |     194.04 |     87.822 |      28.000 |      571.00 |
 VeloClusterTrackingSIMD_9d6e67b1       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Clusters"                       |       871 |    1643658 |     1887.1 |
- | "Nb of Produced Tracks"                         |       871 |     183149 |     210.27 |
+ | "Nb of Produced Clusters"                       |       873 |    1621649 |     1857.6 |
+ | "Nb of Produced Tracks"                         |       873 |     179632 |     205.76 |
diff --git a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-detdesc-opt b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-detdesc-opt
index 18a38049bc4..a71480b0078 100644
--- a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-detdesc-opt
@@ -3,15 +3,15 @@ ApplicationMgr                         INFO Application Manager Terminated succe
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |      1000 |
- | "Nb events removed"                             |       129 |
+ | "Nb events removed"                             |       127 |
 HLTControlFlowMgr                      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Processed events"                              |      1000 |
 MDFIOAlg                               INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#banks in raw event"                           |      1000 |     809193 |     809.19 |    0.99587 |      808.00 |      816.00 |
- | "event size statistics (KBytes)"                |      1017 |     200013 |     196.67 |     90.955 |      30.000 |      805.00 |
+ | "#banks in raw event"                           |      1000 |     809160 |     809.16 |    0.94255 |      808.00 |      813.00 |
+ | "event size statistics (KBytes)"                |      1011 |     196171 |     194.04 |     87.822 |      28.000 |      571.00 |
 VeloClusterTrackingSIMD_9d6e67b1       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Clusters"                       |       871 |    1643658 |     1887.1 |
- | "Nb of Produced Tracks"                         |       871 |     183607 |     210.80 |
+ | "Nb of Produced Clusters"                       |       873 |    1621649 |     1857.6 |
+ | "Nb of Produced Tracks"                         |       873 |     180202 |     206.42 |
diff --git a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-opt b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-opt
index 8209cf79c64..1db8fe10ed7 100644
--- a/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-opt
+++ b/Hlt/RecoConf/tests/refs/legacy_rec_hlt1_reco_velo_only.ref.x86_64_v3-opt
@@ -3,15 +3,15 @@ ApplicationMgr                         INFO Application Manager Terminated succe
 DefaultGECFilter                       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Nb Events Processed"                           |      1000 |
- | "Nb events removed"                             |       129 |
+ | "Nb events removed"                             |       127 |
 HLTControlFlowMgr                      INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "Processed events"                              |      1000 |
 MDFIOAlg                               INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "#banks in raw event"                           |      1000 |     809193 |     809.19 |    0.99587 |      808.00 |      816.00 |
- | "event size statistics (KBytes)"                |      1017 |     200013 |     196.67 |     90.955 |      30.000 |      805.00 |
+ | "#banks in raw event"                           |      1000 |     809160 |     809.16 |    0.94255 |      808.00 |      813.00 |
+ | "event size statistics (KBytes)"                |      1011 |     196171 |     194.04 |     87.822 |      28.000 |      571.00 |
 VeloClusterTrackingSIMD_9d6e67b1       INFO Number of counters : 2
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "Nb of Produced Clusters"                       |       871 |    1643658 |     1887.1 |
- | "Nb of Produced Tracks"                         |       871 |     184312 |     211.61 |
+ | "Nb of Produced Clusters"                       |       873 |    1621649 |     1857.6 |
+ | "Nb of Produced Tracks"                         |       873 |     180808 |     207.11 |
-- 
GitLab


From 3817e2bc6a22d6014d47de4b4a496595ff4eaacd Mon Sep 17 00:00:00 2001
From: Luke Grazette <l.grazette@warwick.ac.uk>
Date: Wed, 12 Feb 2025 10:09:59 +0000
Subject: [PATCH 27/31] [QEE] Collection MR for further line optimisations 2025

---
 .../python/Hlt2Conf/lines/qee/dimuon_no_ip.py |  6 +-
 .../python/Hlt2Conf/lines/qee/drellyan.py     | 16 ++---
 .../Hlt2Conf/lines/qee/high_mass_dielec.py    | 20 +++++--
 .../Hlt2Conf/lines/qee/high_mass_dimuon.py    | 41 ++++++++-----
 .../python/Hlt2Conf/lines/qee/jets.py         |  8 +--
 .../python/Hlt2Conf/lines/qee/qee_builders.py |  6 +-
 .../Hlt2Conf/lines/qee/single_high_pt_muon.py | 55 +++++++-----------
 .../python/Hlt2Conf/lines/qee/spruce_qee.py   | 58 +++++++++----------
 .../lines/qee/spruce_qee_pp_ref_2024.py       |  5 +-
 9 files changed, 111 insertions(+), 104 deletions(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/dimuon_no_ip.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/dimuon_no_ip.py
index affe62a461f..1d24b5fbdef 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/dimuon_no_ip.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/dimuon_no_ip.py
@@ -49,7 +49,7 @@ def make_dimuons(
     vchi2pdof_max=9,
     min_pt_prod=1 * GeV * GeV,
     min_ipchi2=0,
-    min_mass=0,
+    min_mass=2 * F.PDG_MASS("mu+"),
     max_mass=110 * GeV,
     opposite_sign=True,
     pid_mu=-10,
@@ -152,7 +152,7 @@ def dimuonnoip_massrange6_line(name="Hlt2QEE_DiMuonNoIP_massRange6", prescale=1)
 @register_line_builder(turbo_lines)
 def displaceddimuon_line(name="Hlt2QEE_DisplacedDiMuon", prescale=1):
     pvs = make_pvs()
-    dimuonnoip = make_dimuons(pvs, min_ipchi2=16, ownpvvdchi2_min=30, pid_mu=None)
+    dimuonnoip = make_dimuons(pvs, min_ipchi2=16, ownpvvdchi2_min=30)
     return Hlt2Line(
         name=name,
         algs=upfront_reconstruction() + [require_pvs(pvs), dimuonnoip],
@@ -270,7 +270,7 @@ def dimuonnoip_massrange6_ss_line(
 def displaceddimuon_ss_line(name="Hlt2QEE_DisplacedDiMuon_ss", prescale=0.1):
     pvs = make_pvs()
     dimuonnoip = make_dimuons(
-        pvs, min_ipchi2=16, ownpvvdchi2_min=30, opposite_sign=False, pid_mu=None
+        pvs, min_ipchi2=16, ownpvvdchi2_min=30, opposite_sign=False
     )
     return Hlt2Line(
         name=name,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/drellyan.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/drellyan.py
index f22fd9ff8a8..dff1de5bdf7 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/drellyan.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/drellyan.py
@@ -27,6 +27,7 @@ from Functors.math import in_range
 from GaudiKernel.SystemOfUnits import GeV, mm
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
+from Moore.streams import DETECTORS
 from PyConf import configurable
 from RecoConf.algorithms_thor import ParticleCombiner, ParticleFilter
 from RecoConf.event_filters import require_pvs
@@ -42,14 +43,13 @@ mass_ranges = [
     [10.0 * GeV, 400 * GeV, "Nominal", 1.0, True, False],
 ]
 # fourth argument: prescale
-# fifth argument: persist reco on/off
+# fifth argument: underlying event on/off
 # sixth argument: use softer muons
 
 
 @configurable
 def filter_muons(
     particles,
-    pvs,
     min_ip,
     max_ip,
     min_pidmu,
@@ -63,7 +63,7 @@ def filter_muons(
         F.PT >= min_pt,
         F.P >= min_p,
         F.PID_MU >= min_pidmu,
-        in_range(min_ip, F.MINIP(pvs), max_ip),
+        in_range(min_ip, F.OWNPVIP, max_ip),
     )
 
     return ParticleFilter(particles, F.FILTER(muon_requirements))
@@ -72,7 +72,6 @@ def filter_muons(
 @configurable
 def combine_muons_for_decay_descriptor(
     decay_descriptor,
-    pvs,
     name,
     min_mass,
     max_mass,
@@ -88,7 +87,6 @@ def combine_muons_for_decay_descriptor(
 
     filtered_muons = filter_muons(
         all_muons,
-        pvs,
         min_pidmu=min_pidmu,
         min_p=min_muon_p,
         min_pt=min_muon_pt,
@@ -158,7 +156,7 @@ for is_ss in [True, False]:
                 min_ip=min_ip,
                 is_ss=is_ss,
                 prescale=prescale,
-                persist_reco=mass_range[4],
+                save_underlying_event=mass_range[4],
                 min_pidmu=min_pidmu,
             ):
                 pvs = make_pvs()
@@ -173,7 +171,6 @@ for is_ss in [True, False]:
                 dimuons = make_dimuon_candidates(
                     is_ss,
                     name + "_combiner",
-                    pvs=pvs,
                     min_mass=min_mass,
                     max_mass=max_mass,
                     max_ip=max_ip,
@@ -183,9 +180,12 @@ for is_ss in [True, False]:
                     min_muon_pt=muon_min_pt,
                 )
 
+                detectors_to_save = DETECTORS if save_underlying_event else []
+
                 return Hlt2Line(
                     name=name,
                     algs=upfront_reconstruction() + [require_pvs(pvs), dimuons],
-                    persistreco=persist_reco,
+                    raw_banks=detectors_to_save,
+                    persistreco=False,
                     prescale=prescale,
                 )
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dielec.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dielec.py
index 7632fb37dae..74d619db25d 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dielec.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dielec.py
@@ -27,6 +27,7 @@ from Hlt2Conf.lines.qee.qee_monitors import qee_monitors1d
 all_lines = {}
 
 _default_monitoring_variables = ("pt", "eta", "n_candidates")
+z_min_combination_mass, z_min_composite_mass = 30.0 * GeV, 40.0 * GeV
 
 
 @configurable
@@ -39,29 +40,36 @@ def elec_filter_for_Z(particles, min_pt=0.0 * GeV):
 @configurable
 def make_Zee_cand():
     elecs = elec_filter_for_Z(make_long_electrons_with_brem(), min_pt=10.0 * GeV)
-    line_alg = make_dielec_novxt(elecs, "Z0 -> e+ e-", 40.0 * GeV)
+    line_alg = make_dielec_novxt(elecs, "Z0 -> e+ e-")
     return line_alg
 
 
 @configurable
 def make_Zeess_cand():
     elecs = elec_filter_for_Z(make_long_electrons_with_brem(), min_pt=10.0 * GeV)
-    line_alg = make_dielec_novxt(elecs, "[Z0 -> e- e-]cc", 40.0 * GeV)
+    line_alg = make_dielec_novxt(elecs, "[Z0 -> e- e-]cc")
     return line_alg
 
 
 @configurable
-def make_dielec_novxt(input_elecs, decaydescriptor, min_mass=40.0 * GeV):
+def make_dielec_novxt(
+    input_elecs,
+    decaydescriptor,
+    min_combination_mass=z_min_combination_mass,
+    min_composite_mass=z_min_composite_mass,
+):
     """DiElec without any requirements but mass"""
 
-    # mass region of dielecs
-    combination_code = F.MASS > min_mass
+    # pre-vertex fit, useful for controlling the combinatorics
+    combination_code = F.MASS > min_combination_mass
+    # post-vertex fit
+    composite_code = F.MASS > min_composite_mass
 
     return ParticleCombiner(
         [input_elecs, input_elecs],
         DecayDescriptor=decaydescriptor,
         CombinationCut=combination_code,
-        CompositeCut=F.ALL,
+        CompositeCut=composite_code,
     )
 
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dimuon.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dimuon.py
index 12cda22e041..d93ccf6d90d 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dimuon.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/high_mass_dimuon.py
@@ -31,6 +31,9 @@ from Hlt2Conf.lines.qee.qee_monitors import (
 all_lines = {}
 
 _default_monitoring_variables = ("pt", "eta", "n_candidates")
+z_min_combination_mass, z_min_composite_mass = 30.0 * GeV, 40.0 * GeV
+zss_min_combination_mass = 16.0 * GeV
+zss_min_composite_mass = zss_min_combination_mass
 
 
 @configurable
@@ -42,43 +45,55 @@ def muon_filter_for_Z(particles, min_pt=0.0 * GeV):
 @configurable
 def make_Z_cand():
     muons_for_Z = muon_filter_for_Z(make_ismuon_long_muon(), min_pt=3.0 * GeV)
-    return make_dimuon_novxt(muons_for_Z, muons_for_Z, "Z0 -> mu+ mu-", 40 * GeV)
+    return make_dimuon_novxt(muons_for_Z, muons_for_Z, "Z0 -> mu+ mu-")
 
 
 @configurable
 def make_Z_cand_SingleNoMuID():
     muon_ID, muon_noID = make_ismuon_long_muon(), make_long_muons()
-    muons_for_Z_ID = muon_filter_for_Z(muon_ID, min_pt=3.0 * GeV)
-    muons_for_Z_noID = muon_filter_for_Z(muon_noID, min_pt=3.0 * GeV)
-    return make_dimuon_novxt(
-        muons_for_Z_ID, muons_for_Z_noID, "[Z0 -> mu+ mu-]cc", 40 * GeV
-    )
+    muons_for_Z_ID = muon_filter_for_Z(muon_ID, min_pt=10.0 * GeV)
+    muons_for_Z_noID = muon_filter_for_Z(muon_noID, min_pt=10.0 * GeV)
+    return make_dimuon_novxt(muons_for_Z_ID, muons_for_Z_noID, "[Z0 -> mu+ mu-]cc")
 
 
 @configurable
 def make_Z_cand_DoubleNoMuID():
-    muons_for_Z = muon_filter_for_Z(make_long_muons(), min_pt=3.0 * GeV)
-    return make_dimuon_novxt(muons_for_Z, muons_for_Z, "Z0 -> mu+ mu-", 40 * GeV)
+    muons_for_Z = muon_filter_for_Z(make_long_muons(), min_pt=10.0 * GeV)
+    return make_dimuon_novxt(muons_for_Z, muons_for_Z, "Z0 -> mu+ mu-")
 
 
 @configurable
 def make_Zss_cand():
     muons = muon_filter_for_Z(make_ismuon_long_muon(), min_pt=3.0 * GeV)
-    return make_dimuon_novxt(muons, muons, "[Z0 -> mu- mu-]cc", 16.0 * GeV)
+    return make_dimuon_novxt(
+        muons,
+        muons,
+        "[Z0 -> mu- mu-]cc",
+        min_combination_mass=zss_min_combination_mass,
+        min_composite_mass=zss_min_composite_mass,
+    )
 
 
 @configurable
-def make_dimuon_novxt(input_muon1, input_muon2, decaydescriptor, min_mass=40.0 * GeV):
+def make_dimuon_novxt(
+    input_muon1,
+    input_muon2,
+    decaydescriptor,
+    min_combination_mass=z_min_combination_mass,
+    min_composite_mass=z_min_composite_mass,
+):
     """Dimuon combination with only a mass cut"""
 
-    # mass region of dimuons
-    combination_code = F.MASS > min_mass
+    # pre-vertex fit, useful for controlling the combinatorics
+    combination_code = F.MASS > min_combination_mass
+    # post-vertex fit
+    composite_code = F.MASS > min_composite_mass
 
     return ParticleCombiner(
         [input_muon1, input_muon2],
         DecayDescriptor=decaydescriptor,
         CombinationCut=combination_code,
-        CompositeCut=F.ALL,
+        CompositeCut=composite_code,
     )
 
 
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/jets.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/jets.py
index c4ad95d33c8..d63b238c2d9 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/jets.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/jets.py
@@ -224,7 +224,7 @@ def IncJet45GeV_line(name="Hlt2QEE_IncJet45GeVFull", prescale=1.0):
 
 @register_line_builder(all_lines)
 @configurable
-def IncDiJet15GeV_line(name="Hlt2QEE_IncDiJet15GeVFull", prescale=0.1):
+def IncDiJet15GeV_line(name="Hlt2QEE_IncDiJet15GeVFull", prescale=0.5):
     return _dijet_line_template(
         name=name, prescale=prescale, prod_pt_min=15 * GeV, hlt1_filter=True
     )
@@ -232,7 +232,7 @@ def IncDiJet15GeV_line(name="Hlt2QEE_IncDiJet15GeVFull", prescale=0.1):
 
 @register_line_builder(all_lines)
 @configurable
-def IncDiJet20GeV_line(name="Hlt2QEE_IncDiJet20GeVFull", prescale=0.25):
+def IncDiJet20GeV_line(name="Hlt2QEE_IncDiJet20GeVFull", prescale=1.0):
     return _dijet_line_template(
         name=name, prescale=prescale, prod_pt_min=20 * GeV, hlt1_filter=True
     )
@@ -240,7 +240,7 @@ def IncDiJet20GeV_line(name="Hlt2QEE_IncDiJet20GeVFull", prescale=0.25):
 
 @register_line_builder(all_lines)
 @configurable
-def IncDiJet25GeV_line(name="Hlt2QEE_IncDiJet25GeVFull", prescale=0.5):
+def IncDiJet25GeV_line(name="Hlt2QEE_IncDiJet25GeVFull", prescale=1.0):
     return _dijet_line_template(
         name=name, prescale=prescale, prod_pt_min=25 * GeV, hlt1_filter=True
     )
@@ -248,7 +248,7 @@ def IncDiJet25GeV_line(name="Hlt2QEE_IncDiJet25GeVFull", prescale=0.5):
 
 @register_line_builder(all_lines)
 @configurable
-def IncDiJet30GeV_line(name="Hlt2QEE_IncDiJet30GeVFull", prescale=0.75):
+def IncDiJet30GeV_line(name="Hlt2QEE_IncDiJet30GeVFull", prescale=1.0):
     return _dijet_line_template(
         name=name, prescale=prescale, prod_pt_min=30 * GeV, hlt1_filter=True
     )
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/qee_builders.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/qee_builders.py
index 747a3c6703a..42d3a0be941 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/qee_builders.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/qee_builders.py
@@ -214,14 +214,16 @@ def Z_To_lepts_filter(lepton_type="mu", min_pt=10.0 * GeV):
             input_muon1=muons_for_Z,
             input_muon2=muons_for_Z,
             decaydescriptor="Z0 -> mu+ mu-",
-            min_mass=40 * GeV,
+            min_combination_mass=30.0 * GeV,
+            min_composite_mass=40.0 * GeV,
         )
     else:
         electrons_for_Z = elec_filter(min_pt=min_pt)
         zcand = make_dielec_novxt(
             input_elecs=electrons_for_Z,
             decaydescriptor="Z0 -> e+ e-",
-            min_mass=40.0 * GeV,
+            min_combination_mass=30.0 * GeV,
+            min_composite_mass=40.0 * GeV,
         )
 
     return zcand
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/single_high_pt_muon.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/single_high_pt_muon.py
index 850ec749bb5..8cc398e8ff5 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/single_high_pt_muon.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/single_high_pt_muon.py
@@ -13,7 +13,6 @@ Definition of the HLT2 single high-PT muon lines.
 """
 
 import Functors as F
-from Functors.math import in_range
 from GaudiKernel.SystemOfUnits import GeV
 from Moore.config import register_line_builder
 from Moore.lines import Hlt2Line
@@ -21,8 +20,9 @@ from PyConf import configurable
 from PyConf.Algorithms import WeightedRelTableAlg
 from RecoConf.algorithms_thor import ParticleFilter
 from RecoConf.reconstruction_objects import upfront_reconstruction
-from RecoConf.standard_particles import make_ismuon_long_muon, make_long_muons
+from RecoConf.standard_particles import make_long_pions
 
+from Hlt2Conf.lines.qee.qee_builders import muon_filter
 from Hlt2Conf.standard_jets import make_onlytrack_particleflow
 
 all_lines = {}
@@ -33,43 +33,36 @@ threshold_map = {
     "iso": 12.5 * GeV,
     "nomuid": 15.0 * GeV,
     "tight": 18.0 * GeV,
+    "vtight": 20.0 * GeV,
 }
 
-
-@configurable
-def make_highpt_muons(
-    name="HighPtMuonMaker_{hash}_{hash}",
-    muons=make_ismuon_long_muon,
-    min_muon_pt=threshold_map["standard"],
-):
-    code = F.require_all(F.PT > min_muon_pt)
-    return ParticleFilter(muons(), F.FILTER(code), name=name)
+hlt2_isolation_config = {
+    "max_cone_pt": 5.0 * GeV,
+    "cone_radius": 0.5,
+    "use_pflow": True,
+}
 
 
 @configurable
 def make_isolated_muons(
     high_pt_muons,
-    name="HighPtIsolatedMuonMaker_{hash}",
-    max_cone_pt=10.0 * GeV,
-    pflow_output=make_onlytrack_particleflow,
+    max_cone_pt: float,
+    cone_radius: float,
+    use_pflow: bool,
+    name: str = "HighPtIsolatedMuonMaker_{hash}",
 ):
+    cone_cands = make_onlytrack_particleflow if use_pflow else make_long_pions
     # ~F.SHARE_TRACKS removes the signal track from the cone by ensuring
     # it is not in InputCandidates
     ftAlg = WeightedRelTableAlg(
         ReferenceParticles=high_pt_muons,
-        InputCandidates=pflow_output(),
-        Cut=F.require_all((F.DR2 < (0.5**2)), ~F.SHARE_TRACKS()),
+        InputCandidates=cone_cands(),
+        Cut=F.require_all((F.DR2 < (cone_radius**2)), ~F.SHARE_TRACKS()),
     )
 
     ftAlg_Rels = ftAlg.OutputRelations
 
-    code = F.require_all(
-        in_range(
-            0,
-            F.VALUE_OR(0) @ F.SUMCONE(Functor=F.PT, Relations=ftAlg_Rels),
-            max_cone_pt,
-        )
-    )
+    code = (F.VALUE_OR(0) @ F.SUMCONE(Functor=F.PT, Relations=ftAlg_Rels)) < max_cone_pt
 
     return ParticleFilter(high_pt_muons, F.FILTER(code), name=name)
 
@@ -81,7 +74,7 @@ def single_muon_highpt_line(
 ):
     """High PT single muon line"""
 
-    high_pt_muons = make_highpt_muons(min_muon_pt=threshold_map["standard"])
+    high_pt_muons = muon_filter(min_pt=threshold_map["standard"], require_muID=True)
 
     return Hlt2Line(
         name=name,
@@ -99,7 +92,7 @@ def single_muon_highpt_prescale_line(
 ):
     """High PT single muon line with lower pT threshold, prescaled to reduce the rate."""
 
-    high_pt_muons = make_highpt_muons(min_muon_pt=threshold_map["prescale"])
+    high_pt_muons = muon_filter(min_pt=threshold_map["prescale"], require_muID=True)
 
     return Hlt2Line(
         name=name,
@@ -118,12 +111,8 @@ def single_muon_highpt_iso_line(
     """High PT single muon line with lower pT threshold, and isolation to keep the rate down.
     Make PT cut first to drastically reduce number of times isolation algorithm is called."""
 
-    high_pt_muons = make_highpt_muons(
-        min_muon_pt=threshold_map["iso"], name="HighPtMuonMakerForIso"
-    )
-    high_pt_isolated_muons = make_isolated_muons(
-        high_pt_muons, pflow_output=make_onlytrack_particleflow
-    )
+    high_pt_muons = muon_filter(min_pt=threshold_map["iso"], require_muID=True)
+    high_pt_isolated_muons = make_isolated_muons(high_pt_muons, **hlt2_isolation_config)
 
     return Hlt2Line(
         name=name,
@@ -142,8 +131,8 @@ def single_muon_highpt_nomuid_line(
     """High PT single muon line with No ISMUON requirement for background and MuonID efficiency studies
     . Prescale required to control the rate."""
 
-    high_pt_nomuid_muons = make_highpt_muons(
-        muons=make_long_muons, min_muon_pt=threshold_map["nomuid"]
+    high_pt_nomuid_muons = muon_filter(
+        min_pt=threshold_map["nomuid"], require_muID=False
     )
 
     return Hlt2Line(
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee.py
index cdd5f24e2e1..e79b229fc17 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee.py
@@ -633,18 +633,27 @@ for lepton_type, lepton_suffix in zip(["mu", "e"], ["Mu", "E"]):
 
 
 ################ Single muon lines ################
+sprucing_isolation_config = {
+    "max_cone_pt": 8.0 * GeV,
+    "cone_radius": 0.4,
+    "use_pflow": False,
+}
+
+
 @register_line_builder(sprucing_lines)
 @configurable
 def single_muon_highpt_sprucing_line(
     name="SpruceQEE_SingleHighPtMuon", persistreco=True, prescale=1
 ):
-    """High PT Single Muon line, slightly tighter pT cut on top of Hlt2QEE_SingleHighPtMuonFull"""
+    """High PT Single Muon line, slightly tighter pT cut and a loose isolation cut
+    on top of Hlt2QEE_SingleHighPtMuonFull"""
 
-    line_alg = muon_filter(min_pt=muon_thresholds["tight"])
+    muons = muon_filter(min_pt=muon_thresholds["tight"])
+    isolated_muons = make_isolated_muons(muons, **sprucing_isolation_config)
     return SpruceLine(
         name=name,
         persistreco=persistreco,
-        algs=upfront_reconstruction() + [line_alg],
+        algs=upfront_reconstruction() + [muons, isolated_muons],
         hlt2_filter_code=_hlt2_decision_regex(single_muon_highpt_line),
         prescale=prescale,
     )
@@ -652,49 +661,34 @@ def single_muon_highpt_sprucing_line(
 
 @register_line_builder(sprucing_lines)
 @configurable
-def single_muon_highpt_prescale_sprucing_line(
-    name="SpruceQEE_SingleHighPtMuonPrescale", persistreco=True, prescale=0.1
-):
-    """High PT single muon line with lower pT threshold, prescaled to reduce the rate, passthrough after Hlt2QEE_SingleHighPtMuonPrescaleFull"""
-
-    line_alg = muon_filter(min_pt=muon_thresholds["prescale"])
-    return SpruceLine(
-        name=name,
-        persistreco=persistreco,
-        algs=upfront_reconstruction() + [line_alg],
-        hlt2_filter_code=_hlt2_decision_regex(single_muon_highpt_prescale_line),
-        prescale=prescale,
-    )
-
-
-@register_line_builder(sprucing_lines)
-@configurable
-def single_muon_highpt_iso_sprucing_line(
-    name="SpruceQEE_SingleHighPtMuonIso", persistreco=True, prescale=0.01
+def single_muon_highpt_nomuid_sprucing_line(
+    name="SpruceQEE_SingleHighPtMuonNoMuID", persistreco=True, prescale=0.5
 ):
-    """High PT single muon line with lower pT threshold, using isolation variables to reduce the rate, passthrough after Hlt2QEE_SingleHighPtMuonIso"""
+    """High PT single muon line without ISMUON requirement, for background and MuonID efficiency studies.
+    Applies a slightly tighter pT threshold and a loose isolation cut on top of Hlt2QEE_SingleHighPtMuonNoMuIDFull"""
 
-    filtered_muons = muon_filter(min_pt=muon_thresholds["iso"])
-    line_alg = make_isolated_muons(
-        filtered_muons, pflow_output=make_onlytrack_particleflow
+    nomuid_muons = muon_filter(min_pt=muon_thresholds["tight"], require_muID=False)
+    isolated_nomuid_muons = make_isolated_muons(
+        nomuid_muons, **sprucing_isolation_config
     )
     return SpruceLine(
         name=name,
         persistreco=persistreco,
-        algs=upfront_reconstruction() + [line_alg],
-        hlt2_filter_code=_hlt2_decision_regex(single_muon_highpt_iso_line),
+        algs=upfront_reconstruction() + [nomuid_muons, isolated_nomuid_muons],
+        hlt2_filter_code=_hlt2_decision_regex(single_muon_highpt_nomuid_line),
         prescale=prescale,
     )
 
 
 @register_line_builder(sprucing_lines)
 @configurable
-def single_muon_highpt_nomuid_sprucing_line(
-    name="SpruceQEE_SingleHighPtMuonNoMuID", persistreco=True, prescale=0.5
+def single_muon_highpt_nomuid_noiso_sprucing_line(
+    name="SpruceQEE_SingleHighPtMuonNoMuIDNoIso", persistreco=True, prescale=0.1
 ):
-    """High PT single muon line without ISMUON requirement, for background and MuonID efficiency studies, passthrough after Hlt2QEE_SingleHighPtMuonNoMuIDFull"""
+    """High PT single muon line without ISMUON requirement for measuring inclusive
+    charged hadron pT spectrum"""
 
-    line_alg = muon_filter(min_pt=muon_thresholds["nomuid"], require_muID=False)
+    line_alg = muon_filter(min_pt=muon_thresholds["vtight"], require_muID=False)
     return SpruceLine(
         name=name,
         persistreco=persistreco,
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee_pp_ref_2024.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee_pp_ref_2024.py
index 0753b9c5a13..14dfe963536 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee_pp_ref_2024.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/qee/spruce_qee_pp_ref_2024.py
@@ -101,6 +101,7 @@ from Hlt2Conf.lines.qee.single_high_pt_electron import (
     pt_thresholds as elec_pt_thresholds,
 )
 from Hlt2Conf.lines.qee.single_high_pt_muon import (
+    hlt2_isolation_config,
     make_isolated_muons,
     single_muon_highpt_iso_line,
     single_muon_highpt_line,
@@ -701,9 +702,7 @@ def single_muon_highpt_iso_sprucing_line(
     """High PT single muon line with lower pT threshold, using isolation variables to reduce the rate, passthrough after Hlt2QEE_SingleHighPtMuonIso"""
 
     filtered_muons = muon_filter(min_pt=muon_thresholds["iso"])
-    line_alg = make_isolated_muons(
-        filtered_muons, pflow_output=make_onlytrack_particleflow
-    )
+    line_alg = make_isolated_muons(filtered_muons, **hlt2_isolation_config)
     return SpruceLine(
         name=name,
         persistreco=persistreco,
-- 
GitLab


From 4413ad53ffd7239b142fb2911d767bcbc82db6c4 Mon Sep 17 00:00:00 2001
From: RefBot <lhcbsoft@cern.ch>
Date: Thu, 13 Feb 2025 08:46:57 +0100
Subject: [PATCH 28/31] Update References for: LHCb!4913, Moore!4327,
 DaVinci!1230 based on lhcb-master-mr/12587

[skip ci]
---
 ..._persistreco_check_flavourtags.ref.detdesc |  1 +
 ...heck_flavourtags.ref.x86_64_v3-detdesc-opt |  1 +
 ...udi_downstream_with_mcchecking.ref.detdesc | 26 +++++++++----------
 3 files changed, 15 insertions(+), 13 deletions(-)

diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.detdesc b/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.detdesc
index bcbfae22396..ce99d837dd5 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.detdesc
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.detdesc
@@ -43,6 +43,7 @@
 |-phoenix_filename                        = ''  (default: '')
 |-preamble_algs                           = []  (default: [])
 |-print_freq                              = 10000  (default: 10000)
+|-process                                 = None
 |-python_logging_level                    = 20  (default: 20)
 |-require_specific_decoding_keys          = []  (default: [])
 |-root_ioalg_name                         = 'RootIOAlg'  (default: 'RootIOAlg')
diff --git a/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.x86_64_v3-detdesc-opt b/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.x86_64_v3-detdesc-opt
index bcbfae22396..ce99d837dd5 100644
--- a/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.x86_64_v3-detdesc-opt
+++ b/Hlt/Hlt2Conf/tests/refs/hlt2_persistreco_check_flavourtags.ref.x86_64_v3-detdesc-opt
@@ -43,6 +43,7 @@
 |-phoenix_filename                        = ''  (default: '')
 |-preamble_algs                           = []  (default: [])
 |-print_freq                              = 10000  (default: 10000)
+|-process                                 = None
 |-python_logging_level                    = 20  (default: 20)
 |-require_specific_decoding_keys          = []  (default: [])
 |-root_ioalg_name                         = 'RootIOAlg'  (default: 'RootIOAlg')
diff --git a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
index 10ce6a69d58..214f7696a59 100644
--- a/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
+++ b/Hlt/RecoConf/tests/refs/allen_gaudi_downstream_with_mcchecking.ref.detdesc
@@ -53,13 +53,13 @@ fromV3TrackV1Track_6f234e16            INFO Number of counters : 1
  | "Nb of Produced Tracks"                         |      1000 |       6810 |     6.8100 |
 matching_consolidate_tracks            INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_long_tracks_matching"                        |      1000 |      15370 |     15.370 |
+ | "n_long_tracks_matching"                        |      1000 |      15371 |     15.371 |
 pv_beamline_cleanup                    INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_PVs"                                         |      1000 |       5079 |     5.0790 |
 scifi_consolidate_seeds                INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
- | "n_seed_tracks"                                 |      1000 |      47151 |     47.151 |
+ | "n_seed_tracks"                                 |      1000 |      47152 |     47.152 |
 scifi_consolidate_tracks               INFO Number of counters : 1
  |    Counter                                      |     #     |    sum     | mean/eff^* | rms/err^*  |     min     |     max     |
  | "n_long_tracks_forward"                         |      1000 |      34078 |     34.078 |
@@ -100,12 +100,12 @@ is_muon_c92a16c2                       INFO 1D histograms in directory "is_muon_
  | pv_y                                          | "pv_y"                                        |        969 |     453.06 | 302.95     |     2.6228 |     22.408 |
 matching_consolidate_tracks            INFO 1D histograms in directory "matching_consolidate_tracks" : 6
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | long_track_ghost_prob                         | "GhostProb"                                   |      15370 |    0.14101 | 0.12232    |     1.1157 |    0.35583 |
- | long_track_matching_eta                       | "#eta"                                        |      15370 |     3.8775 | 0.71664    |   -0.56856 |   -0.26318 |
- | long_track_matching_nhits                     | "N. hits / track"                             |      15370 |     24.567 | 3.4253     |    0.07307 |   -0.70852 |
- | long_track_matching_phi                       | "#phi"                                        |      15370 |   0.020384 | 1.7904     |   -0.02653 |    -1.1887 |
- | long_track_matching_qop                       | "q/p"                                         |      15370 |-1.6461e-06 | 0.00018882 |   0.028602 |    -1.3855 |
- | n_long_tracks_matching_event                  | "n_long_tracks_matching_event"                |       1000 |      15.37 | 10.970     |     1.1678 |     1.5413 |
+ | long_track_ghost_prob                         | "GhostProb"                                   |      15371 |      0.141 | 0.12232    |     1.1158 |    0.35605 |
+ | long_track_matching_eta                       | "#eta"                                        |      15371 |     3.8774 | 0.71669    |   -0.56844 |   -0.26373 |
+ | long_track_matching_nhits                     | "N. hits / track"                             |      15371 |     24.567 | 3.4252     |   0.073154 |   -0.70842 |
+ | long_track_matching_phi                       | "#phi"                                        |      15371 |   0.020404 | 1.7904     |  -0.026563 |    -1.1886 |
+ | long_track_matching_qop                       | "q/p"                                         |      15371 |-1.6645e-06 | 0.00018882 |    0.02867 |    -1.3855 |
+ | n_long_tracks_matching_event                  | "n_long_tracks_matching_event"                |       1000 |     15.371 | 10.971     |     1.1676 |     1.5396 |
 pv_beamline_cleanup                    INFO 1D histograms in directory "pv_beamline_cleanup" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | n_pvs_event                                   | "n_pvs_event"                                 |       1000 |      5.079 | 2.1737     |    0.39579 |   -0.14695 |
@@ -115,11 +115,11 @@ pv_beamline_cleanup                    INFO 1D histograms in directory "pv_beaml
  | pv_z                                          | "pv_z"                                        |       5073 |    0.45689 | 59.520     |  -0.036897 |   -0.11128 |
 scifi_consolidate_seeds                INFO 1D histograms in directory "scifi_consolidate_seeds" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
- | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     47.151 | 32.621     |     1.5838 |     4.3015 |
- | scifi_track_eta                               | "#eta"                                        |      47151 |      2.536 | 0.67357    |    0.68904 |     0.3097 |
- | scifi_track_nhits                             | "N. hits / track"                             |      47151 |     11.315 | 0.77786    |   -0.61162 |    -1.0961 |
- | scifi_track_phi                               | "#phi"                                        |      47151 |    0.01184 | 2.0901     | -0.0074449 |   -0.98749 |
- | scifi_track_qop                               | "q/p"                                         |      47151 | 1.2315e-06 | 0.00017911 |  0.0016036 |    -1.1154 |
+ | n_scifi_seeds_event                           | "n_scifi_seeds_event"                         |       1000 |     47.152 | 32.622     |     1.5837 |     4.3011 |
+ | scifi_track_eta                               | "#eta"                                        |      47152 |      2.536 | 0.67358    |    0.68897 |    0.30964 |
+ | scifi_track_nhits                             | "N. hits / track"                             |      47152 |     11.315 | 0.77787    |   -0.61157 |    -1.0962 |
+ | scifi_track_phi                               | "#phi"                                        |      47152 |   0.011841 | 2.0901     | -0.0074469 |   -0.98744 |
+ | scifi_track_qop                               | "q/p"                                         |      47152 | 1.2254e-06 | 0.00017911 |  0.0016186 |    -1.1154 |
 scifi_consolidate_tracks               INFO 1D histograms in directory "scifi_consolidate_tracks" : 5
  | ID                                            | Title                                         |      #     |     Mean   |    RMS     |  Skewness  |  Kurtosis  |
  | long_track_forward_eta                        | "#eta"                                        |      34078 |     4.3558 | 0.55018    |  -0.050691 |   -0.35983 |
-- 
GitLab


From 574decffef50d6b0da9fc0c3b1d59ecd7ffdcf16 Mon Sep 17 00:00:00 2001
From: Nicole Skidmore <nicola.skidmore@cern.ch>
Date: Thu, 13 Feb 2025 07:56:48 +0000
Subject: [PATCH 29/31] Overlap improvements

---
 Hlt/Hlt2Conf/CMakeLists.txt                   |  13 ---
 .../sprucing/lbexec_yamls/spruce_overlap.yaml |   3 +-
 .../python/Hlt2Conf/Sprucing_tests.py         |  41 ++++---
 .../Sprucing_production_pp.py                 |  15 ++-
 .../Hlt2Conf/test_streaming_config.json       |   1 +
 .../spruce_bandwidth_turbo_streams.py         |   9 +-
 .../spruce_turbopass_overlap_check.py         |  32 +++---
 ...test_excl_spruce_2022_data_bandq_check.qmt |  42 -------
 .../test_excl_spruce_2022_data_qee_check.qmt  |  42 -------
 .../test_excl_spruce_2022_data_sl_check.qmt   |  42 -------
 .../test_pass_spruce_2022_data_b2cc_check.qmt |  42 -------
 ...test_pass_spruce_2022_data_bandq_check.qmt |  42 -------
 .../test_pass_spruce_2022_data_bnoc_check.qmt |  42 -------
 ...test_pass_spruce_2022_data_charm_check.qmt |  42 -------
 .../test_pass_spruce_2022_data_qee_check.qmt  |  42 -------
 .../test_pass_spruce_2022_data_sl_check.qmt   |  42 -------
 .../sprucing.qms/test_spruce_turbooverlap.qmt |   6 +-
 ...rcal_spruce_2022_data_monitoring_check.qmt |  45 --------
 ...l_spruce_2022_data_monitoring_rb_check.qmt |  46 --------
 ...turcal_spruce_2022_data_trackeff_check.qmt |  45 --------
 ...cal_spruce_2022_data_trackeff_rb_check.qmt |  46 --------
 ...t_turcal_spruce_2022_data_pid_rb_check.ref |   1 +
 Hlt/Moore/python/Moore/LbExec.py              |   9 +-
 Hlt/Moore/python/Moore/config.py              |  38 ++++---
 Hlt/Moore/python/Moore/lines.py               |  29 +++--
 Hlt/Moore/python/Moore/production.py          | 104 ++++++++++--------
 26 files changed, 170 insertions(+), 691 deletions(-)
 create mode 100644 Hlt/Hlt2Conf/python/Hlt2Conf/test_streaming_config.json
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_bandq_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_qee_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_sl_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_b2cc_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bandq_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bnoc_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_charm_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_qee_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_sl_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_rb_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_check.qmt
 delete mode 100644 Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_rb_check.qmt

diff --git a/Hlt/Hlt2Conf/CMakeLists.txt b/Hlt/Hlt2Conf/CMakeLists.txt
index f93c9c94358..a60aea47f99 100644
--- a/Hlt/Hlt2Conf/CMakeLists.txt
+++ b/Hlt/Hlt2Conf/CMakeLists.txt
@@ -110,23 +110,10 @@ if(BUILD_TESTING AND NOT USE_DD4HEP)
             Hlt2Conf.sprucing.test_turcal_spruce_2022_data
             Hlt2Conf.sprucing.test_turcal_spruce_2022_data_pid_check
             Hlt2Conf.sprucing.test_turcal_spruce_2022_data_pid_rb_check
-            Hlt2Conf.sprucing.test_turcal_spruce_2022_data_trackeff_check
-            Hlt2Conf.sprucing.test_turcal_spruce_2022_data_trackeff_rb_check
-            Hlt2Conf.sprucing.test_turcal_spruce_2022_data_monitoring_check
-            Hlt2Conf.sprucing.test_turcal_spruce_2022_data_monitoring_rb_check
             Hlt2Conf.sprucing.test_excl_spruce_2022_data_b2oc_check
-            Hlt2Conf.sprucing.test_excl_spruce_2022_data_bandq_check
-            Hlt2Conf.sprucing.test_excl_spruce_2022_data_qee_check
             Hlt2Conf.sprucing.test_excl_spruce_2022_data_rd_check
-            Hlt2Conf.sprucing.test_excl_spruce_2022_data_sl_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_b2cc_check
             Hlt2Conf.sprucing.test_pass_spruce_2022_data_b2oc_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_bandq_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_bnoc_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_charm_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_qee_check
             Hlt2Conf.sprucing.test_pass_spruce_2022_data_rd_check
-            Hlt2Conf.sprucing.test_pass_spruce_2022_data_sl_check
             Hlt2Conf.sprucing.test_excl_spruce_2023_1_data
             Hlt2Conf.sprucing.test_excl_spruce_2023_2_data
             Hlt2Conf.sprucing.test_hlt2_foroverlapcheck
diff --git a/Hlt/Hlt2Conf/options/sprucing/lbexec_yamls/spruce_overlap.yaml b/Hlt/Hlt2Conf/options/sprucing/lbexec_yamls/spruce_overlap.yaml
index 6f367608724..db386a2b248 100644
--- a/Hlt/Hlt2Conf/options/sprucing/lbexec_yamls/spruce_overlap.yaml
+++ b/Hlt/Hlt2Conf/options/sprucing/lbexec_yamls/spruce_overlap.yaml
@@ -10,8 +10,7 @@ evt_max: -1
 geometry_version: run3/trunk
 conditions_version: jonrob/all-pmts-active
 
-
-process: Spruce
+process: TurboSpruce
 input_raw_format : 0.5
 
 dddb_tag: dddb-20231017
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/Sprucing_tests.py b/Hlt/Hlt2Conf/python/Hlt2Conf/Sprucing_tests.py
index 6aa2ec41241..f7076a394fe 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/Sprucing_tests.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/Sprucing_tests.py
@@ -284,7 +284,6 @@ def turbo_overlap(options: Options):
 
     This test shows the overlap using PassLine on a data file in dpa eos space
     """
-    create_or_reuse_rootIOAlg(options)
 
     def make_streams():
         stream_A = Stream(
@@ -304,6 +303,8 @@ def turbo_overlap(options: Options):
 
 
 def spruce_overlap(options: Options):
+    import json
+
     """
     Test for the technical overlap of passthrough streams created in the sprucing-streaming step
 
@@ -315,24 +316,38 @@ def spruce_overlap(options: Options):
     This test shows how to remove the overlap using SpruceLine based on the output of hlt2_foroverlapcheck.py
     """
 
-    create_or_reuse_rootIOAlg(options)
-
-    input_line_config = options.input_streams_attributes_file
+    from pathlib import Path
 
-    spruce_streams = {
-        "streamone": ["Hlt2.*one.*"],
-        "streamtwo": ["Hlt2.*two.*"],
-        "streamthree": ["Hlt2.*three.*"],
-    }
+    turbolinedict = Path(__file__).parent / "test_streaming_config.json"
 
+    stream = "default"
+    input_line_config = options.input_streams_attributes_file
+    stream_config = turbolinedict
+
+    # Open and merge the line_config and the streaming_config
+    with open(stream_config, "r") as json_file:
+        streaming_config = json.load(json_file)
+    with open(input_line_config, "r") as json_file:
+        line_config = json.load(json_file)[stream]
+
+    for line, l_config in line_config.items():
+        for stream, s_config in streaming_config.items():
+            if line in s_config:
+                l_config["stream"] = stream
+                break
+        else:
+            raise Exception(f"Line {line} not found in any stream")
+
+    assert sum(map(len, streaming_config.values())) == len(line_config.keys()), (
+        f"There are {len(line_config.keys())} lines to be run but only {sum(map(len, streaming_config.values()))} lines in the streams config"
+    )
+
+    print(f"line_config: {line_config}")
     custom_prescales = {"Hlt2Linetwo": 0.5}
 
     def make_streams():
         return turbo_spruce(
-            input_line_config,
-            spruce_streams,
-            custom_prescales=custom_prescales,
-            stream="default",
+            line_config, custom_prescales=custom_prescales, use_regex=False
         )
 
     with list_of_full_stream_lines.bind(lines=[]):
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/sprucing_settings/Sprucing_production_pp.py b/Hlt/Hlt2Conf/python/Hlt2Conf/sprucing_settings/Sprucing_production_pp.py
index 6e15452dac9..4399f24bc76 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/sprucing_settings/Sprucing_production_pp.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/sprucing_settings/Sprucing_production_pp.py
@@ -157,17 +157,20 @@ turbolinedict = {
 from Moore.production import turbo_spruce
 
 
-def make_turbo_spruce_prod_streams(input_streams_attributes_file):
-    # create_or_reuse_rootIOAlg(options)
+def make_turbo_spruce_prod_streams(line_config):
+    return turbo_spruce(line_config, use_regex=True, spruce_streams=turbolinedict)
 
-    # custom_prescales = {"Hlt2Linetwo": 0.5}
 
-    return turbo_spruce(input_streams_attributes_file, turbolinedict)
+def turbo_spruce_production(options: Options):
+    import json
 
+    input_line_config = options.input_streams_attributes_file
+    stream = "turbo"
+    with open(input_line_config, "r") as json_file:
+        line_config = json.load(json_file)[stream]
 
-def turbo_spruce_production(options: Options):
     def make_streams():
-        return make_turbo_spruce_prod_streams(options.input_streams_attributes_file)
+        return make_turbo_spruce_prod_streams(line_config)
 
     config = run_moore(options, make_streams, public_tools=[])
     return config
diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/test_streaming_config.json b/Hlt/Hlt2Conf/python/Hlt2Conf/test_streaming_config.json
new file mode 100644
index 00000000000..8a61b1beed0
--- /dev/null
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/test_streaming_config.json
@@ -0,0 +1 @@
+{"streamone": ["Hlt2Lineone_extraoutputs"], "streamtwo": ["Hlt2Linetwo"], "streamthree": ["Hlt2Linethree"]}
diff --git a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
index 0f7edb7d21c..13a0a863429 100644
--- a/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
+++ b/Hlt/Hlt2Conf/tests/options/bandwidth/spruce_bandwidth_turbo_streams.py
@@ -27,6 +27,7 @@ from RecoConf.reconstruction_objects import reconstruction
 log = logging.getLogger()
 
 options.input_process = "Hlt2"
+options.process = "TurboSpruce"
 
 fname_helper = FileNameHelper(process="spruce", stream_config="turbo")
 fname_helper.make_tmp_dirs()
@@ -38,8 +39,14 @@ options.input_streams_attributes_file = FileNameHelper(
 ).streams_attributes_file()
 
 
+input_line_config = options.input_streams_attributes_file
+stream = "turbo"
+with open(input_line_config, "r") as json_file:
+    line_config = json.load(json_file)[stream]
+
+
 def make_streams():
-    real_streams = make_turbo_spruce_prod_streams(options.input_streams_attributes_file)
+    real_streams = make_turbo_spruce_prod_streams(line_config)
 
     # Write out stream configuration to JSON file for use later in the test
     with open(fname_helper.stream_config_json_path(), "w") as f:
diff --git a/Hlt/Hlt2Conf/tests/options/sprucing/spruce_turbopass_overlap_check.py b/Hlt/Hlt2Conf/tests/options/sprucing/spruce_turbopass_overlap_check.py
index e5c45f44b5b..dbe1e1c90c2 100644
--- a/Hlt/Hlt2Conf/tests/options/sprucing/spruce_turbopass_overlap_check.py
+++ b/Hlt/Hlt2Conf/tests/options/sprucing/spruce_turbopass_overlap_check.py
@@ -49,7 +49,7 @@ assert args.p == "Spruce" or args.p == "Turbo", (
 if args.p == "Turbo":
     RECO_ROOT = "/Event/HLT2"
 else:
-    RECO_ROOT = "/Event/Spruce/HLT2"
+    RECO_ROOT = "/Event/Turbo/HLT2"
 
 cf_node = do_unpacking(input_process=args.p, has_mc_data=options.simulation)
 
@@ -119,12 +119,12 @@ for ii in range(nevents):
         else:  # Spruce
             if options.input_stream == "streamone":
                 # Check particles and rb
-                check_particles(TES, f"/Event/Spruce/SprucePass_{lineone}")
+                check_particles(TES, f"/Event/Turbo/{lineone}")
                 check_banks(TES, options.input_stream, [9])
 
                 # Check persistreco
                 for reco in reco_locs:
-                    persistreco = TES[f"/Event/Spruce/HLT2/Rec/{reco}"]
+                    persistreco = TES[f"/Event/Turbo/HLT2/Rec/{reco}"]
                     if not persistreco or persistreco.size() <= 0:
                         raise RuntimeError(
                             "Check ERROR - Reco locations not propagated"
@@ -139,9 +139,7 @@ for ii in range(nevents):
                 ## proto().track().ancestors().size()
 
                 # Check CALO clusters
-                caloclusters = TES["/Event/Spruce/HLT2/Rec/Calo/Electrons"][
-                    0
-                ].clusters()
+                caloclusters = TES["/Event/Turbo/HLT2/Rec/Calo/Electrons"][0].clusters()
                 if not caloclusters or caloclusters.size() <= 0:
                     raise RuntimeError("Check ERROR - Calo clusters not propagated")
                 else:
@@ -150,7 +148,7 @@ for ii in range(nevents):
                     )
 
                 # Check CALO digits
-                calodigits = TES["/Event/Spruce/HLT2/Rec/Calo/Electrons"][0].digits()
+                calodigits = TES["/Event/Turbo/HLT2/Rec/Calo/Electrons"][0].digits()
                 if not calodigits or calodigits.size() <= 0:
                     raise RuntimeError("Check ERROR - Calo digits not propagated")
                 else:
@@ -159,7 +157,7 @@ for ii in range(nevents):
                     )
 
                 # Check PV tracks
-                pvtracks = TES["/Event/Spruce/HLT2/Rec/Vertex/Primary"][0].tracks()
+                pvtracks = TES["/Event/Turbo/HLT2/Rec/Vertex/Primary"][0].tracks()
                 if not pvtracks or pvtracks.size() <= 0:
                     raise RuntimeError("Check ERROR - PV tracks not propagated")
                 else:
@@ -169,30 +167,28 @@ for ii in range(nevents):
 
                 # Check extra_outputs
                 for extraoutput in lineone_extraoutputs:
-                    check_particles(
-                        TES, f"/Event/Spruce/SprucePass_{lineone}/{extraoutput}"
-                    )
+                    check_particles(TES, f"/Event/Turbo/{lineone}/{extraoutput}")
 
                 # Check no overlap
                 try:
-                    check_particles(TES, f"/Event/Spruce/SprucePass_{linetwo}")
+                    check_particles(TES, f"/Event/Turbo/{linetwo}")
                 except RuntimeError:
                     print(f"Check - No particles from {linetwo} AS EXPECTED")
 
                 else:
                     print("Check ERROR - Overlap is present")
                 finally:
-                    print(f"Done with SprucePass_{lineone}")
+                    print(f"Done with {lineone}")
                     break
 
             else:  # streamtwo
                 # Check particles and no Rich rb
-                check_particles(TES, f"/Event/Spruce/SprucePass_{linetwo}")
+                check_particles(TES, f"/Event/Turbo/{linetwo}")
                 check_not_banks(TES, options.input_stream, [9])
 
                 # Check persistreco
                 for reco in reco_locs:
-                    persistreco = TES[f"/Event/Spruce/HLT2/Rec/{reco}"]
+                    persistreco = TES[f"/Event/Turbo/HLT2/Rec/{reco}"]
                     if not persistreco or persistreco.size() <= 0:
                         print(f"Reco ({reco}) not propagated as expected")
                     else:
@@ -203,7 +199,7 @@ for ii in range(nevents):
                 # Cannot check absense of CALO objs with linetwo
 
                 # Check PV tracks
-                pvtracks = TES["/Event/Spruce/HLT2/Rec/Vertex/Primary"][0].tracks()
+                pvtracks = TES["/Event/Turbo/HLT2/Rec/Vertex/Primary"][0].tracks()
                 if not pvtracks or pvtracks.size() == 0:
                     print("PV tracks not propagated as expected")
                 else:
@@ -213,11 +209,11 @@ for ii in range(nevents):
 
                 # Check for no overlap
                 try:
-                    check_particles(TES, f"/Event/Spruce/SprucePass_{lineone}")
+                    check_particles(TES, f"/Event/Turbo/{lineone}")
                 except RuntimeError:
                     print(f"Check - No particles from {lineone} AS EXPECTED")
                 else:
                     print("Check ERROR - Overlap is present")
                 finally:
-                    print(f"Done with SprucePass_{linetwo}")
+                    print(f"Done with {linetwo}")
                     break
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_bandq_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_bandq_check.qmt
deleted file mode 100644
index 4da1e673aac..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_bandq_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of excl sprucing on 2022 data for bandq streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_excl_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>spruce_all_lines_production.bandq.dst</text>
-  <text>-manifest</text>
-  <text>spruce_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>excl</text>
-  <text>-stream</text>
-  <text>bandq</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_qee_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_qee_check.qmt
deleted file mode 100644
index 1a34f569169..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_qee_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of excl sprucing on 2022 data for qee streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_excl_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>spruce_all_lines_production.qee.dst</text>
-  <text>-manifest</text>
-  <text>spruce_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>excl</text>
-  <text>-stream</text>
-  <text>qee</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_sl_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_sl_check.qmt
deleted file mode 100644
index e2b670a9009..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_excl_spruce_2022_data_sl_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of excl sprucing on 2022 data for sl streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_excl_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>spruce_all_lines_production.sl.dst</text>
-  <text>-manifest</text>
-  <text>spruce_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>excl</text>
-  <text>-stream</text>
-  <text>sl</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_b2cc_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_b2cc_check.qmt
deleted file mode 100644
index 68da553c431..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_b2cc_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for b2cc streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.b2cc.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>b2cc</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bandq_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bandq_check.qmt
deleted file mode 100644
index 24c9e0716ee..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bandq_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for bandq streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.bandq.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>bandq</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bnoc_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bnoc_check.qmt
deleted file mode 100644
index 68ae8fd7fa2..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_bnoc_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for bnoc streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.bnoc.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>bnoc</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_charm_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_charm_check.qmt
deleted file mode 100644
index f9343c58cb3..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_charm_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for charm streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.charm.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>charm</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_qee_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_qee_check.qmt
deleted file mode 100644
index 08efc243515..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_qee_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for qee streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.qee.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>qee</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_sl_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_sl_check.qmt
deleted file mode 100644
index 8578829b0de..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_pass_spruce_2022_data_sl_check.qmt
+++ /dev/null
@@ -1,42 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2023 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Check a set of banks, decreports, particles and relations of the output of passthrough sprucing on 2022 data for sl streaming.
--->
-
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_pass_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_all_lines_production.sl.dst</text>
-  <text>-manifest</text>
-  <text>pass_all_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass</text>
-  <text>-stream</text>
-  <text>sl</text>
-</set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_spruce_turbooverlap.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_spruce_turbooverlap.qmt
index 059a1c7a046..3cf1238134d 100644
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_spruce_turbooverlap.qmt
+++ b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_spruce_turbooverlap.qmt
@@ -34,10 +34,10 @@ import re
 ref_file=str(open("test_hlt2_foroverlapcheck.stdout", "r").read())
 
 ref_matches_lineone = re.findall('LAZY_AND: (Hlt2Lineone_extraoutputs) .*Sum=(\d+)', ref_file)
-matches_lineone = re.findall('(VoidFilter/SprucePass_Hlt2Lineone_extraoutputs_Hlt2Filter) .*Sum=(\d+)', stdout)
+matches_lineone = re.findall('(VoidFilter/Hlt2Lineone_extraoutputs_Hlt2Filter) .*Sum=(\d+)', stdout)
 
 ref_matches_linetwo = re.findall('LAZY_AND: (Hlt2Linetwo) .*Sum=(\d+)', ref_file)
-matches_linetwo = re.findall('(VoidFilter/SprucePass_Hlt2Linetwo_Hlt2Filter) .*Sum=(\d+)', stdout)
+matches_linetwo = re.findall('(VoidFilter/Hlt2Linetwo_Hlt2Filter) .*Sum=(\d+)', stdout)
 
 print(f"ref_matches_lineone is {ref_matches_lineone} and matches_lineone is {matches_lineone}")
 print(f"ref_matches_linetwo is {ref_matches_linetwo} and matches_linetwo is {matches_linetwo}")
@@ -51,7 +51,7 @@ else:
   print(f"HLT2 found {ref_matches_lineone[0][1]} events and passthrough Sprucing found {matches_lineone[0][1]} for line {ref_matches_lineone[0][0]} - all good")
 
 
-prescale_linetwo = re.findall('(DeterministicPrescaler/SprucePass_Hlt2Linetwo_Prescaler) .*Eff=..\s(\d+.\d+)', stdout)
+prescale_linetwo = re.findall('(DeterministicPrescaler/Hlt2Linetwo_Prescaler) .*Eff=..\s(\d+.\d+)', stdout)
 print(f"Line two prescale is {prescale_linetwo}")
 
 if not (float(prescale_linetwo[0][1]) &gt; 40. and float(prescale_linetwo[0][1]) &lt; 60.):
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_check.qmt
deleted file mode 100644
index 16ff0c69be2..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_check.qmt
+++ /dev/null
@@ -1,45 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2000-2018 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Tests Sprucing output for 2022 TURCAL stream where for 10% of the data want to keep all detector rawbanks. This is a version of Sprucing passthrough.
-Runs over the output of test_turcal_spruce_2022_data
--->
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_turcal_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_turcal_lines_production.monitoring.dst</text>
-  <text>-manifest</text>
-  <text>pass_turcal_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass_turcal</text>
-  <text>-stream</text>
-  <text>monitoring</text>
-  <text>-rb_to_check</text>
-  <text>16</text>
-  <text>-rb_to_check_not</text>
-  <text>73</text><text>64</text><text>9</text><text>13</text><text>84</text><text>77</text>
-  </set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_rb_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_rb_check.qmt
deleted file mode 100644
index 1fd0294f911..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_monitoring_rb_check.qmt
+++ /dev/null
@@ -1,46 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2000-2018 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Tests Sprucing output for 2022 TURCAL stream where for 10% of the data want to keep all detector rawbanks. This is a version of Sprucing passthrough.
-Runs over the output of test_turcal_spruce_2022_data
--->
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_turcal_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_turcal_lines_production.monitoring_raw.dst</text>
-  <text>-manifest</text>
-  <text>pass_turcal_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass_turcal</text>
-  <text>-stream</text>
-  <text>monitoring_raw</text>
-  <text>-rb_to_check</text>
-  <text>16</text><text>73</text><text>64</text><text>9</text><text>13</text><text>84</text><text>77</text>
-  </set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="reference"><text>../refs/test_turcal_spruce_2022_data_monitoring_rb_check.ref</text></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-from GaudiConf.QMTest.LHCbExclusions import preprocessor
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 1},
-                stdout=remove_known_warnings(stdout))
-validateWithReference(preproc=preprocessor)
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_check.qmt
deleted file mode 100644
index 1c3e89f9a18..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_check.qmt
+++ /dev/null
@@ -1,45 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2000-2018 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Tests Sprucing output for 2022 TURCAL stream where for 10% of the data want to keep all detector rawbanks. This is a version of Sprucing passthrough.
-Runs over the output of test_turcal_spruce_2022_data
--->
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_turcal_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_turcal_lines_production.trackeff.dst</text>
-  <text>-manifest</text>
-  <text>pass_turcal_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass_turcal</text>
-  <text>-stream</text>
-  <text>trackeff</text>
-  <text>-rb_to_check</text>
-  <text>16</text>
-  <text>-rb_to_check_not</text>
-  <text>73</text><text>64</text><text>9</text><text>13</text><text>84</text><text>77</text>
-  </set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 0},
-                stdout=remove_known_warnings(stdout))
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_rb_check.qmt b/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_rb_check.qmt
deleted file mode 100644
index d413f48ade6..00000000000
--- a/Hlt/Hlt2Conf/tests/qmtest/sprucing.qms/test_turcal_spruce_2022_data_trackeff_rb_check.qmt
+++ /dev/null
@@ -1,46 +0,0 @@
-<?xml version="1.0" encoding="UTF-8"?><!DOCTYPE extension  PUBLIC '-//QM/2.3/Extension//EN'  'http://www.codesourcery.com/qm/dtds/2.3/-//qm/2.3/extension//en.dtd'>
-<!--
-    (c) Copyright 2000-2018 CERN for the benefit of the LHCb Collaboration
-
-    This software is distributed under the terms of the GNU General Public
-    Licence version 3 (GPL Version 3), copied verbatim in the file "COPYING".
-
-    In applying this licence, CERN does not waive the privileges and immunities
-    granted to it by virtue of its status as an Intergovernmental Organization
-    or submit itself to any jurisdiction.
--->
-<!--
-Tests Sprucing output for 2022 TURCAL stream where for 10% of the data want to keep all detector rawbanks. This is a version of Sprucing passthrough.
-Runs over the output of test_turcal_spruce_2022_data
--->
-<extension class="GaudiTest.GaudiExeTest" kind="test">
-<argument name="prerequisites"><set>
-  <tuple><text>sprucing.test_turcal_spruce_2022_data</text><enumeral>PASS</enumeral></tuple>
-</set></argument>
-<argument name="program"><text>python</text></argument>
-<argument name="timeout"><integer>300</integer></argument>
-<argument name="args"><set>
-  <text>$HLT2CONFROOT/tests/options/sprucing/spruce_check_2022_data.py</text>
-  <text>-input</text>
-  <text>pass_turcal_lines_production.trackeff_raw.dst</text>
-  <text>-manifest</text>
-  <text>pass_turcal_lines_production.tck.json</text>
-  <text>-job_type</text>
-  <text>pass_turcal</text>
-  <text>-stream</text>
-  <text>trackeff_raw</text>
-  <text>-rb_to_check</text>
-  <text>16</text><text>73</text><text>64</text><text>9</text><text>13</text><text>84</text><text>77</text>
-  </set></argument>
-<argument name="use_temp_dir"><enumeral>true</enumeral></argument>
-<argument name="reference"><text>../refs/test_turcal_spruce_2022_data_trackeff_rb_check.ref</text></argument>
-<argument name="validator"><text>
-
-from Moore.qmtest.exclusions import remove_known_warnings
-from GaudiConf.QMTest.LHCbExclusions import preprocessor
-countErrorLines({"FATAL": 0, "WARNING": 0, "ERROR": 1},
-                stdout=remove_known_warnings(stdout))
-validateWithReference(preproc=preprocessor)
-
-</text></argument>
-</extension>
diff --git a/Hlt/Hlt2Conf/tests/refs/test_turcal_spruce_2022_data_pid_rb_check.ref b/Hlt/Hlt2Conf/tests/refs/test_turcal_spruce_2022_data_pid_rb_check.ref
index 724e6d82bf4..afdca682344 100644
--- a/Hlt/Hlt2Conf/tests/refs/test_turcal_spruce_2022_data_pid_rb_check.ref
+++ b/Hlt/Hlt2Conf/tests/refs/test_turcal_spruce_2022_data_pid_rb_check.ref
@@ -49,6 +49,7 @@ rb_to_check_not  None
 |-phoenix_filename                        = ''  (default: '')
 |-preamble_algs                           = []  (default: [])
 |-print_freq                              = 10000  (default: 10000)
+|-process                                 = None
 |-python_logging_level                    = 20  (default: 20)
 |-require_specific_decoding_keys          = []  (default: [])
 |-root_ioalg_name                         = 'RootIOAlg'  (default: 'RootIOAlg')
diff --git a/Hlt/Moore/python/Moore/LbExec.py b/Hlt/Moore/python/Moore/LbExec.py
index 839a2409dec..0f252926bfd 100644
--- a/Hlt/Moore/python/Moore/LbExec.py
+++ b/Hlt/Moore/python/Moore/LbExec.py
@@ -26,6 +26,7 @@ class ProcessTypes(str, Enum):
     Hlt1 = "Hlt1"
     Hlt2 = "Hlt2"
     TurboPass = "TurboPass"
+    TurboSpruce = "TurboSpruce"
     Spruce = "Spruce"
     ReconstructionOnly = "ReconstructionOnly"
     Monitoring = "Monitoring"
@@ -34,7 +35,7 @@ class ProcessTypes(str, Enum):
 
 class Options(DefaultOptions):
     tck: Optional[int] = None
-    process: ProcessTypes = ProcessTypes.Hlt2
+    process: Optional[ProcessTypes] = None
 
     @contextmanager
     def apply_binds(self):
@@ -64,7 +65,11 @@ class Options(DefaultOptions):
 
         persistreco_version.global_bind(version=self.persistreco_version)
 
-        if self.process == ProcessTypes.Spruce:
+        if (
+            self.process == ProcessTypes.Spruce
+            or self.process == ProcessTypes.TurboSpruce
+            or self.process == ProcessTypes.TurboPass
+        ):
             reconstruction.global_bind(spruce=True, from_file=True)
 
         with super().apply_binds():
diff --git a/Hlt/Moore/python/Moore/config.py b/Hlt/Moore/python/Moore/config.py
index 08409e21a76..f79b3325b7e 100644
--- a/Hlt/Moore/python/Moore/config.py
+++ b/Hlt/Moore/python/Moore/config.py
@@ -135,10 +135,18 @@ def moore_control_flow(options, streams, process, analytics=False):
     extra_locations_to_persist = []
     packed_data = {}
     line_output_cf = {}
+
     if process in ["hlt2", "spruce"]:
-        event_output_prefix = "/Event/Spruce" if process == "spruce" else "/Event/HLT2"
-        reco_output_prefix = "/Event/HLT2"
+        if process == "hlt2":
+            event_output_prefix = reco_output_prefix = "/Event/HLT2"
+
+        if process == "spruce":
+            event_output_prefix = "/Event/Spruce"
+            if getattr(options, "process", None) and options.process == "TurboSpruce":
+                event_output_prefix = "/Event/Turbo"
 
+            reco_output_prefix = "/Event/HLT2"
+        ## The next bit is indented
         (line_output_cf, extra_locations_to_persist, packed_data) = (
             persist_line_outputs(
                 streams=streams,
@@ -292,18 +300,22 @@ def run_moore(
             options.output_streams_attributes_file, streams
         )
 
-    assert hlt1 ^ hlt2 ^ spruce ^ passthrough, (
-        "Expected exclusively all Hlt1, all Hlt2, all Spruce or all Pass lines"
-    )
-
-    if hlt1:
-        process = "hlt1"
-    elif hlt2:
-        process = "hlt2"
-    elif spruce:
+    if getattr(options, "process", None) and options.process == "TurboSpruce":
         process = "spruce"
-    elif passthrough:
-        process = "pass"
+
+    else:
+        assert hlt1 ^ hlt2 ^ spruce ^ passthrough, (
+            "Expected exclusively all Hlt1, all Hlt2, all Spruce or all Pass lines"
+        )
+
+        if hlt1:
+            process = "hlt1"
+        elif hlt2:
+            process = "hlt2"
+        elif spruce:
+            process = "spruce"
+        elif passthrough:
+            process = "pass"
 
     # Combine all lines and output in a global control flow.
     moore_control_node = moore_control_flow(options, streams, process, analytics)
diff --git a/Hlt/Moore/python/Moore/lines.py b/Hlt/Moore/python/Moore/lines.py
index 762387f20d9..a3338ac2e24 100644
--- a/Hlt/Moore/python/Moore/lines.py
+++ b/Hlt/Moore/python/Moore/lines.py
@@ -378,6 +378,7 @@ class Hlt2Line(DecisionLine):
         extra_outputs (iterable of 2-tuple): List of `(name, DataHandle)` pairs.
         persistreco (bool): If True, request HLT2 reconstruction persistence.
         hlt1_filter_code (list(str)): string used to define a HLT1 filter.
+        stream (str): name of the stream to which the line belongs, defaults to None.
 
     Attributes:
         objects_to_persist (list of DataHandle): Objects which this lines
@@ -412,6 +413,7 @@ class Hlt2Line(DecisionLine):
         algs,
         prescale=1.0,
         postscale=1.0,
+        stream=None,
         extra_outputs=None,
         persistreco=False,
         tagging_particles=False,
@@ -461,12 +463,14 @@ class Hlt2Line(DecisionLine):
             else:
                 algs += monitoring_algs
         super(Hlt2Line, self).__init__(name, algs, prescale, postscale)
-        if not self.name.startswith(self._CLASS_NAME_PREFIX):
-            raise ValueError(
-                "name {!r} does not start with {!r}".format(
-                    name, self._CLASS_NAME_PREFIX
+        if not isinstance(self, SpruceLine):
+            if not self.name.startswith(self._CLASS_NAME_PREFIX):
+                raise ValueError(
+                    "name {!r} does not start with {!r}".format(
+                        name, self._CLASS_NAME_PREFIX
+                    )
                 )
-            )
+
         self.extra_outputs = tuple(sorted(set(extra_outputs or []), key=hash))
         self.raw_banks = tuple(sorted(set(raw_banks or []), key=hash))
         self.persistreco = persistreco
@@ -475,6 +479,7 @@ class Hlt2Line(DecisionLine):
         self.calo_clusters = calo_clusters
         self.pv_tracks = True if persistreco else pv_tracks
         self.track_ancestors = track_ancestors
+        self.stream = stream
         # The line guarantees that these objects will be present in the TES if
         # this line made a positive decision
         self.objects_to_persist = []
@@ -507,6 +512,7 @@ class Hlt2Line(DecisionLine):
             "track_ancestors": self.track_ancestors,
             "raw_banks": self.raw_banks,
             "produces_particles": is_output_producer,
+            "stream": self.stream,
         }
 
     def to_dict(self):
@@ -732,6 +738,7 @@ class SpruceLine(Hlt2Line):
         algs,
         prescale=1.0,
         postscale=1.0,
+        stream=None,
         extra_outputs=None,
         raw_banks=None,
         persistreco=False,
@@ -747,10 +754,7 @@ class SpruceLine(Hlt2Line):
         self.hlt2_filter_code = hlt2_filter_code
         if hlt2_filter_code:
             hlt2_filter = _return_filter(
-                f"{name}_Hlt2Filter",
-                self.hlt2_filter_code,
-                self._HLT2_FILTER_SOURCE_ID,
-                False if isinstance(self, PassLine) else True,
+                f"{name}_Hlt2Filter", self.hlt2_filter_code, self._HLT2_FILTER_SOURCE_ID
             )
 
             algs = [hlt2_filter] + algs
@@ -761,6 +765,7 @@ class SpruceLine(Hlt2Line):
             algs=algs,
             prescale=prescale,
             postscale=postscale,
+            stream=stream,
             extra_outputs=extra_outputs,
             raw_banks=raw_banks,
             persistreco=persistreco,
@@ -772,12 +777,6 @@ class SpruceLine(Hlt2Line):
             hlt1_filter_code=hlt1_filter_code,
             monitoring_variables=monitoring_variables,
         )
-        if not self.name.startswith(self._CLASS_NAME_PREFIX):
-            raise ValueError(
-                "name {!r} does not start with {!r}".format(
-                    name, self._CLASS_NAME_PREFIX
-                )
-            )
 
 
 class PassLine(SpruceLine):
diff --git a/Hlt/Moore/python/Moore/production.py b/Hlt/Moore/python/Moore/production.py
index 8a0897d22b0..e49c28f43f1 100644
--- a/Hlt/Moore/python/Moore/production.py
+++ b/Hlt/Moore/python/Moore/production.py
@@ -519,58 +519,74 @@ def _spruce(
         return config
 
 
-def turbo_spruce(
-    input_line_config, spruce_streams, custom_prescales={}, stream="turbo"
-):
+def turbo_spruce(line_config, custom_prescales={}, use_regex=True, spruce_streams=None):
     """
-    Creates and configures sprucing streams for the passthrough of HLT2 TURBO output.
+    Creates and configures sprucing streams for HLT2 TURBO output.
 
-    This function reads the attributes of all Hlt2Lines
-    from a JSON file made at the HLT2 stage. It streams these Hlt2Lines as SpruceLines based on their attributes and
-    the given regex patterns in `spruce_streams`. If required it can apply custom prescales.
+    This function reads the attributes of Hlt2Lines from a dict made at the HLT2 stage. It streams these Hlt2Lines as SpruceLines based on their "stream" attribute OR by regex. If required it can apply custom prescales.
 
     Args:
-        input_line_config (str): JSON file made at the HLT2 stage with stream and line attributes
-        spruce_streams (dict): A dictionary mapping stream names to regex
-            pattern lists for Sprucing streams.
+        line_config (dict): dict made at the HLT2 stage with line attributes. This dict must have the following structure: {"line_name": {"name": "line_name", "stream": "stream_name", "prescale": 1.0} ...}. See Sprucing_tests:spruce_overlap for an example
         custom_prescales (dict, optional): A dictionary mapping line names to
             prescale factors. Defaults to empty dictionary.
-        stream (str, optional): The stream to be configured. Defaults to "turbo".
+        use_regex (bool, optional): If True, stream lines according to spruce_streams regex. Defaults to True.
+        spruce_streams (dict, optional): A dictionary mapping stream names to regex patterns. Defaults to None.
 
     Returns:
         Streams: An object containing the configured sprucing streams for passthrough of TURBO output.
     """
+    turbo_lines = list(line_config.keys())
+    # print(f"Lines in HLT2 stream requested: {turbo_lines}")
 
-    with open(input_line_config, "r") as json_file:
-        line_attributes = json.load(json_file)[stream]
+    if use_regex:
+        assert all(
+            isinstance(regex_list, list) for regex_list in spruce_streams.values()
+        ), (
+            "The `spruce_streams` dict for use_regex=True must map stream names to regex pattern LISTS"
+        )
+        # Can stream lines according to regex
+        streaming = {
+            stream_name: [
+                line
+                for line in turbo_lines
+                if any(re.match(regex, line) for regex in regex_list)
+            ]
+            for stream_name, regex_list in spruce_streams.items()
+        }
 
-    turbo_lines = list(line_attributes.keys())
-    # print(f"Lines in HLT2 stream requested: {turbo_lines}")
+    else:  # Using stream attribute in line_config to stream lines
+        list_of_streams = set(
+            line_config[line]["stream"] for line in line_config.keys()
+        )
 
-    assert all(
-        isinstance(regex_list, list) for regex_list in spruce_streams.values()
-    ), "The `spruce_streams` dict must map stream names to regex pattern LISTS"
+        ### Check that all lines have a stream
+        if None in list_of_streams:
+            raise ValueError("At least one line has no stream attribute assigned!!!")
+        print(f"Streams found in line attributes file are : {list_of_streams}")
+
+        # Streaming is done via exact "regex" list of lines
+        streaming = {
+            stream_name: [
+                line
+                for line in turbo_lines
+                if line_config[line].get("stream") == stream_name
+            ]
+            for stream_name in list_of_streams
+        }
 
-    # Can stream lines according to regex
-    streaming = {
-        stream_name: [
-            line
-            for line in turbo_lines
-            if any(re.match(regex, line) for regex in regex_list)
-        ]
-        for stream_name, regex_list in spruce_streams.items()
-    }
+    for stream_name in streaming.keys():
+        print(f"Lines in {stream_name} to be spruced: {streaming[stream_name]}")
 
-    # for stream_name in streaming.keys():
-    #     print(
-    #         f"Lines in {stream_name} to be spruced: {streaming[stream_name]}")
+    assert sum(map(len, streaming.values())) == len(line_config.keys()), (
+        f"There are {len(line_config.keys())} lines to be streamed but only {sum(map(len, streaming.values()))} lines in the streams config"
+    )
 
     streams = [
         Stream(
             stream_name,
             lines=[
                 _make_pass_spruceline(
-                    line_attributes, line, custom_prescales=custom_prescales
+                    line_config[line], custom_prescales=custom_prescales
                 )
                 for line in streaming[stream_name]
             ],
@@ -584,13 +600,12 @@ def turbo_spruce(
     return my_streams
 
 
-def _make_pass_spruceline(line_attributes, hlt2_linename, custom_prescales={}):
+def _make_pass_spruceline(line_attributes, custom_prescales={}):
     """
     Create a SpruceLine for a given Hlt2Line.
 
     Args:
-        line_attributes (dict): Attributes for all lines eg. `json[stream]` where json is read from `options.input_streams_attributes_file`.
-        hlt2_linename (str): The name of the Hlt2Line to be converted into a SpruceLine.
+        line_attributes (dict): Attributes for line.
         custom_prescales (dict, optional): A dictionary mapping lines to custom prescales. Defaults to empty dictionary.
 
     Returns:
@@ -598,27 +613,25 @@ def _make_pass_spruceline(line_attributes, hlt2_linename, custom_prescales={}):
     """
     from PyConf.reading import get_particles, upfront_decoder
 
-    filter = f"{hlt2_linename}Decision"
-    location = f"/Event/HLT2/{hlt2_linename}/Particles"
-    spruce_linename = hlt2_linename.replace("Hlt2", "SprucePass_Hlt2")
+    linename = line_attributes["name"]
+    filter = f"{linename}Decision"
+    location = f"/Event/HLT2/{linename}/Particles"
+
     # print(
-    #     f"Line {hlt2_linename} becomes {spruce_linename} with candidates at /Event/Spruce/{spruce_linename}/Particles"
+    #     f"Line {linename} produces candidates at /Event/Turbo/{spruce_linename}/Particles"
     # )
 
-    line_attributes = line_attributes[hlt2_linename]
-    line_attributes["prescale"] = custom_prescales.get(hlt2_linename, 1.0)
-    # print(line_attributes)
+    line_attributes["prescale"] = custom_prescales.get(linename, 1.0)
 
     with upfront_decoder.bind(source="Hlt2"):
         hlt2_particles = get_particles(location)
         algs = []
         # Some lines do not output anything to `/Event/HLT2/{hlt2_linename}/Particles`
         if line_attributes["produces_particles"]:
-            # print(f"Line {hlt2_linename} produces location `/Event/HLT2/{hlt2_linename}/Particles`")
             algs.append(hlt2_particles)
         else:
             print(
-                f"Line {hlt2_linename} does not produce location `/Event/HLT2/{hlt2_linename}/Particles`, skipping this location"
+                f"Line {linename} did not produce location `/Event/HLT2/{linename}/Particles`, skipping this location"
             )
 
         extra_outputs_tuplelist = []
@@ -627,10 +640,10 @@ def _make_pass_spruceline(line_attributes, hlt2_linename, custom_prescales={}):
             for loc in line_attributes["extra_outputs"]:
                 # print(f"Adding extra_output {loc} for line {spruce_linename}")
                 extra_outputs_tuplelist.append(
-                    (loc, get_particles(f"/Event/HLT2/{hlt2_linename}/{loc}/Particles"))
+                    (loc, get_particles(f"/Event/HLT2/{linename}/{loc}/Particles"))
                 )
         pass_spruceline = SpruceLine(
-            name=spruce_linename,
+            name=linename,
             hlt2_filter_code=filter,
             algs=algs,
             extra_outputs=extra_outputs_tuplelist,
@@ -642,5 +655,6 @@ def _make_pass_spruceline(line_attributes, hlt2_linename, custom_prescales={}):
             pv_tracks=line_attributes["pv_tracks"],
             track_ancestors=line_attributes["track_ancestors"],
             raw_banks=line_attributes["raw_banks"],
+            stream=line_attributes["stream"],
         )
     return pass_spruceline
-- 
GitLab


From 3fd30c4596874db2f90f761ac9d5a9534b88b47f Mon Sep 17 00:00:00 2001
From: Nicole Skidmore <nicola.skidmore@cern.ch>
Date: Thu, 13 Feb 2025 13:03:25 +0000
Subject: [PATCH 30/31] v56r2 release

---
 CMakeLists.txt        |  2 +-
 ReleaseNotes/v56r2.md | 66 +++++++++++++++++++++++++++++++++++++++++++
 2 files changed, 67 insertions(+), 1 deletion(-)
 create mode 100644 ReleaseNotes/v56r2.md

diff --git a/CMakeLists.txt b/CMakeLists.txt
index 8fa3fd353a3..2e26da1560e 100644
--- a/CMakeLists.txt
+++ b/CMakeLists.txt
@@ -11,7 +11,7 @@
 
 cmake_minimum_required(VERSION 3.15)
 
-project(Moore VERSION 56.1
+project(Moore VERSION 56.2
         LANGUAGES CXX)
 
 # Enable testing with CTest/CDash
diff --git a/ReleaseNotes/v56r2.md b/ReleaseNotes/v56r2.md
new file mode 100644
index 00000000000..f2453482692
--- /dev/null
+++ b/ReleaseNotes/v56r2.md
@@ -0,0 +1,66 @@
+2025-02-13 Moore v56r2
+===
+
+This version uses
+Allen [v5r2](../../../../Allen/-/tags/v5r2),
+Rec [v37r2](../../../../Rec/-/tags/v37r2),
+Lbcom [v36r3](../../../../Lbcom/-/tags/v36r3),
+LHCb [v56r3](../../../../LHCb/-/tags/v56r3),
+Detector [v2r3](../../../../Detector/-/tags/v2r3),
+Gaudi [v39r2](../../../../Gaudi/-/tags/v39r3) and
+LCG [105c](http://lcginfo.cern.ch/release/105c/) .
+
+
+This version is released on the `master` branch.
+Built relative to Moore [v56r1](/../../tags/v56r1), with the following changes:
+
+### New features ~"new feature"
+
+- Upstream project highlights :star:
+
+
+### Fixes ~"bug fix" ~workaround
+
+- Upstream project highlights :star:
+
+
+### Enhancements ~enhancement
+
+- Overlap improvements, !4327 (@nskidmor)
+- Upstream project highlights :star:
+
+
+### Code cleanups and changes to tests ~modernisation ~cleanup ~testing
+
+- Add some additional arm specific refs, !4301 (@jonrob)
+- Compare CPU and GPU decoding for Plume, !2034 (@espedica) [#379]
+- Upstream project highlights :star:
+
+### Other
+
+- ~selection | Summary of B2CC MRs Since October 2024, !3827 (@yimingli)
+- Update References for: LHCb!4913, Moore!4327, DaVinci!1230 based on lhcb-master-mr/12587, !4364 (@lhcbsoft)
+- Update References for: Moore!4331 based on lhcb-master-mr/12555, !4357 (@lhcbsoft)
+- Fixed validator of test_lbexec_hlt2_pp_2024_noflagging_mc, !4351 (@sponce)
+- Fixed documentation after move of code from HLT2Conf to RecoConf, !4344 (@sponce)
+- Fixed order of input files in tests using mdf_input_and_conds, !4331 (@sponce)
+- Update References for: Rec!3399 based on lhcb-master-mr/12533, !4274 (@lhcbsoft)
+- [QEE] Collection MR for further line optimisations 2025, !4140 (@lugrazet)
+- Synchronize master branch with 2024-patches, !4088 (@clemenci)
+- Tiny manual ref fix for allen_gaudi_downstream_with_mcchecking (was missing in..., !4346 (@sponce)
+- Hlt2_pp_commissioning_data_production - Use fixed geom tag, !4337 (@jonrob)
+- Update References for: Rec!3813 based on lhcb-master-mr/12440, !4330 (@lhcbsoft)
+- Update References for: Rec!4213 based on lhcb-master-mr/12430, !4307 (@lhcbsoft)
+- Update References for: Detector!667 based on lhcb-master-mr/12409, !4291 (@lhcbsoft)
+- [RTA/DPA BW tests]: Minor maintenance / revive qmtests, !4248 (@rjhunter) [#902]
+- [RTADPA BW Tests] Partially revive Hlt1 bandwidth test (and revive qmtest), !4223 (@lugrazet)
+- Update track_refitting module to include PV coordinate shift helper function, !4210 (@ldufour)
+- Ft pseudo hiteff, !4071 (@yihou)
+- Fix monitoring of single jet lines, !4014 (@thboettc)
+- Update interactive-dst.py, !4309 (@nskidmor)
+- Update References for: Allen!1856 based on lhcb-master-mr/12363, !4303 (@lhcbsoft)
+- Overlap changes post discussion, !4294 (@nskidmor)
+- Fix build in pipeline, !4288 (@jonrob)
+- Partly fixed calomon, !4286 (@zejia)
+- Test options for Run 3 SK interactive-dst, !4277 (@nskidmor)
+- Use fitted velo tracks for tracking efficiencies, !4256 (@ldufour)
-- 
GitLab


From 0ddf2e6fbb1e18b678501b15cfa737d172ec4bcb Mon Sep 17 00:00:00 2001
From: gitlabCI <gitlab-ci@cern.ch>
Date: Fri, 14 Feb 2025 11:03:32 +0100
Subject: [PATCH 31/31] in filters.py update to
 Hlt2B2OC_B_SigmaNet_Run3-v3.json

---
 Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/filters.py | 2 +-
 1 file changed, 1 insertion(+), 1 deletion(-)

diff --git a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/filters.py b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/filters.py
index 9166ec24394..ac398343342 100644
--- a/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/filters.py
+++ b/Hlt/Hlt2Conf/python/Hlt2Conf/lines/b_to_open_charm/filters.py
@@ -29,7 +29,7 @@ def b_sigmanet_filter(particles, MVACut=0.0):
         F.MVA(
             MVAType="SigmaNet",
             Config={
-                "File": "paramfile://data/Hlt2B2OC_B_SigmaNet_Run3-v2.json",
+                "File": "paramfile://data/Hlt2B2OC_B_SigmaNet_Run3-v3.json",
                 "Name": "B2OC_SigmaNet_Generic",
                 "Lambda": "2.0",
                 "NLayers": "3",
-- 
GitLab