diff --git a/Build/AtlasBuildScripts/checkout_Gaudi.sh b/Build/AtlasBuildScripts/checkout_Gaudi.sh
index 80dce55c13398856364edb11456077793235c5ad..d15a62d7aa9f16507c3e437013b72f6e6e26d488 100755
--- a/Build/AtlasBuildScripts/checkout_Gaudi.sh
+++ b/Build/AtlasBuildScripts/checkout_Gaudi.sh
@@ -43,6 +43,22 @@ _retry_ () {
     done
 }
 
+_max_retry_=5
+
+_retry_ () {
+    local cmd="$*"
+    local n=0
+    while ! $cmd ; do
+        if test $n -eq $_max_retry_ ; then
+            echo "ERROR: $cmd FAILED $_max_retry_ times. EXIT(1)" >&2
+            exit 1
+        fi
+        echo "WARNING: $cmd FAILED, retry in 30 sec ... "
+        sleep 30s
+        n=`expr $n + 1`
+    done
+}
+
 # Parse the command line arguments:
 TAGBRANCH=""
 SOURCEDIR=""
diff --git a/Build/AtlasBuildScripts/checkout_atlasexternals.sh b/Build/AtlasBuildScripts/checkout_atlasexternals.sh
index bdc803eba192c3689745d81b48157cd9200e3bda..feaee7886163af1679c40dc6320c619c0f9f92fd 100755
--- a/Build/AtlasBuildScripts/checkout_atlasexternals.sh
+++ b/Build/AtlasBuildScripts/checkout_atlasexternals.sh
@@ -43,6 +43,22 @@ _retry_ () {
     done
 }
 
+_max_retry_=5
+
+_retry_ () {
+    local cmd="$*"
+    local n=0
+    while ! $cmd ; do
+        if test $n -eq $_max_retry_ ; then
+            echo "ERROR: $cmd FAILED $_max_retry_ times. EXIT(1)" >&2
+            exit 1
+        fi
+        echo "WARNING: $cmd FAILED, retry in 30 sec ... "
+        sleep 30s
+        n=`expr $n + 1`
+    done
+}
+
 # Parse the command line arguments:
 TAGBRANCH=""
 SOURCEDIR=""
diff --git a/Projects/AthenaP1/package_filters.txt b/Projects/AthenaP1/package_filters.txt
index 4922adcd4ca4569fd479c20c5e54cff2c4e18ef6..770b2e9c207531f6aa19f68d435e3b731d9de435 100644
--- a/Projects/AthenaP1/package_filters.txt
+++ b/Projects/AthenaP1/package_filters.txt
@@ -17,31 +17,6 @@
 # Temporary VP1 compilation issues 
 - graphics/VP1/.*
 
-# Some analysis packages that are not part of Athena
-- AsgExternal/Asg_Test
-- PhysicsAnalysis/D3PDTools/EventLoop
-- PhysicsAnalysis/AnalysisCommon/CPAnalysisExamples
-- PhysicsAnalysis/AnalysisCommon/PMGTools
-- PhysicsAnalysis/D3PDTools/EventLoop
-- PhysicsAnalysis/D3PDTools/EventLoopAlgs
-- PhysicsAnalysis/D3PDTools/EventLoopGrid
-- PhysicsAnalysis/D3PDTools/MultiDraw
-- PhysicsAnalysis/D3PDTools/SampleHandler
-- PhysicsAnalysis/ElectronPhotonID/PhotonEfficiencyCorrection
-- PhysicsAnalysis/ElectronPhotonID/PhotonVertexSelection
-- PhysicsAnalysis/HiggsPhys/Run2/HZZ/Tools/ZMassConstraint
-- PhysicsAnalysis/JetPhys/SemileptonicCorr
-- PhysicsAnalysis/SUSYPhys/SUSYTools
-- PhysicsAnalysis/TauID/DiTauMassTools
-- PhysicsAnalysis/TauID/TauCorrUncert
-- PhysicsAnalysis/TopPhys/QuickAna
-- PhysicsAnalysis/TrackingID/InDetTrackSystematicsTools
-- Reconstruction/Jet/JetAnalysisTools/JetTileCorrection
-- Reconstruction/Jet/JetJvtEfficiency
-- Reconstruction/Jet/JetReclustering
-- Trigger/TrigAnalysis/TrigMuonEfficiency
-- Trigger/TrigAnalysis/TrigTauAnalysis/TrigTauMatching
-
 # Remove simulation packages except those required for EDM, etc.
 - Calorimeter/CaloG4Sim
 - ForwardDetectors/AFP/AFP_G4_SD
diff --git a/Projects/AthenaP1/version.txt b/Projects/AthenaP1/version.txt
index a270d10af0ef323ab5e035010266a79f349c66b6..84864ed40ce54e87c21e3df18da4f0f44cabda2d 100644
--- a/Projects/AthenaP1/version.txt
+++ b/Projects/AthenaP1/version.txt
@@ -1 +1 @@
-21.1.18
+21.1.20
diff --git a/Trigger/TrigCost/TrigCostRootAnalysis/Root/TrigXMLService.cxx b/Trigger/TrigCost/TrigCostRootAnalysis/Root/TrigXMLService.cxx
index aed0edc1e7cb21d7eef5e45c975855012dbe62ed..c08d1d9308aca106a11a36502e339733477cbb28 100644
--- a/Trigger/TrigCost/TrigCostRootAnalysis/Root/TrigXMLService.cxx
+++ b/Trigger/TrigCost/TrigCostRootAnalysis/Root/TrigXMLService.cxx
@@ -759,7 +759,7 @@ namespace TrigCostRootAnalysis {
 #ifndef ROOTCORE
       _path = PathResolverFindDataFile(_file); // Get from CALIB area
       if (_path == Config::config().getStr(kBlankString)) { // One more place we can look
-        _path = std::string(Config::config().getStr(kAFSDataDir) + _file);
+        _path = std::string(Config::config().getStr(kAFSDataDir) + "/" + _file);
       }
 #endif // not ROOTCORE
     }
diff --git a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/CMakeLists.txt b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/CMakeLists.txt
index 9b4b2857567cb17a446d2707b0445711d3a49566..a35f54ffd2757c045b7e70ccc250586f80f78437 100644
--- a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/CMakeLists.txt
+++ b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/CMakeLists.txt
@@ -17,8 +17,10 @@ atlas_add_library( L1TopoSimulationUtils
                    Root/*.cxx
                    PUBLIC_HEADERS L1TopoSimulationUtils
                    INCLUDE_DIRS ${Boost_INCLUDE_DIRS}
-                   LINK_LIBRARIES ${Boost_LIBRARIES} )
-
-
-
+                   LINK_LIBRARIES ${Boost_LIBRARIES} L1TopoEvent )
 
+atlas_add_test( L1TopoSimulationUtils_test
+                SOURCES
+                test/L1TopoSimulationUtils_test.cxx
+                INCLUDE_DIRS ${Boost_INCLUDE_DIRS}
+                LINK_LIBRARIES ${Boost_LIBRARIES} TestTools DataModel SGTools L1TopoEvent L1TopoSimulationUtils)
diff --git a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/L1TopoSimulationUtils/Kinematics.h b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/L1TopoSimulationUtils/Kinematics.h
index 4380ca1edecc848165751f98fc32536e6addc4dc..ab37fe682d056945eefae7426beca909b0e5f682 100644
--- a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/L1TopoSimulationUtils/Kinematics.h
+++ b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/L1TopoSimulationUtils/Kinematics.h
@@ -21,6 +21,18 @@ namespace TSU {
 
 	static unsigned int calcInvMassBW(const TCS::GenericTOB* tob1, const TCS::GenericTOB* tob2);
 	static unsigned int calcDeltaR2BW(const TCS::GenericTOB* tob1, const TCS::GenericTOB* tob2);
+     /**
+        @brief compute the sum in quadrature of two ints
+
+        This function includes an integer square root implementation using a bitwise iterative approach.
+        Square root is computed bit-by-bit (highest significance bits first) and the result is
+        adjusted up- or downwards in each iteration based on whether or not the current result
+        under- or overestimates the value of the sum of squares.
+
+        That is the same way in which the sqrt int is implemented in firmware:
+            processor/sources/common/libraries/L1TopoFunctions.vhd
+            --> function sqrt(d : UNSIGNED) return UNSIGNED
+      */
 	static unsigned long quadraticSumBW(int i1, int i2);
 
 	static unsigned int calcDeltaPhi(const TCS::GenericTOB* tob1, const TCS::GenericTOB* tob2);
diff --git a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/Root/Kinematics.cxx b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/Root/Kinematics.cxx
index ae8526b0435e04c500257f322d1a22fca337d1ae..a76213dd663f806f768679591e0b810471ddc5a5 100644
--- a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/Root/Kinematics.cxx
+++ b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/Root/Kinematics.cxx
@@ -56,33 +56,31 @@ unsigned int TSU::Kinematics::calcDeltaR2BW(const TCS::GenericTOB* tob1, const T
 }
 
 unsigned long TSU::Kinematics::quadraticSumBW(int i1, int i2){
-  long a = i1*i1 + i2*i2;
+    unsigned int ui1 = i1, ui2=i2;
+    unsigned int a = ui1*ui1 + ui2*ui2; 
 
-  unsigned long result=0;
-  long left=0,right=0,r=0;
-  long sign = 0;
+    unsigned int result=0;
+    int left=0, right=0; 
+    unsigned int r=0;
+    int sign=0;
   
-  //long input = a;
-  int halflength = 16; //max 16
-  long bitmask = 0b11111111111111111111111111111111; //32 bits
-  bitmask >>= (32-halflength*2);
+    //The values for halflength and bitmask enforce the
+    //bitwise overflow limit, not the precision of the chosen C++ parameters
+    int halflength = 16; //max 16
+    unsigned int bitmask = 0b11111111111111111111111111111111; //32 bits
+    bitmask >>= (32 - halflength*2); //does nothing unless halflength changes
   
-  for(int i = 0; i < halflength; i++){ //16-->4
-    right = 1 + (sign<<1) + (result<<2);
-
-    left = (r<<2) + (a >> 2*halflength-2);
-    a <<= 2;
-    a = a & bitmask;
-
-    if(sign) r = left + right;
-    else r = left - right;
-     
-    sign = (r & (1 << (halflength+1) ))  > 0;
-    result <<= 1;
-    if(!sign) result += 1;
-  }
- 
-  return result;
+    for(int i = 0; i < halflength; i++){ //16-->4
+        right = 1 + (sign<<1) + (result<<2);
+        left = (r<<2) + (a >> (2*halflength-2));
+        a <<= 2;
+        a = a & bitmask;
+        r = sign ? (left + right) : (left - right);
+        sign = ((r & (1 << (halflength+1) ))  > 0) ? 1 : 0;
+        result <<= 1;
+        if(sign==0) result += 1;
+    }
+    return result;
 }
 
 /*------------------------------------------ NON-BITWISE --------------------------------------------------*/
diff --git a/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/test/L1TopoSimulationUtils_test.cxx b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/test/L1TopoSimulationUtils_test.cxx
new file mode 100644
index 0000000000000000000000000000000000000000..bcfb14a9cd2f903613e70fe9959b88855ab27579
--- /dev/null
+++ b/Trigger/TrigT1/L1Topo/L1TopoSimulationUtils/test/L1TopoSimulationUtils_test.cxx
@@ -0,0 +1,181 @@
+/*
+  Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+*/
+
+/**
+ * @brief Unit test for L1TopoSimulationUtils
+ *
+ * We should collect here a set of basic unit tests for the functions
+ * implemented in this library.
+ *
+ * davide.gerbaudo@gmail.com
+ * May 2017
+ */
+
+#undef NDEBUG
+#include "L1TopoEvent/ClusterTOB.h"
+#include "L1TopoSimulationUtils/KFLUT.h"
+#include "L1TopoSimulationUtils/Hyperbolic.h"
+#include "L1TopoSimulationUtils/Trigo.h"
+#include "L1TopoSimulationUtils/L1TopoDataTypes.h"
+#include "L1TopoSimulationUtils/Kinematics.h"
+
+#include <boost/numeric/conversion/cast.hpp>
+
+#include <iostream>
+#include <cassert>
+#include <cstdint>
+#include <exception>
+
+using std::cout;
+using std::endl;
+using TCS::ClusterTOB;
+
+// Check cosh for intermediate delta-eta
+void test1()
+{
+    cout << "** test1: L1TopoSimulationUtils cosh at different delta-eta values**\n";
+    ClusterTOB cluster_fix0; // one cluster fixed at eta=0
+    ClusterTOB cluster_var; // one cluster scanning eta values
+
+    for(double ieta : {23, int(23.5), 24}) {
+        cluster_var.setEta(ieta);
+        auto cosh_val = TSU::Hyperbolic::Cosh.at(abs(cluster_fix0.eta() - cluster_var.eta()));
+        cout<<"delta eta: "
+            <<" abs("<<cluster_fix0.eta()<<" - "<<cluster_var.eta()<<")"
+            <<" = "<<abs(cluster_fix0.eta() - cluster_var.eta())
+            <<", cosh "<<cosh_val
+            <<endl;
+    }
+}
+
+// Check KF correction values
+void test2()
+{
+    cout << "** test2: L1TopoSimulationUtils KFLUT correction vs. et and eta**\n";
+    TCS::KFLUT  kflut;
+
+    // use roughly the center of the bins defined in KFLUT.cxx + one outsider
+    for(const double eta : {0.05, 0.2, 0.41, 0.6, 0.8, 1.0, 1.2, 1.4, 1.6, 1.8, 2.0, 2.2, 2.4, 2.6, 2.9, 3.1, 3.5}) {
+        for(const unsigned int et : {4, 12, 24, 48, 96, 360}) {
+            int iet = kflut.getetbin(et);
+            int ieta = kflut.getetabin(abs(eta));
+            double corrfactor = kflut.getcorrKF(iet, ieta);
+            const bool large = corrfactor>+0.5;
+            const bool small = corrfactor<-0.5;
+            if(small or large) {
+                cout<<" et "<<et<<" ["<<iet<<"], "
+                    <<" eta "<<eta<<" ["<<ieta<<"] : "
+                    <<corrfactor<<(large ? " >>>" :
+                                   small ? " <<<" :
+                                   "")
+                    <<endl;
+            }
+        } // for(et)
+    } // for(eta)
+}
+
+// Check KF saturation
+void test3()
+{
+    cout << "** test3: L1TopoSimulationUtils KFLUT saturation**\n";
+    TCS::KFLUT  kflut;
+    try {
+        const int et = 1024+1; // 2**10 + 1 : JetTOB has 10bits for E8x8
+        const double eta = 0.5;
+        int iet = kflut.getetbin(et);
+        int ieta = kflut.getetabin(abs(eta));
+        double corrfactor = kflut.getcorrKF(iet, ieta);
+        cout<<" et "<<et<<" ["<<iet<<"], "
+            <<" eta "<<eta<<" ["<<ieta<<"] : "
+            <<corrfactor<<" THIS SHOULD NOT APPEAR HERE"
+            <<endl;
+    } catch(const std::out_of_range &e) {
+        cout<<"This out_of_range is expected for ET values beyond 1024 : "
+            <<e.what()<<endl;
+    }
+}
+
+// test4: Check quadraticSumBW: compare against a "traditional" (binary search) int sqrt implementation
+/**
+   @brief Returns floor of square root of x
+
+   from http://www.geeksforgeeks.org/square-root-of-an-integer/
+*/
+int floorSqrt(unsigned int x)
+{
+    // Base cases
+    if (x == 0 || x == 1)
+        return x;
+    // Do Binary Search for floor(sqrt(x))
+    unsigned long int start = 1, end = x, ans;
+    unsigned long int ux = x;
+    while (start <= end) {
+        unsigned long int mid = (start + end) / 2;
+        // If x is a perfect square
+        if (mid*mid == ux)
+            return mid;
+        // Since we need floor, we update answer when mid*mid is
+        // smaller than x, and move closer to sqrt(x)
+        if (mid*mid < ux) {
+            start = mid + 1;
+            ans = mid;
+        } else // If mid*mid is greater than x
+            end = mid - 1;
+    }
+    return boost::numeric_cast<int>(ans);
+}
+int test4_compare(int u, int v){
+    int bw_result = TSU::Kinematics::quadraticSumBW(u,v);
+    unsigned int uu = u*u;
+    unsigned int uv = v*v;
+    int fl_result = floorSqrt(uu+uv);
+    cout<<" sum2("<<u<<", "<<v<<") :"
+        <<" std = "<<fl_result
+        <<" bw = "<<bw_result
+        <<endl;
+    if(bw_result < u && bw_result < v) return 1; //overflow occurred
+    else return bw_result - fl_result; //possibility mismatch
+}
+int test4()
+{
+    cout << "** test4: L1TopoSimulationUtils quadraticSumBW bitshift**\n";
+    const std::vector<int> values = {/*0b0,*/ // 0 through 32767=2^(15) (16 bits)
+                                     0b1,
+                                     0b11,
+                                     0b111,
+                                     0b1111,
+                                     0b11111,
+                                     0b111111,
+                                     0b1111111,
+                                     0b11111111,
+                                     0b111111111,
+                                     0b1111111111,
+                                     0b11111111111,
+                                     0b111111111111,
+                                     0b1111111111111,
+                                     0b11111111111111,
+                                     0b111111111111111};
+    for(const int v : values){
+      if(test4_compare(v,v) != 0) return 1;
+      if(test4_compare(-v,-v) != 0) return 1;
+    }
+
+    if(test4_compare(0,65535) != 0) return 1;
+    if(test4_compare(362,65535) != 0) return 1;
+    if(test4_compare(46340,46340) != 0) return 1;
+
+    return 0;
+}
+
+
+
+int main()
+{
+  test1();
+  test2();
+  test3();
+  int result = test4();
+
+  return result;
+}
diff --git a/Trigger/TrigT1/TrigT1CaloCalibUtils/python/doL1CaloHVCorrections.py b/Trigger/TrigT1/TrigT1CaloCalibUtils/python/doL1CaloHVCorrections.py
index 6d485980c0fe42f2684838a7257031a9ca9a38a4..aae275eaed59cf8672afca416188bdbd5bff1db7 100644
--- a/Trigger/TrigT1/TrigT1CaloCalibUtils/python/doL1CaloHVCorrections.py
+++ b/Trigger/TrigT1/TrigT1CaloCalibUtils/python/doL1CaloHVCorrections.py
@@ -11,7 +11,7 @@ import time
 import os
 #from ctypes import *
 import struct 
-from array import *
+import array
 
 from PyCool import cool
 from optparse import OptionParser
@@ -21,6 +21,53 @@ import PlotCalibrationHV
 
 import mergeEnergyRamps
 
+class HVCorrectionCOOLReader:
+
+  def __init__(self):
+
+    self.correctionsFromCOOL = {}
+    self.UNIX2COOL = 1000000000
+
+    # get database service and open database
+    dbSvc = cool.DatabaseSvcFactory.databaseService()
+
+    dbString = 'oracle://ATLAS_COOLPROD;schema=ATLAS_COOLONL_TRIGGER;dbname=CONDBR2'
+    try:
+      db = dbSvc.openDatabase(dbString, False)        
+    except Exception, e:
+      print 'Error: Problem opening database', e
+      sys.exit(1)
+
+    folder_name = "/TRIGGER/Receivers/Factors/HVCorrections"
+    folder=db.getFolder(folder_name)
+    ch = folder.listChannels()
+       
+    startUtime = int(time.time())
+    endUtime = int(time.time())
+    startValKey = startUtime * self.UNIX2COOL
+    endValKey = endUtime * self.UNIX2COOL
+    chsel = cool.ChannelSelection(0,sys.maxint)
+
+    try:
+      itr=folder.browseObjects(startValKey, endValKey, chsel)
+    except Exception, e:
+      print e
+      sys.exit(1)
+
+    for row in itr:
+      ReceiverId = hex(int(row.channelId()))
+      payload = row.payload()
+      HVCorrection = payload['factor']
+
+      self.correctionsFromCOOL[ReceiverId] = HVCorrection
+     
+  # close database
+    db.closeDatabase()
+
+  def getCorrection(self, receiver):
+
+    return self.correctionsFromCOOL[receiver]
+
 class HVCorrectionCalculator:
 
   def __init__(self, mapping):
@@ -237,10 +284,24 @@ if __name__ == "__main__":
 
   h_corrEmec_em  = PlotCalibrationGains.L1CaloMap("Calculated HV corrections for EM overlap (EMEC)","#eta bin","#phi bin")
   h_corrFcalHighEta_had = PlotCalibrationGains.L1CaloMap("Calculated HV corrections for HAD FCAL (high #eta)","#eta bin","#phi bin")
+#
+  h_RefcorrEmb_em  = PlotCalibrationGains.L1CaloMap("Reference HV corrections for EM  (EMB in overlap) ","#eta bin","#phi bin")
+  h_RefcorrFcalLowEta_had = PlotCalibrationGains.L1CaloMap("Reference HV corrections for HAD (FCAL low #eta)","#eta bin","#phi bin")
 
+  h_RefcorrEmec_em  = PlotCalibrationGains.L1CaloMap("Reference HV corrections for EM overlap (EMEC)","#eta bin","#phi bin")
+  h_RefcorrFcalHighEta_had = PlotCalibrationGains.L1CaloMap("Reference HV corrections for HAD FCAL (high #eta)","#eta bin","#phi bin")
+#
+  h_DiffcorrEmb_em  = PlotCalibrationGains.L1CaloMap("(calculated-reference) HV corrections for EM  (EMB in overlap) ","#eta bin","#phi bin")
+  h_DiffcorrFcalLowEta_had = PlotCalibrationGains.L1CaloMap("(calculated-reference) HV corrections for HAD (FCAL low #eta)","#eta bin","#phi bin")
+
+  h_DiffcorrEmec_em  = PlotCalibrationGains.L1CaloMap("(calculated-reference) HV corrections for EM overlap (EMEC)","#eta bin","#phi bin")
+  h_DiffcorrFcalHighEta_had = PlotCalibrationGains.L1CaloMap("(calculated-reference) HV corrections for HAD FCAL (high #eta)","#eta bin","#phi bin")
+#
     
   hv_input = PlotCalibrationHV.L1CaloHVReader(options.hv_input) 
 
+  referenceCorrectionReader = HVCorrectionCOOLReader()
+
   geometry_convertor = PlotCalibrationGains.L1CaloGeometryConvertor()
   geometry_convertor.LoadReceiverPPMMap()
 
@@ -348,33 +409,49 @@ if __name__ == "__main__":
     ### check if the channel has overall HV correction larger than the threshold
     
     predictedCorrection = correctionCalculator.GetCorrection(receiver, layer_corr, layer_names)
+    referenceCorrection = referenceCorrectionReader.getCorrection(receiver)
+
+    correctionDifference = (predictedCorrection-referenceCorrection)
+
+#    print "predictedCorrection=", predictedCorrection, "  referenceCorrection=", referenceCorrection
 
-    if abs(predictedCorrection - 1) <= options.hv_corr_diff:
+    if abs(correctionDifference) <= options.hv_corr_diff:                # we update only towers that changed
       continue # skip this receiver, the correction is not high enough
 
     calculatedCorrections[receiver] = [predictedCorrection,0]
-    print >> output_text, ("%5s %9s  %3i %2i  %.3f") % (receiver, coolid, eta_bin, phi_bin, predictedCorrection)
+    print >> output_text, ("%5s %9s  %3i %2i  %.3f (%.3f)") % (receiver, coolid, eta_bin, phi_bin, predictedCorrection,referenceCorrection)
 
 
     if geometry_convertor.isCoolEm(coolid):
       if not geometry_convertor.isPPMOverlap(coolid):
         h_corrEmb_em.Fill(eta_bin,phi_bin,predictedCorrection)
+        h_RefcorrEmb_em.Fill(eta_bin,phi_bin,referenceCorrection)
+        h_DiffcorrEmb_em.Fill(eta_bin,phi_bin,correctionDifference)
       else:
         if geometry_convertor.getOverlapLayer(receiver)=='EMB':
           h_corrEmb_em.Fill(eta_bin,phi_bin,predictedCorrection)
+          h_RefcorrEmb_em.Fill(eta_bin,phi_bin,referenceCorrection)
+          h_DiffcorrEmb_em.Fill(eta_bin,phi_bin,correctionDifference)
         else:
           h_corrEmec_em.Fill(eta_bin,phi_bin,predictedCorrection)
+          h_RefcorrEmec_em.Fill(eta_bin,phi_bin,referenceCorrection)
+          h_DiffcorrEmec_em.Fill(eta_bin,phi_bin,correctionDifference)
 
 
     if geometry_convertor.isCoolHad(coolid):
       if not geometry_convertor.isPPMFCAL(coolid):
         h_corrFcalLowEta_had.Fill(eta_bin,phi_bin,predictedCorrection)
+        h_RefcorrFcalLowEta_had.Fill(eta_bin,phi_bin,referenceCorrection)
+        h_DiffcorrFcalLowEta_had.Fill(eta_bin,phi_bin,correctionDifference)
       else:
         if geometry_convertor.getFCAL23RecEta(receiver)=='HighEta':
           h_corrFcalHighEta_had.Fill(eta_bin,phi_bin,predictedCorrection)
+          h_RefcorrFcalHighEta_had.Fill(eta_bin,phi_bin,referenceCorrection)
+          h_DiffcorrFcalHighEta_had.Fill(eta_bin,phi_bin,correctionDifference)
         else: 
           h_corrFcalLowEta_had.Fill(eta_bin,phi_bin,predictedCorrection)
-
+          h_RefcorrFcalLowEta_had.Fill(eta_bin,phi_bin,referenceCorrection)
+          h_DiffcorrFcalLowEta_had.Fill(eta_bin,phi_bin,correctionDifference)
 
   writeHVToSqlite(options.output_files+".sqlite",calculatedCorrections)
   output_text.close()
@@ -400,8 +477,53 @@ if __name__ == "__main__":
   h_corrFcalHighEta_had.SetMinimum(1.)
   h_corrFcalHighEta_had.SetMaximum(2.1)
   h_corrFcalHighEta_had.Draw()
-  c1.Print(options.output_files+".ps)")
+  c1.Print(options.output_files+".ps")
+
+  # Now corrections from COOL
+
+  h_RefcorrEmb_em.SetMinimum(1.)
+  h_RefcorrEmb_em.SetMaximum(2.1)
+  h_RefcorrEmb_em.Draw()
+  c1.Print(options.output_files+".ps")
+
+  h_RefcorrFcalLowEta_had.SetMinimum(1.)
+  h_RefcorrFcalLowEta_had.SetMaximum(2.1)
+  h_RefcorrFcalLowEta_had.Draw()
+  c1.Print(options.output_files+".ps")
+
+
+  h_RefcorrEmec_em.SetMinimum(1.)
+  h_RefcorrEmec_em.SetMaximum(2.1)
+  h_RefcorrEmec_em.Draw()
+  c1.Print(options.output_files+".ps")
+
+  h_RefcorrFcalHighEta_had.SetMinimum(1.)
+  h_RefcorrFcalHighEta_had.SetMaximum(2.1)
+  h_RefcorrFcalHighEta_had.Draw()
+  c1.Print(options.output_files+".ps")
+
+  # Now difference
+  h_DiffcorrEmb_em.SetMinimum(-0.1)
+  h_DiffcorrEmb_em.SetMaximum(0.1)
+  h_DiffcorrEmb_em.Draw()
+  c1.Print(options.output_files+".ps")
+
+  h_DiffcorrFcalLowEta_had.SetMinimum(-0.1)
+  h_DiffcorrFcalLowEta_had.SetMaximum(0.1)
+  h_DiffcorrFcalLowEta_had.Draw()
+  c1.Print(options.output_files+".ps")
 
+
+  h_DiffcorrEmec_em.SetMinimum(-0.1)
+  h_DiffcorrEmec_em.SetMaximum(0.1)
+  h_DiffcorrEmec_em.Draw()
+  c1.Print(options.output_files+".ps")
+
+  h_DiffcorrFcalHighEta_had.SetMinimum(-0.1)
+  h_DiffcorrFcalHighEta_had.SetMaximum(0.1)
+  h_DiffcorrFcalHighEta_had.Draw()
+  c1.Print(options.output_files+".ps)")
+#
   os.system("ps2pdf " + options.output_files+".ps")
  # os.system("cp HVStatus.pdf /home/jb/public_web/tmp ")
 
diff --git a/Trigger/TrigValidation/TrigP1Test/share/testAthenaP1BStoESD.py b/Trigger/TrigValidation/TrigP1Test/share/testAthenaP1BStoESD.py
deleted file mode 100755
index 2f1796de3cf138eb85381ba3af9cd3244dd0fecc..0000000000000000000000000000000000000000
--- a/Trigger/TrigValidation/TrigP1Test/share/testAthenaP1BStoESD.py
+++ /dev/null
@@ -1,97 +0,0 @@
-# steering file for BS->ESD step
-# see myTopOptions.py for more info
-#doCBNT=False
-from RecExConfig.RecFlags import rec
-from AthenaCommon.AthenaCommonFlags import athenaCommonFlags as acf
-
-import glob
-
-if not ('EvtMax' in dir()):
-   acf.EvtMax=10
-
-
-if not 'BSRDOInput' in dir():
-#    BSRDOInput=["../AthenaModernRDOtoBS/daq.csc13.0000000.Single.Stream.LB0000.Athena._0001.data"]
-#     BSRDOInput=["rfio:/castor/cern.ch/user/s/strom/test/daq.ttbar.data"]  
-#      BSRDOInput=["../testAllPT/daq..0000000.Single.Stream.LB0000.Athena._0001.data"]
-      acf.BSRDOInput=["../testAllPT/EF._0001.data"]
-
-if len(BSRDOInput) > 1:
-  print "WARNNING this JO only works on one file, ignore extras",BSRDOInput
-  acf.BSRDOInput = BSRDOInput[0:0]
-#
-# try looking for the data file in the expected directory
-#
-if  glob.glob(BSRDOInput[0]):
-  print "INFO:  found file",BSRDOInput
-#
-# try using the writing file if this exists
-#
-elif glob.glob(BSRDOInput[0]+".writing"):
-  BSRDOInput[0] = BSRDOInput[0]+".writing"
-  print "using file ",BSRDOInput[0]
-#
-# maybe the name changed
-#
-elif glob.glob( BSRDOInput[0][:BSRDOInput[0].rfind('/')]+"/*.data"): 
-  print "looking for ",BSRDOInput[0][:BSRDOInput[0].rfind('/')]+"/*.data"
-  acf.BSRDOInput = glob.glob( BSRDOInput[0][:BSRDOInput[0].rfind('/')]+"/*.data")
-  print "WARNING: trying file: ",BSRDOInput
-#
-# failing that, use a fixed file
-#
-else:
-  BSRDOInput[0] = "/afs/cern.ch/atlas/project/trigger/pesa-sw/validation/references/data"+BSRDOInput[0][2:]
-  print "WARNING: trying file: ",BSRDOInput
-
-if not 'doWriteESD' in dir():
-  rec.doWriteESD=True
-
-rec.doWriteRDO=False
-rec.doWriteAOD=False 
-rec.doAOD=False
-rec.doESD=False
-rec.doWriteTAG=False 
-
-rec.doCBNT=False
-
-doTrigger=True
-
-#doTrigger=False
-#-------
-# Read from ByteStream
-#------
-from AthenaCommon.GlobalFlags import GlobalFlags
-GlobalFlags.InputFormat.set_bytestream()
-
-readBS=True
-
-#very temporary hack -- should get this automatically 
-#from TriggerJobOpts.TriggerFlags import TriggerFlags
-#TriggerFlags.readLVL1configFromXML=True
-#TriggerFlags.inputLVL1configFile="TriggerRelease/Rel14_1_0rel2_May27_lumi1E31_outputLVL1config.xml"
-
-
-include ("RecExCommon/RecExCommon_flags.py")
-# should be done afterwards so that TriggerFlags are configured ok
-
-# has been run at RDO->BS step (even EF ?)
-# doTrigger=False
-#from RecExConfig.RecFlags import recAlgs
-# recAlgs.doTrigger=False
-
-
-
-# main jobOption
-include ("RecExCommon/RecExCommon_topOptions.py")
-
-# the correct tag should be specified 
-# use "OFLCOND-SIM-00-00-03" for ATLAS-GEO-XX
-#
-ServiceMgr.IOVDbSvc.GlobalTag="OFLCOND-SIM-00-00-03"
-#ServiceMgr.IOVDbSvc.GlobalTag="OFLCOND-CSC-00-01-00"
-
-#the file from /afs/cern.ch/atlas/project/trigger/pesa-sw/validation/references/data 
-#corresponds to MC cabling of SCT
-from TriggerRelease.Modifiers import ForceMCSCTMapping
-ForceMCSCTMapping().postSetup()
diff --git a/Trigger/TrigValidation/TrigP1Test/share/testCheckKeys.sh b/Trigger/TrigValidation/TrigP1Test/share/testCheckKeys.sh
index 64f6a587537d598aad45b3df4e54655d85d375fb..c758bb5a3260acb6fc9269f3c5dac4bab616a5ae 100755
--- a/Trigger/TrigValidation/TrigP1Test/share/testCheckKeys.sh
+++ b/Trigger/TrigValidation/TrigP1Test/share/testCheckKeys.sh
@@ -9,11 +9,7 @@ else
 fi
 
 #setup the TT
-export _JAVA_OPTIONS="-Xms512m -Xmx1048m"
 export DBConn="TRIGGERDBATN"
-
-export PATH=$PATH:$TDAQ_JAVA_HOME/bin
-
 export TNS_ADMIN=/afs/cern.ch/atlas/offline/external/oracle/latest/admin
 
 ##get the right pattern to load Lvl1 xml file
@@ -58,8 +54,10 @@ get_files -xmls LVL1config.dtd
 # - depending on implementation in ART may want to be done explicitly here
 ### #upload the first key
 ### echo "upload the first key"
+### #--name is set to the same name as in testUploadMenuKeys.sh to give the identical menu
+### #--release is set to CheckKeysTest so that it appears clearly in the TriggerTool which key was reuploaded by this test (appears in list of releases for a SMK)
 ### 
-### cmd1="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release 'AthenaP1' --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu1 --hlt_setup $hlt__setup1 --name 'AthenaP1Test' -l INFO --dbConn $DBConn -w_n 60 -w_t 60 "
+### cmd1="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release 'CheckKeysTest' --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu1 --hlt_setup $hlt__setup1 --name 'AthenaP1Test' -l INFO --dbConn $DBConn -w_n 60 -w_t 60 "
 ### 
 ### echo $cmd1
 ### eval $cmd1 &> uploadSMK1.log
@@ -93,8 +91,10 @@ hlt__setup2=ef_Default_setup_rerun.xml
 
 #upload the second key
 echo "upload the second key"
+#--name is set to the same name as in testUploadMenuKeys.sh to give the identical menu
+#--release is set to CheckKeysTest so that it appears clearly in the TriggerTool which key was reuploaded by this test (appears in list of releases for a SMK)
 
-cmd2="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release 'AthenaP1' --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu2 --hlt_setup $hlt__setup2 --name 'AthenaP1Test' -l INFO --dbConn $DBConn -w_n 60 -w_t 60 "
+cmd2="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release 'CheckKeysTest' --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu2 --hlt_setup $hlt__setup2 --name 'AthenaP1Test' -l INFO --dbConn $DBConn -w_n 60 -w_t 60 "
 
 echo $cmd2 "&> uploadSMK2.log"
 eval $cmd2 &> uploadSMK2.log
diff --git a/Trigger/TrigValidation/TrigP1Test/share/testUploadMenuKeys.sh b/Trigger/TrigValidation/TrigP1Test/share/testUploadMenuKeys.sh
index f3e726d815ce831ce39899d8d6b9ebeff5a4393b..d6eb09d4c9501e66c69a50dd547ae2a55e8f5564 100755
--- a/Trigger/TrigValidation/TrigP1Test/share/testUploadMenuKeys.sh
+++ b/Trigger/TrigValidation/TrigP1Test/share/testUploadMenuKeys.sh
@@ -9,11 +9,7 @@ else
 fi
 
 #setup the TT
-export _JAVA_OPTIONS="-Xms512m -Xmx1048m"
 export DBConn="TRIGGERDBATN"
-
-export PATH=$PATH:$TDAQ_JAVA_HOME/bin
-
 export TNS_ADMIN=/afs/cern.ch/atlas/offline/external/oracle/latest/admin
 
 ##get the right pattern to load LVl1 xml file
@@ -98,7 +94,7 @@ rundate=`date +%F" "%H:%M" "`
 
 # Upload SMK
 
-cmd="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release $p1_rel --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu1 --hlt_setup $hlt__setup1 --name 'AthenaP1Test' -l INFO --SMcomment \"${rundate}${nightly}_${rel}\" --dbConn $DBConn -w_n 50 -w_t 60"
+cmd="/afs/cern.ch/user/a/attrgcnf/public/TriggerTool/cmake/run_TriggerTool_MenuExperts.sh -up -release $p1_rel --l1_menu $l1menu --topo_menu $l1topo -hlt $hltmenu1 --hlt_setup $hlt__setup1 --name 'AthenaP1Test' -l INFO --SMcomment \"\\\"${rundate}${nightly}_${rel}\"\\\" --dbConn $DBConn -w_n 50 -w_t 60"
 
 echo $cmd "&> uploadSMK.log"
 eval $cmd &> uploadSMK.log
diff --git a/Trigger/TriggerCommon/TriggerMenu/CMakeLists.txt b/Trigger/TriggerCommon/TriggerMenu/CMakeLists.txt
index 9134646a8bf34061cc499c1132c28fbb0384997a..d2ab5c211d08ea861653e2f2a57db2e076d3cabb 100644
--- a/Trigger/TriggerCommon/TriggerMenu/CMakeLists.txt
+++ b/Trigger/TriggerCommon/TriggerMenu/CMakeLists.txt
@@ -10,9 +10,10 @@ atlas_install_python_modules( python/*.py python/menu python/l1
 python/l1menu python/l1topo python/l1topomenu python/egamma
 python/muon python/jet python/bjet python/met python/tau python/afp
 python/minbias python/heavyion python/bphysics python/calibcosmicmon
-python/test python/combined python/commonUtils )
+python/test python/combined python/commonUtils python/api )
 atlas_install_joboptions( share/*.py )
-atlas_install_scripts( scripts/generate*Menu.py scripts/menuTestTMC.sh )
+atlas_install_scripts( scripts/generate*Menu.py scripts/menuTestTMC.sh 
+scripts/generateUnprescaledLists.py )
 atlas_install_xmls( data/*.dtd data/*.xml )
 
 atlas_add_test( generateMenu SCRIPT scripts/testMenu.sh 
@@ -28,3 +29,71 @@ atlas_add_test ( pyflakesMenu
 atlas_add_test ( checkL1Menu SCRIPT scripts/checkL1Menu.sh
    POST_EXEC_SCRIPT "check_log.pl --config checklogTriggerTest.conf checkL1Menu.log"
 )
+
+# Function to create lowest-unprescaled lists
+function( atlas_run_lowestunprescaled )
+
+   # Don't do anything in release recompilation dryrun mode. In all other
+   # modes, proceed as usual.
+   if( ATLAS_RELEASE_RECOMPILE_DRYRUN )
+      return()
+   endif()
+
+   # Command to build the list of unprescaled triggers. 
+   # Algorithm copied from TriggerMenuXML
+   add_custom_command( OUTPUT ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.stamp
+      COMMAND ${CMAKE_COMMAND} -E touch
+      ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.attempted.stamp
+      COMMAND ${CMAKE_COMMAND} -E make_directory
+      ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled
+      COMMAND ${CMAKE_BINARY_DIR}/atlas_build_run.sh
+      ${CMAKE_RUNTIME_OUTPUT_DIRECTORY}/generateUnprescaledLists.py ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled
+      COMMAND ${CMAKE_COMMAND} -E make_directory
+      ${CMAKE_PYTHON_OUTPUT_DIRECTORY}/TriggerMenu
+      COMMAND ${CMAKE_COMMAND} -E copy_directory
+      ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled/
+      ${CMAKE_PYTHON_OUTPUT_DIRECTORY}/TriggerMenu/api/
+      COMMAND ${CMAKE_COMMAND} -E touch
+      ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.stamp
+      DEPENDS "Package_$<JOIN:$<TARGET_PROPERTY:ATLAS_PACKAGES_TARGET,ATLAS_PACKAGES>,;Package_>" )
+
+   # Create custom target and add it to package dependencies
+   add_custom_target( build_list_unprescaled ALL SOURCES
+      ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.stamp )
+
+   # In case the file generation failed, because it wasn't even attempted
+   install( CODE "if( NOT EXISTS
+                     ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.attempted.stamp )
+                     message( WARNING \"Generating trigger list of unprescaled items\"
+                              \" during the installation\" )
+                     execute_process( COMMAND ${CMAKE_COMMAND} -E touch
+                        ${CMAKE_CURRENT_BINARY_DIR}/unprescaled.attempted.stamp )
+                     execute_process(
+                        COMMAND ${CMAKE_COMMAND} -E make_directory
+                        ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled )
+                     execute_process(
+                        COMMAND ${CMAKE_BINARY_DIR}/atlas_build_run.sh
+                        ${CMAKE_RUNTIME_OUTPUT_DIRECTORY}/generateUnprescaledLists.py
+                        ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled )
+                  endif()" )
+
+   # Install the generated PYTHON files. Note that this installation rule is
+   # executed after the previous code. So by this time the files should be
+   # in place, if they could be produced.
+   install( DIRECTORY ${CMAKE_CURRENT_BINARY_DIR}/LowestUnprescaledLists/unprescaled/
+      DESTINATION ${CMAKE_INSTALL_PYTHONDIR}/TriggerMenu
+      USE_SOURCE_PERMISSIONS
+      FILES_MATCHING PATTERN "list*.py" )
+
+   # Create a target that will depend on all the other targets, and will
+   # print the "right message" at the end of the build.
+   if( NOT TARGET TriggerMenuMain )
+      add_custom_target( TriggerMenuMain ALL
+         COMMAND ${CMAKE_COMMAND} -E echo
+         "TriggerMenu: Package build succeeded" )
+   endif()
+   add_dependencies( TriggerMenuMain build_list_unprescaled )
+
+endfunction ( atlas_run_lowestunprescaled )
+
+atlas_run_lowestunprescaled ( )
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerAPI.py b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerAPI.py
new file mode 100644
index 0000000000000000000000000000000000000000..e1c4d3ca4b597bea89bd9dabf51be84ed6778c6b
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerAPI.py
@@ -0,0 +1,97 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Interface to retrieve lists of unprescaled triggers according to types and periods"
+
+import sys, pickle
+from TriggerMenu.api.TriggerInfo import TriggerInfo
+from TriggerMenu.api.TriggerEnums import TriggerPeriod, TriggerType
+
+class TriggerAPI:
+    pickleFile = "TriggerInfo.pickle"
+    try:
+        with open(pickleFile, 'r') as f:
+            dbQueries = pickle.load(f)
+    except Exception as e:
+        dbQueries = {}
+    
+    @classmethod
+    def getLowestUnprescaled(cls, period, triggerType=TriggerType.ALL, additionalTriggerType=TriggerType.UNDEFINED, matchPattern="", reparse=False):
+        ''' Returns a list of the lowest-pt-threshold HLT chains that were always unprescaled in the given period.
+            period: see TriggerEnums.TriggerPeriod for all possibilities, recommeded TriggerPeriod.y2017
+            triggerType: see TriggerEnums.TriggerType for all possibilities, example TriggerType.el_single
+            additionalTriggerType: can request additional types, use TriggerType.ALL to show combined triggers of any kind
+            matchPattern: provide additionally a regex-like expression to be applied
+        '''
+        cls._loadTriggerPeriod(period,reparse)
+        return cls.dbQueries[period]._getLowestUnprescaled(triggerType, additionalTriggerType, matchPattern)
+    
+    @classmethod
+    def getLowestUnprescaledAnyPeriod(cls, period, triggerType=TriggerType.ALL, additionalTriggerType=TriggerType.UNDEFINED, matchPattern="", reparse=False):
+        ''' Returns a list of the lowest-pt-threshold HLT chains that were unprescaled in at least one of 
+            the subperiods within the given period. The lowest granularity can be seen in TriggerEnums.TriggerPeriod
+            period: see TriggerEnums.TriggerPeriod for all possibilities, recommeded TriggerPeriod.y2017
+            triggerType: see TriggerEnums.TriggerType for all possibilities, example TriggerType.el_single
+            additionalTriggerType: can request additional types to match, use TriggerType.ALL to show combined triggers of any kind
+                                   accepts also a list as input in that case all types have to match
+            matchPattern: provide additionally a regex-like expression to be applied
+        '''
+        lowset = set()
+        for i, ibin in enumerate(reversed(bin(period)[2:])): #to binary
+            ibin = int(ibin)
+            if not ibin: continue
+            subperiod = 2**i
+            cls._loadTriggerPeriod(subperiod, reparse)
+            subperiodset = set( cls.dbQueries[subperiod]._getLowestUnprescaled(triggerType, additionalTriggerType, matchPattern) )
+            #print TriggerPeriod(subperiod), subperiodset
+            lowset |= subperiodset
+        return list(lowset)
+    
+    @classmethod
+    def getUnprescaled(cls, period, triggerType=TriggerType.ALL, additionalTriggerType=TriggerType.UNDEFINED, matchPattern="", reparse=False):
+        ''' Returns a list of always-unprescaled HLT chains, including backup items with higher thresholds.
+            period: see TriggerEnums.TriggerPeriod for all possibilities, recommeded TriggerPeriod.y2017
+            triggerType: see TriggerEnums.TriggerType for all possibilities, example TriggerType.el_single
+            additionalTriggerType: can request additional types, use TriggerType.ALL to show combined triggers of any kind
+            matchPattern: provide additionally a regex-like expression to be applied
+        '''
+        cls._loadTriggerPeriod(period,reparse)
+        return cls.dbQueries[period]._getUnprescaled(triggerType, additionalTriggerType, matchPattern)
+        
+    @classmethod
+    def getAllHLT(cls, period, triggerType=TriggerType.ALL, additionalTriggerType=TriggerType.UNDEFINED, matchPattern="", reparse=False):
+        ''' Returns a map of {HLT chains: average live fraction} for a given period.
+            The average live fraction is an approximation weighting the number of lumiblocks by prescale.
+            *** Don't use this number in analysis!!! ***
+            period: see TriggerEnums.TriggerPeriod for all possibilities, recommeded TriggerPeriod.y2017
+            triggerType: see TriggerEnums.TriggerType for all possibilities, example TriggerType.el_single
+            additionalTriggerType: can request additional types, use TriggerType.ALL to show combined triggers of any kind
+            matchPattern: provide additionally a regex-like expression to be applied
+        '''
+        cls._loadTriggerPeriod(period,reparse)
+        return cls.dbQueries[period]._getAllHLT(triggerType, additionalTriggerType, matchPattern)
+
+    @classmethod
+    def _loadTriggerPeriod(cls, period, reparse):
+        if period not in cls.dbQueries:
+            cls.dbQueries[period] = TriggerInfo(period)
+            if not period & TriggerPeriod.future or period >= TriggerPeriod.runNumber: 
+                #Don't pickle TM information since it can change, very cheap to retrieve anyway
+                with open(cls.pickleFile, 'w') as f:
+                    pickle.dump( cls.dbQueries , f)
+        if reparse: cls.dbQueries[period].reparse()
+
+def main():
+    ''' Run some tests '''
+    from TriggerEnums import TriggerPeriod, TriggerType
+    for triggerType in TriggerType:
+        unprescaled = TriggerAPI.getLowestUnprescaled(TriggerPeriod.y2017periodAll,triggerType)
+        #unprescaled = TriggerAPI.getLowestUnprescaled(332303,triggerType)
+        print triggerType
+        print sorted(unprescaled)
+    print TriggerAPI.getLowestUnprescaled(337833,TriggerType.mu_bphys,matchPattern="bJpsi")
+    print TriggerAPI.getLowestUnprescaled(337833,TriggerType.xe,matchPattern="pufit")
+
+if __name__ == "__main__":
+        sys.exit(main())
+
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerDataAccess.py b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerDataAccess.py
new file mode 100644
index 0000000000000000000000000000000000000000..2d233439d7addbf7898c5399b228e53cbc4e84fc
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerDataAccess.py
@@ -0,0 +1,347 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Access to Trigger DB and TriggerMenu to read past and future prescales"
+
+import sys
+from TriggerMenu.api.TriggerEnums import TriggerPeriod, LBexceptions
+from TriggerMenu.api.TriggerPeriodData import TriggerPeriodData
+
+def getRunLBFromU64(runlb):
+    run = runlb >> 32
+    lb = runlb & ((1L<<32)-1)
+    return ( int(run), int(lb) )
+
+
+def getReadyForPhysicsInRange(period):
+    """
+    returns all runs in the given period which have the ReadyForPhysics flag set in at least 1 LB
+    """
+
+    print "Loading COOL libs..."
+    from CoolLumiUtilities.CoolDataReader import CoolDataReader
+    print "Done loading libs, starting now ..."
+
+    myReader = CoolDataReader('COOLONL_TDAQ/CONDBR2', '/TDAQ/RunCtrl/DataTakingMode')
+    runsWithReady = {}
+
+    firstRun = min([x for x in period.keys()])
+    lastRun = max([x for x in period.keys()])+1
+    since = ((1L*firstRun) << 32)
+    until = ((1L*lastRun) << 32)
+
+    myReader.setIOVRange( since, until )
+    myReader.readData()
+    
+    for obj in myReader.data:
+        isReady = (obj.payload()['ReadyForPhysics'] == 1)
+        if not isReady:
+            continue
+        sincerun, sincelb = getRunLBFromU64(obj.since())
+        untilrun, untillb = getRunLBFromU64(obj.until())
+        if sincerun != untilrun:
+            print "WARNING: ready block crosses run boundaries:", sincerun, untilrun
+        if sincerun not in period: continue
+        #if untilrun not in runlist: print "WTF", sincerun, untilrun
+        if sincerun in runsWithReady:
+            runsWithReady[sincerun] += [ (sincelb, untillb) ]
+        else:
+            runsWithReady[sincerun] = [ (sincelb, untillb) ]
+
+    print runsWithReady
+
+    return runsWithReady
+
+
+def getKeys( listOfRuns, doPrint = False ):
+
+    from CoolLumiUtilities.CoolDataReader import CoolDataReader
+
+    keysByRun = {}
+
+    mySmkReader = CoolDataReader('COOLONL_TRIGGER/CONDBR2', '/TRIGGER/HLT/HltConfigKeys')
+    myL1pskReader = CoolDataReader('COOLONL_TRIGGER/CONDBR2', '/TRIGGER/LVL1/Lvl1ConfigKey')
+    myHltpskReader = CoolDataReader('COOLONL_TRIGGER/CONDBR2', '/TRIGGER/HLT/PrescaleKey')
+    #myBgskReader = CoolDataReader('COOLONL_TRIGGER/CONDBR2', '/TRIGGER/LVL1/BunchGroupKey')
+    
+    for run in sorted(listOfRuns):
+
+        listOfReadyBlocks = listOfRuns[run]
+
+        print "Getting keys for run %i, lbs %r" % (run, listOfReadyBlocks)
+
+        since = ((1L*run) << 32) 
+        until = ((1L*(run+1)) << 32)
+
+        # super master key
+        mySmkReader.setIOVRange( since, until - 1 )
+        mySmkReader.readData()
+        for obj in mySmkReader.data:
+            smk = obj.payload()['MasterConfigurationKey']
+            sincerun, sincelb = getRunLBFromU64(obj.since())
+            untilrun, untillb = getRunLBFromU64(obj.until())
+            keysByRun.setdefault(run,{})['smk'] = smk
+
+        for sincelb, untillb in listOfReadyBlocks:
+
+            since = ((1L*run) << 32) + sincelb
+            until = ((1L*run) << 32) + untillb
+
+            # l1 prescale keys
+            myL1pskReader.setIOVRange( since, until )
+            myL1pskReader.readData()
+            for obj in myL1pskReader.data:
+                l1psk = obj.payload()['Lvl1PrescaleConfigurationKey']
+                sincerun2, sincelb2 = getRunLBFromU64(obj.since())
+                untilrun2, untillb2 = getRunLBFromU64(obj.until())
+                if sincelb2 == untillb: break
+                keysByRun.setdefault(run,{}).setdefault('l1psk',[]).append((l1psk,sincerun2, sincelb2,untilrun2, untillb2-1)) #use same convention as GRL, last lb is included
+            
+            # hlt prescale keys
+            myHltpskReader.setIOVRange( since, until )
+            myHltpskReader.readData()
+            for obj in myHltpskReader.data:
+                hltpsk = obj.payload()['HltPrescaleKey']
+                sincerun2, sincelb2 = getRunLBFromU64(obj.since())
+                untilrun2, untillb2 = getRunLBFromU64(obj.until())
+                if sincelb2 == untillb: break
+                keysByRun.setdefault(run,{}).setdefault('hltpsk',[]).append((hltpsk,sincerun2, sincelb2,untilrun2, untillb2-1)) #use same convention as GRL, last lb is included
+
+            ## Bunch group key
+            #myBgskReader.setIOVRange( since, until )
+            #myBgskReader.readData()
+            #for obj in myBgskReader.data:
+            #    bgsk = obj.payload()['Lvl1BunchGroupConfigurationKey']
+            #    sincerun2, sincelb2 = getRunLBFromU64(obj.since())
+            #    untilrun2, untillb2 = getRunLBFromU64(obj.until())
+            #    keysByRun.setdefault(run,{}).setdefault('bgsk',[]).append(bgsk)
+
+    if doPrint:
+        print keysByRun
+
+    return keysByRun
+
+def getHLTPrescalesRun2(connection,psk):
+    """returns set name, prescale and passthrough 
+    values for a given HLT prescale key 
+    @connection - connection string, e.g. TRIGGERDB
+    @psk - HLT prescale key
+    @return (ps name, [('L2/EF',chainId,prescale,pass-through),...])
+    """
+
+    res = queryHLTPrescaleTableRun2(connection,psk)
+    return {r[0]:r[3] for r in res if r and r[1]=='Prescale'}
+
+def queryHLTPrescaleTableRun2(connection,psk):
+
+    from TrigConfigSvc.TrigConfigSvcUtils import getTriggerDBCursor, executeQuery
+
+    global cursor, schemaname
+    cursor,schemaname = getTriggerDBCursor(connection)
+
+    output = [ "PS.HPR_CHAIN_COUNTER", "PS.HPR_TYPE", "PS.HPR_CONDITION" , "PS.HPR_VALUE"]
+
+    tables = {}
+    tables['PS'] = 'HLT_PRESCALE' 
+
+    condition = [ "PS.HPR_PRESCALE_SET_ID = :psk" ]
+
+    bindvars = { "psk": psk }
+
+    res = executeQuery(cursor, output, condition, schemaname, tables, bindvars)
+
+    return res
+
+
+def fillHLTlist( info, hltList , lbCount, run, grlblocks):
+    from TrigConfigSvc.TrigConfigSvcUtils import getL1Items, getL1Prescales #, getHLTPrescalesRun2 #,getChains
+
+    items = getL1Items('TRIGGERDB', info['smk']) # returs map item name => CTP ID
+    chainsHLT = getChainsWithL1seed('TRIGGERDB', info['smk']) # returns map HLT ID => (HLT name, L1 seed)
+    chainsHLT = {k:v for (k,v) in chainsHLT.iteritems() if "L1" in v[1]}
+
+    #l1psname, l1prescales = getL1Prescales('TRIGGERDB', info['l1psk'][0][0]) # here only asking for the first LB prescale key
+    #l1prescales is a list of 512 prescales, also for IDs which were not used
+    #hltprescales = getHLTPrescalesRun2('TRIGGERDB', info['hltpsk'][0][0])
+    #hltprescales is a map HLTID -> prescale
+
+    tmphltList = []
+    for lbrange in info['hltpsk']:
+        lbstart, lbend = lbrange[2], lbrange[4]
+        if lbend ==0: lbend = 2000
+        hltprescales = getHLTPrescalesRun2('TRIGGERDB', lbrange[0])
+        tmphltList.append(( lbstart, lbend,hltprescales) )
+
+    tmpl1List = []
+    for lbrange in info['l1psk']:
+        lbstart, lbend = lbrange[2], lbrange[4]
+        if lbend ==0: lbend = 2000
+        l1psname, l1prescales = getL1Prescales('TRIGGERDB', lbrange[0])
+        l1prescales    = {l1name: l1prescales[int(l1id)] for (l1name, l1id) in items.iteritems()}
+        tmpl1List.append(( lbstart, lbend,l1prescales) )
+
+    ##if the lb limits don't match shut out and skip for the momenet
+    #if tmpl1List[0][0] != tmphltList[0][0] or tmpl1List[-1][1] != tmphltList[-1][1]:
+    #    print "FUCK", run, tmpl1List[0][:2], tmphltList[0][:2], tmpl1List[-1][:2], tmphltList[-1][:2]
+
+    #merge the lb ranges of HLT and L1
+    hltindex, l1index = 0,0
+    mergedList = []
+    while hltindex < len(tmphltList) and l1index < len(tmpl1List) :
+        if tmphltList[hltindex][1] == tmpl1List[l1index][1]:
+            lbstart, lbend = max(tmphltList[hltindex][0],tmpl1List[l1index][0]), tmphltList[hltindex][1]
+            mergedList.append((lbstart, lbend,tmphltList[hltindex][2],tmpl1List[l1index][2]))
+            hltindex += 1
+            l1index += 1
+        elif tmphltList[hltindex][1] > tmpl1List[l1index][1]:
+            lbstart, lbend = max(tmphltList[hltindex][0],tmpl1List[l1index][0]), tmpl1List[l1index][1]
+            mergedList.append((lbstart, lbend,tmphltList[hltindex][2],tmpl1List[l1index][2]))
+            l1index += 1
+        else:
+            lbstart, lbend = max(tmphltList[hltindex][0],tmpl1List[l1index][0]), tmphltList[hltindex][1]
+            mergedList.append((lbstart, lbend,tmphltList[hltindex][2],tmpl1List[l1index][2]))
+            hltindex += 1
+
+    hltMap = {}
+    for lbstart, lbend, hltprescales, l1prescales in mergedList:
+        lboverlap = max([min(lbend,grllbend) - max(lbstart,grllbstart) for (grllbstart,grllbend) in grlblocks])+1
+        if lboverlap <= 0:
+            #print "Rejected:",(lboverlap, lbstart, lbend, grlblocks)
+            continue
+        if run in LBexceptions.exceptions:
+            if any([lbstart>=exc_start and lbstart<=exc_end for exc_start, exc_end in LBexceptions.exceptions[run]]): continue
+
+        #print "Accepted:",(lboverlap, lbstart, lbend, grlblocks)
+        lbCount += lboverlap
+        for hltid, hltps in hltprescales.iteritems():
+            if hltid not in chainsHLT: continue
+            if hltps < 1: hltps = 1e10
+            l1seeds = chainsHLT[hltid][1]
+            l1ps = 1e10
+            for l1seed in l1seeds.split(","): #protect L1_MU20,L1_MU21
+                tmpl1ps = l1prescales[l1seed] 
+                if tmpl1ps < 1: tmpl1ps = 1e10
+                l1ps = min(l1ps, tmpl1ps)
+            
+            efflb = lboverlap/(hltps*l1ps)
+            if chainsHLT[hltid][0]  == "HLT_2mu6_bUpsimumu_L1BPH-8M15-2MU6_BPH-0DR22-2MU6" and (hltps*l1ps)>1:
+                print "HLT_mu50:",run,(lboverlap, lbstart, lbend, grlblocks),hltps,l1ps
+            if not chainsHLT[hltid][0] in hltMap: hltMap[chainsHLT[hltid][0]] = [l1seeds, 0]
+            hltMap[chainsHLT[hltid][0]][1] += efflb
+    
+    for i, (hlt,(l1,efflb)) in enumerate(hltList):
+        if hlt in hltMap: hltMap[hlt][1] += efflb
+        else: hltMap[hlt] = (l1, efflb)
+
+    return hltMap.items(), lbCount
+
+
+def getChainsWithL1seed(connection, smk):
+    '''copy of getChains but retrieving also the L1 seed and assuming always run2
+         https://gitlab.cern.ch/atlas/athena/blob/master/Trigger/TrigConfiguration/TrigConfigSvc/python/TrigConfigSvcUtils.py#L611
+    '''
+    from TrigConfigSvc.TrigConfigSvcUtils import getTriggerDBCursor, executeQuery
+    cursor,schemaname = getTriggerDBCursor(connection)
+         
+    output = ['TC.HTC_ID', 'TC.HTC_CHAIN_COUNTER', 'TC.HTC_NAME', 'TC.HTC_LOWER_CHAIN_NAME']
+    tables = {}
+    tables['SM']    = 'SUPER_MASTER_TABLE'
+    tables['M2C']     = 'HLT_TM_TO_TC'
+    tables['TC']    = 'HLT_TRIGGER_CHAIN'
+    tables['MT']    = 'HLT_MASTER_TABLE'
+
+    condition = [ "SM.SMT_ID = :smk",
+                    'SM.SMT_HLT_MASTER_TABLE_ID = MT.HMT_ID',
+                    'MT.HMT_TRIGGER_MENU_ID = M2C.HTM2TC_TRIGGER_MENU_ID',
+                    'M2C.HTM2TC_TRIGGER_CHAIN_ID = TC.HTC_ID' ]
+    
+    bindvars = { "smk": smk }
+    
+    res = executeQuery(cursor, output, condition, schemaname, tables, bindvars)
+    
+    chainsef = {}
+    for x in res:
+        if len(x)!=4: continue #protect against HLT_noalg_bkg_L1Bkg and similars
+        chainsef[x[1]] = (x[2],x[3])
+
+    return chainsef
+
+
+
+def getHLTlist_fromDB(period):
+    ''' Return a list of (HLT chain, L1 seed, average prescale ) for a given period
+        The average prescale is an approximation weighting the PS by number of lumiblocks.
+        *** Don't use this number in analysis!!! ***
+    '''
+    
+    triggerPeriod = TriggerPeriodData( period ).grl
+    runsWithReadyForPhysics = getReadyForPhysicsInRange(triggerPeriod)
+    keys = getKeys( runsWithReadyForPhysics)
+    
+    # get keys for last run
+    #lastRun = sorted(keys.keys())[-1:]
+    #lastRuns = sorted(keys.keys())[-10:]
+    #print "Checking run:",lastRun
+    hltList = []
+    lbCount = 0
+    for run in keys:
+        print "Filling run:",run
+        hltList, lbCount = fillHLTlist( keys[run], hltList, lbCount , run, triggerPeriod[run])
+        #print "After filling, items/lbCount: ",len(hltList),lbCount
+        #print "mu26_ivarmedium items:",[(x, l1, ps) for x, (l1, ps) in hltList if "mu26_ivarmedium" in x]
+
+    return [(x, l1, ps/float(lbCount)) for x, (l1, ps) in hltList]
+    
+    return 0
+
+def getHLTlist_fromTM(period):
+    ''' Return a list of (HLT chain, L1 seed, prescale ) for a given period
+        Only "Future" periods make sense here
+        The format is the same as for TriggerDBAccess for compatibility but the l1seeds are empty
+    '''
+    from TriggerMenu.menu import Physics_pp_v7
+    from TriggerJobOpts.TriggerFlags import TriggerFlags
+    
+    Physics_pp_v7.setupMenu()
+    if not period & TriggerPeriod.future: return []
+    maxlumi = 20000
+    if   period & TriggerPeriod.future1p8e34: maxlumi = 17000
+    elif period & TriggerPeriod.future2e34:   maxlumi = 20000
+    else: print "Warning non-recongnized future",period
+
+    hltList = []
+    for prop in dir(TriggerFlags):
+        if prop[-5:]!='Slice': continue
+        sliceName=prop
+        m_slice=getattr(TriggerFlags,sliceName)
+        for m in m_slice.signatures():
+            #['mu28_ivarmedium',      'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream], ['Primary:20000','RATE:SingleMuon', 'BW:Muon'], -1],
+            hltname = 'HLT_'+m[0]
+            l1seed  = m[1]
+            comment = m[4][0]
+            ps = 1e10
+            if maxlumi <= 20000 and 'Primary:20000' in comment: ps = 1
+            if maxlumi <= 17000 and 'Primary:17000' in comment: ps = 1
+            hltList.append( (hltname, l1seed, ps) )
+        
+    return hltList
+
+def getHLTlist(period):
+    ''' Return a list of (HLT chain, L1 seed, average prescale ) for a given period
+        The average prescale is an approximation weighting the PS by number of lumiblocks.
+        *** Don't use this number in analysis!!! ***
+        For "future" periods, the average prescale is 1 for items flagged as primary in TM and 1e10 for non-primaries
+    '''
+    if not period & TriggerPeriod.future or period >= TriggerPeriod.runNumber: 
+        hltlist = getHLTlist_fromDB(period)
+    else:
+        hltlist = getHLTlist_fromTM(period)
+    
+    vetoes = ['calib','noise','noalg','EMPTY','UNPAIRED']
+    return [(name, l1seed,ps) for name, l1seed,ps in hltlist if not any(v in name for v in vetoes)]
+
+def test():
+    print getHLTlist(TriggerPeriod.y2017)
+
+if __name__ == "__main__":
+    sys.exit(test())
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerEnums.py b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerEnums.py
new file mode 100644
index 0000000000000000000000000000000000000000..dab38cd9752e872e8d3664057f24b8d436cf84ce
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerEnums.py
@@ -0,0 +1,76 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Enumerations for trigger types and periods"
+
+from enum import IntEnum
+
+class TriggerType(IntEnum):
+    el_single  = 1 << 0
+    el_multi   = 1 << 1
+    mu_single  = 1 << 2
+    mu_multi   = 1 << 3
+    j_single   = 1 << 4
+    j_multi    = 1 << 5
+    bj_single  = 1 << 6
+    bj_multi   = 1 << 7
+    tau_single = 1 << 8
+    tau_multi  = 1 << 9
+    g_single   = 1 << 10
+    g_multi    = 1 << 11
+    xe         = 1 << 12
+    ht         = 1 << 13
+    mu_bphys   = 1 << 14
+    exotics    = 1 << 15
+
+    el          = el_single | el_multi
+    mu          = mu_single | mu_multi
+    j           = j_single  | j_multi
+    bj          = bj_single | bj_multi
+    tau         = tau_single| tau_multi
+    g           = g_single  | g_multi
+
+    ALL         = el | mu | j | bj | tau | g | xe | ht | mu_bphys | exotics
+    UNDEFINED  = 0
+
+
+class TriggerPeriod(IntEnum):
+    y2015             = 1 << 0
+    y2016periodAD3    = 1 << 1
+    y2016periodD4plus = 1 << 2
+    y2017periodB1     = 1 << 3
+    y2017periodB2B4   = 1 << 4
+    y2017periodB5B7   = 1 << 5
+    y2017periodB8     = 1 << 6
+    y2017periodC      = 1 << 7
+    y2017periodD1D5   = 1 << 8
+    y2017periodD6     = 1 << 9
+    y2017periodE      = 1 << 10
+    y2017periodF      = 1 << 11
+    y2017periodGHI    = 1 << 12
+    future1p8e34      = 1 << 13
+    future2e34        = 1 << 14
+    runNumber         = 1 << 18 #Can't get higher than this
+
+    y2017periodB      = y2017periodB1   | y2017periodB2B4 | y2017periodB5B7 | y2017periodB8
+    y2017periodD      = y2017periodD1D5 | y2017periodD6
+    y2017periodDplus  = y2017periodD    | y2017periodE    | y2017periodF    | y2017periodGHI
+    y2017periodAll    = y2017periodB    | y2017periodC    | y2017periodDplus
+    y2017             = y2017periodAll
+    y2016             = y2016periodAD3  | y2016periodD4plus
+    future            = future1p8e34    | future2e34
+
+class LBexceptions:
+    ''' List of LBs to be skipped. 
+        Usually due to accidental prescales that will be taken into account in future GRLs or via reduced luminosity.
+        Users can modify this if needed, but hopefully there is no need ;)
+    '''
+    # Run number: [(LB start, LB end), ...] both inclusive
+    exceptions = {
+       276262: [(72 , 75 )], #toroid off keys 
+       281317: [(116, 118)], #toroid off keys 
+       299055: [(650, 700)], #Toroid was going down, turned muons off
+       301932: [(233, 234)], #Accidentaly moved to MuScan prescales
+       302831: [(4  , 10 )], #toroid off keys 
+       336506: [(212, 260)], #Regular muscan but the defect is not in sync with the switch of keys
+       }
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerInfo.py b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerInfo.py
new file mode 100644
index 0000000000000000000000000000000000000000..a613aca39b1491e1c6bf53ceb9f8bfe0ecfe31d2
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerInfo.py
@@ -0,0 +1,412 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Class containing all the information of an HLT chain"
+
+import re
+from TriggerMenu.api.TriggerEnums import TriggerType
+
+class TriggerInfo:
+    ''' Object containing all the HLT information related to a given period.
+        Stores a list of TriggerChain objects and the functions to skim them
+    '''
+    def __init__(self,period):
+        self.triggerChains = []
+        self.period = period
+
+        from TriggerDataAccess import getHLTlist
+        HLTlist = getHLTlist(period)
+        for hlt, l1, ps in HLTlist:
+            self.triggerChains.append( TriggerChain(hlt, l1, ps))
+
+    def reparse(self):
+        self.triggerChains = [ TriggerChain(t.name, t.l1seed, t.prescale) for t in self.triggerChains ]
+
+    def _getUnprescaled(self,triggerType, additionalTriggerType, matchPattern):
+        return [x.name for x in self.triggerChains if x.isUnprescaled() and x.passType(triggerType, additionalTriggerType) and re.search(matchPattern, x.name)]
+
+    def _getLowestUnprescaled(self,triggerType, additionalTriggerType, matchPattern):
+        chainList = [ x for x in self.triggerChains if x.isUnprescaled() and x.passType(triggerType, additionalTriggerType) and re.search(matchPattern, x.name)]
+        typeMap = {}
+        for chain in chainList:
+            if chain.triggerType not in typeMap:
+                typeMap[chain.triggerType] = [chain]
+                continue
+            append = False
+            for other in typeMap[chain.triggerType][:]:
+                comp = chain.isLowerThan(other)
+                if comp ==  0: 
+                    append = False
+                    break
+                append = True
+                if comp ==  1:    typeMap[chain.triggerType].remove(other)
+            if append:
+                typeMap[chain.triggerType].append(chain)
+        return [x.name for t in typeMap.itervalues() for x in t ]
+
+
+    def _getAllHLT(self,triggerType, additionalTriggerType, matchPattern):
+        return {x.name: x.prescale for x in self.triggerChains if x.passType(triggerType, additionalTriggerType) and re.search(matchPattern, x.name)}
+
+
+class TriggerLeg:
+    types          = ('e','j','mu','tau','xe','g','ht')
+    legpattern     = re.compile('([0-9]*)(%s)([0-9]+)' % '|'.join(types))
+    detailpattern  = re.compile('(?:-?\d+)|(?:[^0-9|-]+)')
+    bjetpattern    = re.compile('bmv')
+    bphyspattern   = re.compile('b[A-Z]')
+    exoticspattern = re.compile('llp|LLP|muvtx|hiptrt|LATE|NOMATCH')
+
+    def __init__(self,legname, chainseed, chainname):
+        self.legname = legname
+        self.details = []
+        self.l1seed = ""
+        chainseed= chainseed.replace("L1_","")
+        blocks = legname.split("_L1")
+
+        for token in blocks[0].split("_"):
+            m = self.legpattern.match(token)
+            if m:
+                count,legtype,thr = m.groups()
+                self.count = int(count) if count else 1
+                self.thr = int(thr)
+                if legtype == 'e':
+                    if self.count > 1: self.legtype = TriggerType.el_multi
+                    else:              self.legtype = TriggerType.el_single
+                elif legtype == 'mu':
+                    if self.count > 1: self.legtype = TriggerType.mu_multi
+                    else:              self.legtype = TriggerType.mu_single
+                elif legtype == 'j':
+                    if self.count > 1: self.legtype = TriggerType.j_multi
+                    else:              self.legtype = TriggerType.j_single
+                elif legtype == 'tau':
+                    if self.count > 1: self.legtype = TriggerType.tau_multi
+                    else:              self.legtype = TriggerType.tau_single
+                elif legtype == 'g':
+                    if self.count > 1: self.legtype = TriggerType.g_multi
+                    else:              self.legtype = TriggerType.g_single
+                elif legtype == 'xe':
+                    self.legtype = TriggerType.xe
+                elif legtype == 'ht':
+                    self.legtype = TriggerType.ht
+                else:
+                    print "Unknown trigger type:",legtype
+            else:
+                if self.bjetpattern.match(token):
+                    if self.legtype == TriggerType.j_single: self.legtype = TriggerType.bj_single
+                    if self.legtype == TriggerType.j_multi:  self.legtype = TriggerType.bj_multi
+                if self.bphyspattern.match(token):
+                    self.legtype = TriggerType.mu_bphys
+                if self.exoticspattern.search(token):
+                    self.legtype = TriggerType.exotics
+                self.details.append(token)
+
+        for l1seed in blocks[1:]:
+            if self.exoticspattern.search(l1seed):
+                self.legtype = TriggerType.exotics
+            if l1seed == chainseed: continue
+            else: 
+                assert self.l1seed=="", (self.l1seed, chainseed, chainname, blocks[1:])
+                self.l1seed = l1seed
+        if not self.l1seed: self.l1seed = chainseed
+
+    def __repr__(self):
+        return self.legname+" {0:b}".format(self.legtype)
+
+    def isLegLowerThan(self, other, debug=False):
+        ''' Returns -9 if none of them is lower than the other (e.g. different met flavour).
+            Returns -1 if identical
+            Returns  0 if other is lower than self.
+            Returns  1 if self  is lower than other.
+        '''
+        if debug:
+            print "DEBUG LEGS --------"
+            print self.legname, other.legname
+            print self.legtype, other.legtype
+            print self.l1seed, other.l1seed
+            print self.details, other.details
+            print self.thr, other.thr
+            print self.compareDetails(other, debug=True)
+            print self.details == other.details
+            print "DEBUG LEGS END --------"
+
+        if self.legtype != other.legtype: return -9
+        if self.compareDetails(other) == -1:
+            if self.thr < other.thr: return 1
+            if self.thr > other.thr: return 0
+            else: return -1
+
+        if self.compareDetails(other) == 1 and self.thr  <= other.thr: return 1
+        if self.compareDetails(other) == 0 and other.thr <= self.thr:  return 0
+        return -9
+
+    def compareDetails(self, other, debug=False):
+        ''' Returns -9 if none of them is lower than the other (e.g. different met flavour).
+            Returns -1 if identical
+            Returns  0 if other is lower than self.
+            Returns  1 if self  is lower than other.
+        '''
+        from copy import deepcopy
+
+        if debug: print "compareDetails:",len(self.details), len(other.details),(self.l1seed == other.l1seed),(self.details == other.details) 
+        if len(self.details) != len(other.details): 
+            if any([x.startswith("nod0") for x in self.details]):
+                cloneself = deepcopy(self)
+                cloneself.details = [ x for x in self.details if not x.startswith("nod0")]
+                compno = cloneself.compareDetails(other,debug)
+                if compno ==1 or compno == -1: 
+                    #print "About to return 1",self.legname, other.legname
+                    return 1
+            if any([x.startswith("nod0") for x in other.details]):
+                cloneother = deepcopy(other)
+                cloneother.details = [ x for x in other.details if not x.startswith("nod0")]
+                compno = self.compareDetails(cloneother,debug)
+                if compno ==0 or compno == -1:
+                    #print "About to return 0",self.legname, other.legname
+                    return 0
+            if any([x.startswith("cut") for x in self.details]):
+                cloneself = deepcopy(self)
+                cloneself.details = [ x for x in self.details if not x.startswith("cut")]
+                compno = cloneself.compareDetails(other,debug)
+                if compno ==0 or compno == -1: 
+                    #print "About to return 0",self.legname, other.legname
+                    return 0
+            if any([x.startswith("cut") for x in other.details]):
+                cloneother = deepcopy(other)
+                cloneother.details = [ x for x in other.details if not x.startswith("cut")]
+                compno = self.compareDetails(cloneother,debug)
+                if compno ==1 or compno == -1:
+                    #print "About to return 1",self.legname, other.legname
+                    return 1
+            return -9
+        compl1seed  = self.compareTags(self.l1seed, other.l1seed, stringSubset=True, debug=debug)
+        compdetails = self.compareTags("".join(self.details), "".join(other.details), debug=debug )
+        if self.l1seed == other.l1seed:
+            if self.details == other.details: return -1
+            if debug: print "compareTags 1:",compdetails
+            return compdetails
+
+        if self.details == other.details:
+            if debug: print "compareTags 2:",compl1seed
+            return compl1seed
+
+        if compl1seed == compdetails:
+            return compl1seed
+        return -9
+
+    def compareTags(self, tag1, tag2, stringSubset=False,debug=False):
+        def mycomp(x,y):
+            ''' Return -9 for different strings, 
+                -1 for identical strings/nums, 
+                0/1 for high/low numbers or string subsets
+            '''
+            try: 
+                x,y = int(x), int(y)
+                if x < y: return 1
+                elif x > y: return 0
+                else: return -1
+            except ValueError: 
+                if x==y: return -1
+                if x == y.replace("vloose","loose"): return 0
+                if x == y.replace("vloose","loose").replace("loose","medium"): return 0
+                if x == y.replace("vloose","loose").replace("loose","medium").replace("medium","tight"): return 0
+                if y == x.replace("vloose","loose"): return 1
+                if y == x.replace("vloose","loose").replace("loose","medium"): return 1
+                if y == x.replace("vloose","loose").replace("loose","medium").replace("medium","tight"): return 1
+                if stringSubset:
+                    if x in y: return 1
+                    if y in x: return 0
+                return -9
+
+        if tag1 == tag2: return -1
+        #lower mv2 values are tighter, put a minus sign to trick it
+        tag1 = tag1.replace("mv2c","mv2c-")
+        tag2 = tag2.replace("mv2c","mv2c-")
+        #only make a statement on the numerical values, with everything else identical
+        reself  = self.detailpattern.findall(tag1)
+        reother = self.detailpattern.findall(tag2)
+
+        if len(reself) != len(reother): return -9
+        thecomp = [mycomp(a,b) for a,b in zip(reself,reother)]
+        if debug: print "thecomp:",thecomp,reself,reother
+        if any([x == -9 for x in thecomp]): return -9
+        if all([x !=0 for x in thecomp]) and any([x == 1 for x in thecomp]): return 1
+        if all([x !=1 for x in thecomp]) and any([x == 0 for x in thecomp]): return 0
+        return -9
+
+    @classmethod
+    def parse_legs(cls,name,l1seed,chainname):
+        legsname = []
+        name = name.replace("HLT_","")
+        for token in name.split("_"):
+            m = cls.legpattern.match(token)
+            if m:
+                legsname.append(token)
+            elif legsname: 
+                legsname[-1] += "_"+token
+            else: #first token doesn't match
+                #print "parse_legs: Problem parsing",name
+                return []
+        return [TriggerLeg(l,l1seed,chainname) for l in legsname]
+
+class TriggerChain:
+    l1types        = ('EM','J','MU','TAU','XE','XS','HT')
+    l1pattern      = re.compile('([0-9]*)(%s)([0-9]+)' % '|'.join(l1types))
+
+    def __init__(self,name,l1seed,prescale):
+        self.name = name
+        self.l1seed = l1seed
+        tmplegs = TriggerLeg.parse_legs(name,l1seed,name)
+        self.legs = self.splitAndOrderLegs(tmplegs)
+        self.prescale = prescale
+        self.triggerType = self.getTriggerType(self.legs, l1seed)
+
+    def splitAndOrderLegs(self, legs):
+        from copy import deepcopy
+        newLegs = []
+        for triggerType in TriggerType:
+            for l in legs:
+                if not l.legtype == triggerType: continue
+                for i in range(l.count):
+                    tmp = deepcopy(l)
+                    tmp.count = 1
+                    if tmp.legtype & TriggerType.el_multi:
+                        tmp.legtype |=  TriggerType.el_single
+                        tmp.legtype &= ~TriggerType.el_multi
+                    elif tmp.legtype & TriggerType.mu_multi:
+                        tmp.legtype |=  TriggerType.mu_single
+                        tmp.legtype &= ~TriggerType.mu_multi
+                    elif tmp.legtype & TriggerType.tau_multi:
+                        tmp.legtype |=  TriggerType.tau_single
+                        tmp.legtype &= ~TriggerType.tau_multi
+                    elif tmp.legtype & TriggerType.j_multi:
+                        tmp.legtype |=  TriggerType.j_single
+                        tmp.legtype &= ~TriggerType.j_multi
+                    elif tmp.legtype & TriggerType.bj_multi:
+                        tmp.legtype |=  TriggerType.bj_single
+                        tmp.legtype &= ~TriggerType.bj_multi
+                    elif tmp.legtype & TriggerType.g_multi:
+                        tmp.legtype |=  TriggerType.g_single
+                        tmp.legtype &= ~TriggerType.g_multi
+                    newLegs.append(tmp)
+        return newLegs
+
+    def getTriggerType(self, legs, l1seed):
+        mtype = TriggerType.UNDEFINED
+        for l in legs:
+            if mtype & TriggerType.el and l.legtype & TriggerType.el:
+                mtype |=  TriggerType.el_multi
+                mtype &= ~TriggerType.el_single
+            elif mtype & TriggerType.mu and l.legtype & TriggerType.mu:
+                mtype |=  TriggerType.mu_multi
+                mtype &= ~TriggerType.mu_single
+            elif mtype & TriggerType.tau and l.legtype & TriggerType.tau:
+                mtype |=  TriggerType.tau_multi
+                mtype &= ~TriggerType.tau_single
+            elif mtype & TriggerType.j and l.legtype & TriggerType.j:
+                mtype |=  TriggerType.j_multi
+                mtype &= ~TriggerType.j_single
+            elif mtype & TriggerType.bj and l.legtype & TriggerType.bj:
+                mtype |=  TriggerType.bj_multi
+                mtype &= ~TriggerType.bj_single
+            elif mtype & TriggerType.g and l.legtype & TriggerType.g:
+                mtype |=  TriggerType.g_multi
+                mtype &= ~TriggerType.g_single
+            elif l.legtype & TriggerType.mu_bphys:
+                mtype |=  TriggerType.mu_bphys
+                mtype &= ~(TriggerType.mu_single | TriggerType.mu_multi)
+            elif l.legtype & TriggerType.exotics:
+                mtype |=  TriggerType.exotics
+            else:
+                mtype |= l.legtype
+
+        l1seed= l1seed.replace("L1_","")
+        for token in l1seed.split("_"):
+            m = self.l1pattern.match(token)
+            if m:
+                count,legtype,thr = m.groups()
+                count = int(count) if count else 1
+                if legtype == 'EM':
+                    assert(mtype & TriggerType.g or mtype & TriggerType.el or mtype & TriggerType.exotics), (legtype, mtype, self.name)
+                elif legtype == 'MU':
+                    if count > 1: mtype |= TriggerType.mu_multi
+                    elif not mtype & TriggerType.mu_multi: mtype |= TriggerType.mu_single
+                elif legtype == 'TAU':
+                    assert(mtype & TriggerType.tau or mtype & TriggerType.exotics), (legtype, mtype, self.name)
+                elif legtype == 'J':
+                    if not mtype & TriggerType.bj and not mtype & TriggerType.j and not mtype & TriggerType.tau and not mtype & TriggerType.ht:
+                        if count > 1: mtype |= TriggerType.j_multi
+                        elif not mtype & TriggerType.j_multi: mtype |= TriggerType.j_single
+                elif legtype == 'XE' or legtype == 'XS':
+                    mtype |= TriggerType.xe
+                elif legtype == 'HT':
+                    mtype |= TriggerType.ht
+                else:
+                    print "Unknown trigger type:",legtype
+        return mtype
+
+    def isUnprescaled(self):
+        return self.prescale == 1 
+
+    def getType(self):
+        return self.triggerType
+
+    def passType(self, triggerType, additionalTriggerType):
+        if self.triggerType == TriggerType.UNDEFINED: return False
+        if self.triggerType == TriggerType.ALL:       return True
+        match   = (self.triggerType & triggerType)
+        if not match: return False
+        tmpType = self.triggerType & ~triggerType
+
+        try: 
+            for t in additionalTriggerType:
+                match   = (tmpType & t)
+                if not match: return False
+                tmpType = tmpType & ~t
+        except TypeError: #Not iterable
+            if additionalTriggerType!=TriggerType.UNDEFINED:
+                match   = (tmpType & additionalTriggerType)
+                if not match: return False
+                tmpType = tmpType & ~additionalTriggerType
+
+        return tmpType == TriggerType.UNDEFINED #After matches nothing remains
+
+    def __repr__(self):
+        print self.name, self.legs, "{0:b}".format(self.triggerType), self.prescale
+        return ""
+
+    def isLowerThan(self, other):
+        ''' Returns -1 if none of them is lower than the other (e.g. asymmetric dilepton).
+            Returns  0 if other is lower than self.
+            Returns  1 if self  is lower than other.
+        '''
+        if self.triggerType != other.triggerType: return -1
+        if len(self.legs) != len(other.legs): return -1
+        comp = -1
+        debug = False
+        #if re.search("HLT_j55_gsc75_bmv2c1040_split_3j55_gsc75_boffperf_split", self.name): debug = True
+        if debug: print "DEBUG:",self.name,other.name
+        for selfleg, otherleg in zip(self.legs, other.legs):
+            legcomp = selfleg.isLegLowerThan(otherleg, debug)
+            if debug: print "DEBUG LEG return:", legcomp
+            if legcomp == -9: return -1
+            elif legcomp == -1: continue
+            elif legcomp == 0 and comp == 1: return -1
+            elif legcomp == 1 and comp == 0: return -1
+            elif legcomp == 0 : comp = 0
+            elif legcomp == 1 : comp = 1
+        if debug: print "DEBUG FINAL:",comp
+        return comp
+
+
+def test():
+    a = TriggerChain("HLT_j50_gsc65_bmv2c1040_split_3j50_gsc65_boffperf_split", "L1J100",1)
+    print a
+    print bin(a.getType())
+    print a.passType(TriggerType.j_multi, TriggerType.UNDEFINED)
+    print a.passType(TriggerType.j_multi | TriggerType.bj_single, TriggerType.UNDEFINED)
+    print a.isUnprescaled()
+
+if __name__ == "__main__":
+    import sys
+    sys.exit(test())
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerPeriodData.py b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerPeriodData.py
new file mode 100644
index 0000000000000000000000000000000000000000..d7bc9e3329dbbbaa07ceafaaeb2de3503fcfae2b
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/TriggerPeriodData.py
@@ -0,0 +1,148 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Class defining data periods and access to GRLs"
+
+import sys
+import xml.etree.ElementTree as ET
+from TriggerMenu.api.TriggerEnums import TriggerPeriod
+
+class TriggerPeriodData:
+    # From https://atlas-tagservices.cern.ch/tagservices/RunBrowser/runBrowserReport/rBR_Period_Report.php?fnt=data17_13TeV
+    # period: start,end,maxlumi
+    periodMap2015 = {
+        'All' :(276262, 284484, 0)
+    }
+    periodMap2016 = {
+        'AD3' :(296939,302872,0),
+        'D4plus' :(302919,311481,0),
+    }
+    periodMap2017 = {
+        'B' :(325713,328393,15815),
+        'B1':(325713,325790,3216),
+        'B2':(326439,326439,22.4),
+        'B3':(326446,326551,7008),
+        'B4':(326657,326695,6199),
+        'B5':(326834,326945,7915),
+        'B6':(327057,327265,11202),
+        'B7':(327342,327490,14642),
+        'B8':(327582,328393,15815),
+        'C' :(329385,330470,16776),
+        'C1':(329385,329484,289),
+        'C2':(329542,329542,3422),
+        'C3':(329716,329778,7729),
+        'C4':(329780,329964,13293),
+        'C5':(330025,330203,16365),
+        'C6':(330294,330294,14993),
+        'C7':(330328,330328,7213),
+        'C8':(330470,330470,16776),
+        'D' :(330857,332304,17466),
+        'D1':(330857,330875,2.77),
+        'D2':(331019,331020,3800),
+        'D3':(331033,331239,16242),
+        'D4':(331462,331479,15952),
+        'D5':(331697,331975,16385),
+        'D6':(332303,332304,17466),
+        'E' :(332720,334779,14059),
+        'E1':(332720,332896,3485),
+        'E2':(332915,333192,9599),
+        'E3':(333367,333487,10230),
+        'E4':(333519,333650,10534),
+        'E5':(333707,333979,9515),
+        'E6':(333994,333994,14059),
+        'E7':(334264,334580,9745),
+        'E8':(334588,334779,9061),
+        'F' :(334842,335290,12070),
+        'F1':(334842,334907,10643),
+        'F2':(334960,335022,11067),
+        'F3':(335056,335082,12070),
+        'F4':(335083,335170,10520),
+        'F5':(335177,335290,10658),
+        'G' :(335302,335302,1658),
+        'G1':(335302,335302,1658),
+        'H' :(336497,336782,14165),
+        'H1':(336497,336497,306),
+        'H2':(336505,336505,4224),
+        'H3':(336506,336548,11603),
+        'H4':(336567,336782,14165),
+        'I' :(336832,337833,18456),
+        'I1':(336832,337005,16400),
+        'I2':(337052,337215,17078),
+        'I3':(337263,337833,18456),
+    }
+    
+    grlroot = "/cvmfs/atlas.cern.ch/repo/sw/database/GroupData/GoodRunsLists/"
+    y2017grlpath = grlroot+"data17_13TeV/20171019/data17_13TeV.periodAllYear_DetStatus-v95-pro21-09_Unknown_PHYS_StandardGRL_All_Good_25ns_Triggerno17e33prim.xml"
+    y2016grlpath = grlroot+"data16_13TeV/20170605/data16_13TeV.periodAllYear_DetStatus-v89-pro21-01_DQDefects-00-02-04_PHYS_StandardGRL_All_Good_25ns.xml"
+    y2015grlpath = grlroot+"data15_13TeV/20170619/data15_13TeV.periodAllYear_DetStatus-v89-pro21-02_Unknown_PHYS_StandardGRL_All_Good_25ns.xml"
+    def __init__(self, period):
+        if period & TriggerPeriod.y2015: 
+            self.loadGRL(self.y2015grlpath)
+        elif period & TriggerPeriod.y2016: 
+            self.loadGRL(self.y2016grlpath)
+        elif period & TriggerPeriod.y2017: 
+            self.loadGRL(self.y2017grlpath)
+        else: #run number assume 2017
+            self.loadGRL(self.y2017grlpath)
+        self.skimPeriod(period)
+
+    def loadGRL(self, grlpath):
+        grlroot = ET.parse(grlpath).getroot()
+        self.grl = {}
+        for run in grlroot.findall('NamedLumiRange/LumiBlockCollection'):
+            self.grl[ int(run.find('Run').text)] = [(int(x.get('Start')), int(x.get('End'))) for x in run.findall('LBRange')]
+
+    def skimPeriod(self, period):
+        if period >= TriggerPeriod.runNumber:
+            if period in self.grl:
+                blocks = self.grl[period]
+                self.grl = {}
+                self.grl[period] = blocks
+            else:
+                self.grl = {}
+                self.grl[period] = [(0,9999)]
+        else:
+            ranges = []
+            if period & TriggerPeriod.y2015     :
+                ranges.append( self.periodMap2015['All'] )
+            if period & TriggerPeriod.y2016     :
+                ranges.append( self.periodMap2016['AD3'] )
+                ranges.append( self.periodMap2016['D4plus'] )
+            if period & TriggerPeriod.y2017periodB1:
+                ranges.append( self.periodMap2017['B1'] )
+            if period & TriggerPeriod.y2017periodB2B4:
+                for i in range(2,4+1): ranges.append( self.periodMap2017['B%d' %i] )
+            if period & TriggerPeriod.y2017periodB5B7:
+                for i in range(5,7+1): ranges.append( self.periodMap2017['B%d' %i] )
+            if period & TriggerPeriod.y2017periodB8     :
+                ranges.append( self.periodMap2017['B8'] )
+            if period & TriggerPeriod.y2017periodC     :
+                for i in range(1,8+1): ranges.append( self.periodMap2017['C%d' %i] )
+            if period & TriggerPeriod.y2017periodD1D5:
+                for i in range(1,5+1): ranges.append( self.periodMap2017['D%d' %i] )
+            if period & TriggerPeriod.y2017periodD6     :
+                ranges.append( self.periodMap2017['D6'] )
+            if period & TriggerPeriod.y2017periodE     :
+                ranges.append( self.periodMap2017['E'] )
+            if period & TriggerPeriod.y2017periodF     :
+                ranges.append( self.periodMap2017['F'] )
+            if period & TriggerPeriod.y2017periodGHI :
+                ranges.append( self.periodMap2017['G'] )
+                ranges.append( self.periodMap2017['H'] )
+                ranges.append( self.periodMap2017['I'] )
+            for run in self.grl.keys()[:]:
+                if not any([run >= x[0] and run <= x[1] for x in ranges]): self.grl.pop(run)
+
+def test():
+    #root = TriggerPeriod.y2017grlroot
+    #print root.tag, root.attrib
+    #for child in root:
+    #    print child.tag, child.attrib
+
+    #for run in root.findall('NamedLumiRange/LumiBlockCollection'):
+    #    print run.find('Run').text, [(x.get('Start'), x.get('End')) for x in run.findall('LBRange')]
+    print TriggerPeriodData( TriggerPeriod.y2015 ).grl
+
+if __name__ == "__main__":
+    sys.exit(test())
+
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/api/__init__.py b/Trigger/TriggerCommon/TriggerMenu/python/api/__init__.py
new file mode 100755
index 0000000000000000000000000000000000000000..74583d364ec2ca794156596c7254d9b234a940c6
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/python/api/__init__.py
@@ -0,0 +1,2 @@
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/l1menu/ItemDef.py b/Trigger/TriggerCommon/TriggerMenu/python/l1menu/ItemDef.py
index d524e7557685bc25a654c7a8218aee28577aec5d..502e221e758d8e210baa67177a9b15281be89f4b 100755
--- a/Trigger/TriggerCommon/TriggerMenu/python/l1menu/ItemDef.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/l1menu/ItemDef.py
@@ -122,6 +122,7 @@ class ItemDef:
         if '_v6' in TriggerFlags.triggerMenuSetup() or '_HI' in TriggerFlags.triggerMenuSetup():
            LVL1MenuItem('L1_2EM13VH'        ).setLogic( EM13VH.x(2)          & physcond).setTriggerType( TT.calo )  # noqa: F821              
            LVL1MenuItem('L1_2EM18VH'        ).setLogic( EM18VH.x(2)          & physcond).setTriggerType( TT.calo )  # noqa: F821
+        LVL1MenuItem('L1_2EM12'          ).setLogic( EM12.x(2)            & physcond).setTriggerType( TT.calo )     # noqa: F821
         LVL1MenuItem('L1_2EM15'          ).setLogic( EM15.x(2)            & physcond).setTriggerType( TT.calo )     # noqa: F821
         LVL1MenuItem('L1_2EM15VH'        ).setLogic( EM15VH.x(2)          & physcond).setTriggerType( TT.calo )     # noqa: F821
         if not '_v6' in TriggerFlags.triggerMenuSetup() and not '_HI' in TriggerFlags.triggerMenuSetup():
@@ -164,7 +165,8 @@ class ItemDef:
         LVL1MenuItem('L1_J30.0ETA49'  ).setLogic( J300ETA49 & physcond).setTriggerType(TT.calo)    # noqa: F821
         LVL1MenuItem('L1_J25.0ETA23_2J15.31ETA49'  ).setLogic( J250ETA23 & J1531ETA49.x(2) & physcond).setTriggerType(TT.calo)    # noqa: F821
        
-        LVL1MenuItem('L1_2EM3_VTE70').setLogic( EM3.x(2) & Not(TE70) & physcond).setTriggerType(TT.calo) # noqa: F821        
+        LVL1MenuItem('L1_2EM3_VTE70').setLogic( EM3.x(2) & Not(TE70) & physcond).setTriggerType(TT.calo) # noqa: F821
+        LVL1MenuItem('L1_2EM3_VTE50').setLogic( EM3.x(2) & Not(TE50) & physcond).setTriggerType(TT.calo) # noqa: F821        
  
         # HI
         LVL1MenuItem('L1_EM3_NZ'         ).setLogic( EM3      & Not(ZDC_AND) & physcond).setTriggerType( TT.calo )    # noqa: F821
@@ -253,6 +255,8 @@ class ItemDef:
 
 
         LVL1MenuItem('L1_MU4_TE10' ).setLogic( MU4      & TE10 & physcond).setTriggerType(TT.muon)     # noqa: F821
+        LVL1MenuItem('L1_MU4_TE20' ).setLogic( MU4      & TE20 & physcond).setTriggerType(TT.muon)     # noqa: F821
+        LVL1MenuItem('L1_MU4_TE30' ).setLogic( MU4      & TE30 & physcond).setTriggerType(TT.muon)     # noqa: F821
         LVL1MenuItem('L1_MU4_TE40' ).setLogic( MU4      & TE40 & physcond).setTriggerType(TT.muon)     # noqa: F821
         LVL1MenuItem('L1_MU4_TE50' ).setLogic( MU4      & TE50 & physcond).setTriggerType(TT.muon)     # noqa: F821
         LVL1MenuItem('L1_MU4_TE70' ).setLogic( MU4      & TE70 & physcond).setTriggerType(TT.muon)     # noqa: F821
@@ -1120,6 +1124,8 @@ class ItemDef:
 
         # LUT 24 (9 Outputs)
         ALFA_ANY          = ALFA3_B7L1U | ALFA3_B7L1L | ALFA3_A7L1U | ALFA3_A7L1L | ALFA3_A7R1U | ALFA3_A7R1L | ALFA3_B7R1U | ALFA3_B7R1L # 0      # noqa: F821
+        ALFA_B1          = ALFA3_B7L1U | ALFA3_B7L1L | ALFA3_A7L1U | ALFA3_A7L1L  # 0      # noqa: F821
+        ALFA_B2          = ALFA3_A7R1U | ALFA3_A7R1L | ALFA3_B7R1U | ALFA3_B7R1L # 0      # noqa: F821
         #NOT_ALFA_ANY_A    = Not(ALFA3_B7L1U | ALFA3_B7L1L | ALFA3_A7L1U | ALFA3_A7L1L)  #  1-4     # noqa: F821
         #NOT_ALFA_ANY_C    = Not(ALFA3_A7R1U | ALFA3_A7R1L | ALFA3_B7R1U | ALFA3_B7R1L)  #  5-8     # noqa: F821
 
@@ -1340,6 +1346,8 @@ class ItemDef:
         
         LVL1MenuItem('L1_ALFA_BGT' ).setLogic(RNDM3 & physcond).setTriggerType(TT.alfa)    # noqa: F821
         LVL1MenuItem('L1_ALFA_BGT_UNPAIRED_ISO' ).setLogic(RNDM3 & unpaired_isocond).setTriggerType(TT.alfa)    # noqa: F821
+        LVL1MenuItem('L1_ALFA_BGT_BGRP1').setLogic(RNDM3 & physcond).setTriggerType(TT.alfa)    # noqa: F821
+        LVL1MenuItem('L1_ALFA_BGT_BGRP4').setLogic(RNDM3 & unpaired_isocond).setTriggerType(TT.alfa)    # noqa: F821
         LVL1MenuItem('L1_ALFA_BGT_BGRP10').setLogic(RNDM3 & alfacalib).setTriggerType(TT.alfa)    # noqa: F821
 
         LVL1MenuItem('L1_ALFA_SHOWSYST5').setLogic( (ALFA_ANY_A & ALFA_ANY_C) & physcond).setTriggerType(TT.alfa)    # noqa: F821
@@ -1352,7 +1360,8 @@ class ItemDef:
         LVL1MenuItem('L1_ALFA_SYST18').setLogic( ALFA_LL & ALFA_RL & physcond).setTriggerType(TT.alfa)    # noqa: F821
        
         LVL1MenuItem('L1_ALFA_ANY').setLogic(ALFA_ANY & physcond).setTriggerType(TT.alfa)    # noqa: F821
-        
+        LVL1MenuItem('L1_ALFA_B1_EMPTY').setLogic(ALFA_B1 & cosmiccond).setTriggerType(TT.alfa)    # noqa: F821
+        LVL1MenuItem('L1_ALFA_B2_EMPTY').setLogic(ALFA_B2 & cosmiccond).setTriggerType(TT.alfa)    # noqa: F821        
         LVL1MenuItem('L1_ALFA_ANY_EMPTY').setLogic(ALFA_ANY & cosmiccond).setTriggerType(TT.alfa)    # noqa: F821
         LVL1MenuItem('L1_ALFA_ANY_FIRSTEMPTY').setLogic(ALFA_ANY & firstempty).setTriggerType(TT.alfa)    # noqa: F821
         LVL1MenuItem('L1_ALFA_ANY_UNPAIRED_ISO').setLogic(ALFA_ANY & unpaired_isocond).setTriggerType(TT.alfa)    # noqa: F821
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/l1menu/Menu_MC_pp_v7.py b/Trigger/TriggerCommon/TriggerMenu/python/l1menu/Menu_MC_pp_v7.py
index 1cb6ef6b8371bb690be09d3c26fc3f71c3861ed0..b937e8f03da85565742bbeac2febb5a61617a024 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/l1menu/Menu_MC_pp_v7.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/l1menu/Menu_MC_pp_v7.py
@@ -104,7 +104,8 @@ def defineMenu():
         # 8 x TE
         #'TE3', 'TE5', 'TE10', 'TE15', 'TE20', 'TE25', 'TE30', 'TE40',
         #'TE5', 'TE30', 'TE40', 'TE45', 'TE50', 'TE55', 'TE60', 'TE65',
-        'TE5', 'TE10', 'TE20', 'TE30', 'TE40', 'TE50', 'TE60', 'TE70',
+        #'TE5', 'TE10', 'TE20', 'TE30', 'TE40', 'TE50', 'TE60', 'TE70',
+        'TE5', 'TE10', 'TE15', 'TE20', 'TE25', 'TE30', 'TE40', 'TE50',
         #'TE2', 'TE3', 'TE4', 'TE5', 'TE10', 'TE20', 'TE30', 'TE70',
 
         # 8 x XE (for standard XE)
@@ -363,7 +364,8 @@ def defineMenu():
         'ALFA2_B7R1L', 'ALFA2_B7R1U', 'ALFA2_A7R1L', 'ALFA2_A7R1U', 'ALFA2_A7L1L', 'ALFA2_A7L1U', 'ALFA2_B7L1L', 'ALFA2_B7L1U',
         'ALFA3_B7R1L', 'ALFA3_B7R1U', 'ALFA3_A7R1L', 'ALFA3_A7R1U', 'ALFA3_A7L1L', 'ALFA3_A7L1U', 'ALFA3_B7L1L', 'ALFA3_B7L1U',
         'ALFA4_B7R1L', 'ALFA4_B7R1U', 'ALFA4_A7R1L', 'ALFA4_A7R1U', 'ALFA4_A7L1L', 'ALFA4_A7L1U', 'ALFA4_B7L1L', 'ALFA4_B7L1U',
-#ATR-13743        'ALFA_B7R1L_OD', 'ALFA_B7R1U_OD', 'ALFA_A7R1L_OD', 'ALFA_A7R1U_OD', 'ALFA_A7L1L_OD', 'ALFA_A7L1U_OD', 'ALFA_B7L1L_OD', 'ALFA_B7L1U_OD',
+#ATR-13743      
+#        'ALFA_B7R1L_OD', 'ALFA_B7R1U_OD', 'ALFA_A7R1L_OD', 'ALFA_A7R1U_OD', 'ALFA_A7L1L_OD', 'ALFA_A7L1U_OD', 'ALFA_B7L1L_OD', 'ALFA_B7L1U_OD',
 
 
         ]
@@ -396,10 +398,10 @@ def defineMenu():
         'L1_MU4_UNPAIRED_ISO','L1_MU4_UNPAIRED_NONISO',
          'L1_MU20_FIRSTEMPTY','L1_MU21_FIRSTEMPTY',
 
-        'L1_2EM3_VTE70', 
+        'L1_2EM3_VTE50', 
         
         # multi lepton
-        "L1_2EM3", "L1_2EM7", "L1_2EM10VH", "L1_2EM15", "L1_2EM15VH", "L1_2EM15VHI", "L1_EM7_2EM3", "L1_EM12_2EM3", "L1_EM15VH_3EM7",
+        "L1_2EM3", "L1_2EM7", "L1_2EM10VH", "L1_2EM12", "L1_2EM15", "L1_2EM15VH", "L1_2EM15VHI", "L1_EM7_2EM3", "L1_EM12_2EM3", "L1_EM15VH_3EM7",
 	"L1_2EM20VH", "L1_EM15VH_3EM10VH", "L1_EM20VH_3EM10VH", "L1_EM20VH_2EM10VH_3EM8VH",
         "L1_EM7_MU10",
         "L1_2MU4", "L1_2MU6", "L1_2MU10", "L1_2MU20_OVERLAY", "L1_MU10_2MU6", "L1_MU11_2MU6", "L1_3MU4", "L1_MU6_2MU4", "L1_3MU6",  "L1_4MU4", "L1_MU6_3MU4", "L1_2MU6_3MU4",
@@ -536,7 +538,8 @@ def defineMenu():
         # TE
         #"L1_TE3",        "L1_TE5",        "L1_TE10",        "L1_TE15",        "L1_TE20",        "L1_TE25",        "L1_TE30",        "L1_TE40",
         #"L1_TE5",        "L1_TE30",        "L1_TE40",        "L1_TE45",        "L1_TE50",        "L1_TE55",        "L1_TE60",        "L1_TE65",
-        "L1_TE5", "L1_TE10", "L1_TE20", "L1_TE30", "L1_TE40", "L1_TE50", "L1_TE60", "L1_TE70",
+        #"L1_TE5", "L1_TE10", "L1_TE20", "L1_TE30", "L1_TE40", "L1_TE50", "L1_TE60", "L1_TE70",
+        "L1_TE5", "L1_TE10", "L1_TE15", "L1_TE20", "L1_TE25", "L1_TE30", "L1_TE40", "L1_TE50",
         #"L1_TE2",        "L1_TE3",   "L1_TE4",  "L1_TE5",        "L1_TE10",        "L1_TE20",        "L1_TE30",      "L1_TE70",
 
         #"L1_TE3.0ETA24", "L1_TE5.0ETA24", "L1_TE10.0ETA24", "L1_TE15.0ETA24", "L1_TE20.0ETA24", "L1_TE25.0ETA24", "L1_TE30.0ETA24", "L1_TE40.0ETA24", 
@@ -548,7 +551,7 @@ def defineMenu():
         #"L1_MBTS_1_VTE2", "L1_MBTS_1_VTE3", "L1_MBTS_1_VTE4", "L1_MBTS_1_VTE5", "L1_MBTS_1_VTE10", "L1_MBTS_2_VTE2", "L1_MBTS_2_VTE3", "L1_MBTS_2_VTE4", "L1_MBTS_2_VTE5", "L1_MBTS_2_VTE10", 
         
         #TE + MU
-        "L1_MU4_TE10", "L1_MU4_TE40", "L1_MU4_TE50",
+        "L1_MU4_TE10", "L1_MU4_TE20", "L1_MU4_TE30", "L1_MU4_TE40",# "L1_MU4_TE50",
 
         # MBTS
         "L1_MBTS_1", "L1_MBTS_2", "L1_MBTS_1_1",
@@ -837,11 +840,12 @@ def defineMenu():
         ##     'L1_CALREQ0_P1', 'L1_CALREQ1_P1', 'L1_CALREQ2_P1',
 
         #ALFA
-#ALFA_B7R1L_OD        'L1_ALFA_ELAST1',
-#        'L1_ALFA_ELAST2',
-#        'L1_ALFA_ELAST11','L1_ALFA_ELAST12',
-#        'L1_ALFA_ELAST13','L1_ALFA_ELAST14','L1_ALFA_ELAST15','L1_ALFA_ELAST15_Calib',
-#        'L1_ALFA_ELAST16','L1_ALFA_ELAST17','L1_ALFA_ELAST18','L1_ALFA_ELAST18_Calib',
+#ALFA_B7R1L_OD        
+        'L1_ALFA_ELAST1',
+        'L1_ALFA_ELAST2',
+        'L1_ALFA_ELAST11','L1_ALFA_ELAST12',
+        'L1_ALFA_ELAST13','L1_ALFA_ELAST14','L1_ALFA_ELAST15','L1_ALFA_ELAST15_Calib',
+        'L1_ALFA_ELAST16','L1_ALFA_ELAST17','L1_ALFA_ELAST18','L1_ALFA_ELAST18_Calib',
 #        'L1_ALFA_SDIFF5','L1_ALFA_SDIFF6','L1_ALFA_SDIFF7','L1_ALFA_SDIFF8',
 #        'L1_MBTS_1_A_ALFA_C','L1_MBTS_1_C_ALFA_A','L1_MBTS_1_A_ALFA_C_UNPAIRED_ISO','L1_MBTS_1_C_ALFA_A_UNPAIRED_ISO',
 #        'L1_MBTS_2_A_ALFA_C','L1_MBTS_2_C_ALFA_A','L1_MBTS_2_A_ALFA_C_UNPAIRED_ISO','L1_MBTS_2_C_ALFA_A_UNPAIRED_ISO',
@@ -861,13 +865,15 @@ def defineMenu():
 #        #'L1_LHCF_ALFA_ANY_A',
 #        #'L1_LHCF_ALFA_ANY_C',
 ##        'L1_LHCF_ALFA_ANY_A_UNPAIRED_ISO','L1_LHCF_ALFA_ANY_C_UNPAIRED_ISO',
-#        'L1_ALFA_BGT','L1_ALFA_BGT_UNPAIRED_ISO','L1_ALFA_BGT_BGRP10',
-#        'L1_ALFA_SHOWSYST5',
-#        'L1_ALFA_SYST9' ,'L1_ALFA_SYST10','L1_ALFA_SYST11','L1_ALFA_SYST12',
-#        'L1_ALFA_SYST17','L1_ALFA_SYST18',
-#        'L1_ALFA_ANY',
-#        'L1_ALFA_ANY_EMPTY','L1_ALFA_ANY_FIRSTEMPTY','L1_ALFA_ANY_UNPAIRED_ISO','L1_ALFA_ANY_UNPAIRED_NONISO',
-#        'L1_ALFA_ANY_BGRP10','L1_ALFA_ANY_ABORTGAPNOTCALIB','L1_ALFA_ANY_CALIB',
+#        'L1_ALFA_BGT','L1_ALFA_BGT_UNPAIRED_ISO',
+        'L1_ALFA_BGT_BGRP1','L1_ALFA_BGT_BGRP4','L1_ALFA_BGT_BGRP10',
+        'L1_ALFA_SHOWSYST5',
+        'L1_ALFA_SYST9' ,'L1_ALFA_SYST10','L1_ALFA_SYST11','L1_ALFA_SYST12',
+        'L1_ALFA_SYST17','L1_ALFA_SYST18',
+        'L1_ALFA_ANY',
+        'L1_ALFA_ANY_EMPTY','L1_ALFA_B1_EMPTY','L1_ALFA_B2_EMPTY','L1_ALFA_ANY_FIRSTEMPTY','L1_ALFA_ANY_UNPAIRED_ISO','L1_ALFA_ANY_UNPAIRED_NONISO',
+        'L1_ALFA_ANY_BGRP10',
+        'L1_ALFA_ANY_ABORTGAPNOTCALIB','L1_ALFA_ANY_CALIB',
         'L1_ALFA_B7L1U','L1_ALFA_B7L1L','L1_ALFA_A7L1U','L1_ALFA_A7L1L','L1_ALFA_A7R1U','L1_ALFA_A7R1L','L1_ALFA_B7R1U','L1_ALFA_B7R1L',
 #        'L1_ALFA_ANY_A_EMPTY','L1_ALFA_ANY_C_EMPTY',
 #        'L1_ALFA_B7L1U_OD','L1_ALFA_B7L1L_OD','L1_ALFA_A7L1U_OD','L1_ALFA_A7L1L_OD','L1_ALFA_A7R1U_OD','L1_ALFA_A7R1L_OD','L1_ALFA_B7R1U_OD','L1_ALFA_B7R1L_OD',
@@ -939,6 +945,7 @@ def defineMenu():
         'L1_2EM7' : 24,
         'L1_2EM10VH' : 25,
         #'L1_2EM13VH' : 26,
+        'L1_2EM12' : 409,
         'L1_2EM15' : 27,
         'L1_2EM15VH' : 28,
         'L1_EM7_2EM3' : 29,
@@ -1100,8 +1107,8 @@ def defineMenu():
         'L1_TE30' : 138,
         'L1_TE40' : 82,
         'L1_TE50' : 143,
-        'L1_TE60' : 160,
-        'L1_TE70' : 152,
+        'L1_TE15' : 160,
+        'L1_TE25' : 152,
 
 
 #        'L1_MBTS_1_VTE2' : 160,
@@ -1496,7 +1503,7 @@ def defineMenu():
 ##         'L1_MBTS_2_VTE5':127,
 ##         'L1_MBTS_2_VTE10':129,  
 
-        'L1_2EM3_VTE70' : 474,
+        'L1_2EM3_VTE50' : 474,
         
 #        'L1_MBTS_1_VTE70' : 477,
 
@@ -1506,8 +1513,10 @@ def defineMenu():
         'L1_ZDC_AND':421, 
         'L1_ZDC_A_C':422, 
         'L1_MU4_TE10':470,
+        'L1_MU4_TE20':410,
+        'L1_MU4_TE30':124,
         'L1_MU4_TE40':108,
-        'L1_MU4_TE50':124,
+        #'L1_MU4_TE50':124,
 
         'L1_LUCID_BGRP9' : 471,
         'L1_LUCID_BGRP11' : 472,
@@ -1516,18 +1525,19 @@ def defineMenu():
 #        'L1_MBTS_1_OVERLAY' : 445,
 #        'L1_TE20_OVERLAY' : 455,
         
-#ATR-13743        'L1_ALFA_ELAST1'  : 424,
-#        'L1_ALFA_ELAST2'  : 425,
-#        'L1_ALFA_ELAST11' : 426,
-#        'L1_ALFA_ELAST12' : 427,
-#        'L1_ALFA_ELAST13' : 428,
-#        'L1_ALFA_ELAST14' : 429,
-#        'L1_ALFA_ELAST15' : 430,
-#        'L1_ALFA_ELAST15_Calib' : 431,
-#        'L1_ALFA_ELAST16' : 432,
-#        'L1_ALFA_ELAST17' : 433,
-#        'L1_ALFA_ELAST18' : 434,
-#        'L1_ALFA_ELAST18_Calib' : 435,
+#ATR-13743        
+        'L1_ALFA_ELAST1'  : 48,
+        'L1_ALFA_ELAST2'  : 71,
+        'L1_ALFA_ELAST11' : 77,
+        'L1_ALFA_ELAST12' : 79,
+        'L1_ALFA_ELAST13' : 80,
+        'L1_ALFA_ELAST14' : 84,
+        'L1_ALFA_ELAST15' : 87,
+        'L1_ALFA_ELAST15_Calib' : 127,
+        'L1_ALFA_ELAST16' : 129,
+        'L1_ALFA_ELAST17' : 133,
+        'L1_ALFA_ELAST18' : 257,
+        'L1_ALFA_ELAST18_Calib' : 275,
 #        'L1_ALFA_SDIFF5' : 436,
 #        'L1_ALFA_SDIFF6' : 437,
 #        'L1_ALFA_SDIFF7' : 438,
@@ -1566,35 +1576,39 @@ def defineMenu():
 #        
 #        'L1_ALFA_BGT' : 471,
 #        'L1_ALFA_BGT_UNPAIRED_ISO' : 472,
-#        'L1_ALFA_BGT_BGRP10' : 473,
-#        'L1_ALFA_SHOWSYST5' : 474,
-#        'L1_ALFA_SYST9'  : 475,
-#        'L1_ALFA_SYST10' : 476,
-#        'L1_ALFA_SYST11' : 477,
-#        'L1_ALFA_SYST12' : 478,
-#        'L1_ALFA_SYST17' : 479,
-#        'L1_ALFA_SYST18' : 480,
-#        'L1_ALFA_ANY' : 481,
-#        'L1_ALFA_ANY_EMPTY' : 482,
-#        'L1_ALFA_ANY_FIRSTEMPTY' : 483,
-#        'L1_ALFA_ANY_UNPAIRED_ISO' : 484,
-#        'L1_ALFA_ANY_UNPAIRED_NONISO' : 485,
-#        'L1_ALFA_ANY_BGRP10' : 486,
-#        'L1_ALFA_ANY_ABORTGAPNOTCALIB' : 487,
-#        'L1_ALFA_ANY_CALIB' : 488,
-         'L1_ALFA_B7L1U' : 489,
-         'L1_ALFA_B7L1L' : 490,
-         'L1_ALFA_A7L1U' : 491,
-         'L1_ALFA_A7L1L' : 492,
-         'L1_ALFA_A7R1U' : 493,
-         'L1_ALFA_A7R1L' : 494,
-         'L1_ALFA_B7R1U' : 495,
-         'L1_ALFA_B7R1L' : 496,
+        'L1_ALFA_BGT_BGRP1' : 395,
+        'L1_ALFA_BGT_BGRP4' : 396,
+        'L1_ALFA_BGT_BGRP10' : 497,
+        'L1_ALFA_SHOWSYST5' : 285,
+        'L1_ALFA_SYST9'  : 288,
+        'L1_ALFA_SYST10' : 290,
+        'L1_ALFA_SYST11' : 291,
+        'L1_ALFA_SYST12' : 292,
+        'L1_ALFA_SYST17' : 316,
+        'L1_ALFA_SYST18' : 326,
+        'L1_ALFA_ANY' : 328,
+        'L1_ALFA_ANY_EMPTY' : 330,
+        'L1_ALFA_B1_EMPTY' : 376,
+        'L1_ALFA_B2_EMPTY' : 407,
+        'L1_ALFA_ANY_FIRSTEMPTY' : 349,
+        'L1_ALFA_ANY_UNPAIRED_ISO' : 362,
+        'L1_ALFA_ANY_UNPAIRED_NONISO' : 363,
+        'L1_ALFA_ANY_BGRP10' : 370,
+        'L1_ALFA_ANY_ABORTGAPNOTCALIB' : 374,
+        'L1_ALFA_ANY_CALIB' : 375,
+        'L1_ALFA_B7L1U' : 489,
+        'L1_ALFA_B7L1L' : 490,
+        'L1_ALFA_A7L1U' : 491,
+        'L1_ALFA_A7L1L' : 492,
+        'L1_ALFA_A7R1U' : 493,
+        'L1_ALFA_A7R1L' : 494,
+        'L1_ALFA_B7R1U' : 495,
+        'L1_ALFA_B7R1L' : 496,
 
         
         'L1_MU6_FTK'                           : 499,
         'L1_MU20_FTK'                          : 500,
-        'L1_MU21_FTK'                          : 497,
+#        'L1_MU21_FTK'                          : 497,
         'L1_TAU12IM_FTK'                       : 501,
         'L1_TAU20IM_FTK'                       : 86,
         'L1_TAU20IM_2TAU12IM_J25_2J20_3J12_FTK': 502,
@@ -1605,18 +1619,18 @@ def defineMenu():
         'L1_J40_FTK'                           : 507,
         'L1_J100_FTK'                          : 508,           
         'L1_MU20_TAU12IM_FTK'                  : 498,
-#        'L1_ALFA_B7L1U_OD' : 497,
-#        'L1_ALFA_B7L1L_OD' : 498,
-#        'L1_ALFA_A7L1U_OD' : 499,
-#        'L1_ALFA_A7L1L_OD' : 500,
-#        'L1_ALFA_A7R1U_OD' : 501,
-#        'L1_ALFA_A7R1L_OD' : 502,
-#        'L1_ALFA_B7R1U_OD' : 503,
-#        'L1_ALFA_B7R1L_OD' : 504,
-#        'L1_ALFA_B7L1_OD'  : 505,
-#        'L1_ALFA_A7L1_OD'  : 506,
-#        'L1_ALFA_B7R1_OD'  : 507,
-#        'L1_ALFA_A7R1_OD'  : 508,
+#        'L1_ALFA_B7L1U_OD' : ,
+#        'L1_ALFA_B7L1L_OD' : ,
+#        'L1_ALFA_A7L1U_OD' : ,
+#        'L1_ALFA_A7L1L_OD' : ,
+#        'L1_ALFA_A7R1U_OD' : 409,
+#        'L1_ALFA_A7R1L_OD' : 410,
+#        'L1_ALFA_B7R1U_OD' : 417,
+#        'L1_ALFA_B7R1L_OD' : 418,
+#        'L1_ALFA_B7L1_OD'  : 434,
+#        'L1_ALFA_A7L1_OD'  : 455,
+#        'L1_ALFA_B7R1_OD'  : 477,
+#        'L1_ALFA_A7R1_OD'  : 478,
         'L1_CALREQ2' : 511,  # never use 509-511 for anything else than CALREQ triggers
 }
 
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/menu/CPS.py b/Trigger/TriggerCommon/TriggerMenu/python/menu/CPS.py
index 106182f354645b361249b263bfc26de39cb73564..8c53e64a5d15b55434e8a4d7f0c7e4287dfccc55 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/menu/CPS.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/menu/CPS.py
@@ -52,7 +52,7 @@ def defineCPSGroups():
         #Egamma chains
         "RATE:CPS:HLT_e5_vloose"  :  ['e5_lhvloose_nod0',],
                                       
-        "RATE:CPS:HLT_2g3" : ['2g3_loose_L12EM3_VTE70','2g3_loose_dPhi15_L12EM3_VTE70','2g3_medium_dPhi15_L12EM3_VTE70'],
+        "RATE:CPS:HLT_2g3" : ['2g3_loose_L12EM3_VTE50','2g3_loose_dPhi15_L12EM3_VTE50','2g3_medium_dPhi15_L12EM3_VTE50'],
         ########################################################################
 
         "RATE:CPS:HLT_e20_vloose"        : ['e20_lhvloose_nod0'],
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/menu/L1Seeds.py b/Trigger/TriggerCommon/TriggerMenu/python/menu/L1Seeds.py
index 94b89864c0db154f0465795b5534d8b4b28e8469..476bad1744217fa4f8a2c8a5cc8a90e61ae00d30 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/menu/L1Seeds.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/menu/L1Seeds.py
@@ -219,7 +219,8 @@ def getEBnoL1PSSeed(l1items, l1seedname):
 ##############################
 def getL1_ALFA_Phys(l1seed):
 
-    L1ALFA_Phys_seeds = 'L1_ALFA_ELAST1,L1_ALFA_ELAST2,L1_ALFA_ELAST11,L1_ALFA_ELAST12,L1_ALFA_ELAST13,L1_ALFA_ELAST14,L1_ALFA_ELAST15,L1_ALFA_ELAST16,L1_ALFA_ELAST17,L1_ALFA_ELAST18,L1_ALFA_SHOWSYST5,L1_ALFA_ANY_A_EMPTY,L1_ALFA_ANY_C_EMPTY'
+    L1ALFA_Phys_seeds = 'L1_ALFA_ELAST1,L1_ALFA_ELAST2,L1_ALFA_ELAST11,L1_ALFA_ELAST12,L1_ALFA_ELAST13,L1_ALFA_ELAST14,L1_ALFA_ELAST15,L1_ALFA_ELAST16,L1_ALFA_ELAST17,L1_ALFA_ELAST18,L1_ALFA_SHOWSYST5,L1_ALFA_B1_EMPTY,L1_ALFA_B2_EMPTY'
+#,L1_ALFA_ANY_A_EMPTY,L1_ALFA_ANY_C_EMPTY'
 
     # check if all the l1 background seeds given are in the current L1 menu
     l1bgditems = L1ALFA_Phys_seeds.split(',')
@@ -245,9 +246,10 @@ def getL1_ALFA_Phys_Any(l1seed):
 ##############################
 def getL1ALFA_Calib(l1seed):
 
-    L1ALFA_Calib_seeds = 'L1_ALFA_B7L1U,L1_ALFA_B7L1L,L1_ALFA_A7L1U,L1_ALFA_A7L1L,L1_ALFA_A7R1U,L1_ALFA_A7R1L,L1_ALFA_B7R1U,L1_ALFA_B7R1L'
-        #ATR-13743 'L1_ALFA_ELAST15_Calib,L1_ALFA_ELAST18_Calib,L1_ALFA_BGT,L1_ALFA_BGT_UNPAIRED_ISO,L1_ALFA_BGT_BGRP10,L1_ALFA_SHOWSYST5,L1_ALFA_ANY_EMPTY,L1_ALFA_ANY_FIRSTEMPTY,L1_ALFA_ANY_UNPAIRED_ISO,L1_ALFA_ANY_UNPAIRED_NONISO,L1_ALFA_ANY_BGRP10,L1_ALFA_ANY_CALIB,L1_ALFA_ANY_ABORTGAPNOTCALIB,
-           #L1_ALFA_B7L1U_OD,L1_ALFA_B7L1L_OD,L1_ALFA_A7L1U_OD,L1_ALFA_A7L1L_OD,L1_ALFA_A7R1U_OD,L1_ALFA_A7R1L_OD,L1_ALFA_B7R1U_OD,L1_ALFA_B7R1L_OD,L1_ALFA_B7L1_OD,L1_ALFA_A7L1_OD,L1_ALFA_A7R1_OD,L1_ALFA_B7R1_OD,L1_ALFA_ANY_A_EMPTY,L1_ALFA_ANY_C_EMPTY'
+    L1ALFA_Calib_seeds = 'L1_ALFA_B7L1U,L1_ALFA_B7L1L,L1_ALFA_A7L1U,L1_ALFA_A7L1L,L1_ALFA_A7R1U,L1_ALFA_A7R1L,L1_ALFA_B7R1U,L1_ALFA_B7R1L,L1_ALFA_ELAST15_Calib,L1_ALFA_ELAST18_Calib,L1_ALFA_BGT_BGRP1,L1_ALFA_BGT_BGRP4,L1_ALFA_BGT_BGRP10,L1_ALFA_SHOWSYST5,L1_ALFA_ANY_EMPTY,L1_ALFA_ANY_FIRSTEMPTY,L1_ALFA_ANY_UNPAIRED_ISO,L1_ALFA_ANY_UNPAIRED_NONISO,L1_ALFA_ANY_BGRP10,L1_ALFA_ANY_CALIB,L1_ALFA_ANY_ABORTGAPNOTCALIB,L1_ALFA_B1_EMPTY,L1_ALFA_B2_EMPTY'
+    #,L1_ALFA_B7L1U_OD,L1_ALFA_B7L1L_OD,L1_ALFA_A7L1U_OD,L1_ALFA_A7L1L_OD,L1_ALFA_A7R1U_OD,L1_ALFA_A7R1L_OD,L1_ALFA_B7R1U_OD,L1_ALFA_B7R1L_OD,L1_ALFA_B7L1_OD,L1_ALFA_A7L1_OD,L1_ALFA_A7R1_OD,L1_ALFA_B7R1_OD'
+        #ATR-13743 'L1_ALFA_BGT,L1_ALFA_BGT_UNPAIRED_ISO,,
+           #L1_ALFA_ANY_A_EMPTY,L1_ALFA_ANY_C_EMPTY'
 
     # check if all the l1 background seeds given are in the current L1 menu
     l1bgditems = L1ALFA_Calib_seeds.split(',')
@@ -286,6 +288,19 @@ def getL1ALFA_SYS(l1seed):
             
     return L1ALFA_SYS_seeds
 
+##############################
+def getL1ALFA_SYS_Calib(l1seed):
+
+    L1ALFA_SYS_Calib_seeds = 'L1_ALFA_SYST9,L1_ALFA_SYST10,L1_ALFA_SYST11,L1_ALFA_SYST12,L1_ALFA_SYST17,L1_ALFA_SYST18'
+
+    # check if all the l1 background seeds given are in the current L1 menu
+    l1bgditems = L1ALFA_SYS_Calib_seeds.split(',')
+    for item in l1bgditems:
+        if item not in l1seed:
+            log.error('L1 item %s from L1ALFA_SYS_Calib_seeds seeds is not in current L1 menu' % item)
+            
+    return L1ALFA_SYS_Calib_seeds
+
 ##############################
 def getL1ALFA_ELAS(l1seed):
 
@@ -372,11 +387,11 @@ def getSpecificL1Seeds(l1seedname, l1itemobject):
     elif (l1seedname in ['L1_MinBias', 'L1_MinBias_EMPTY']):
         L1Seed = getL1MinBiasSeed(l1seedname, l1itemobject)
 
-#    elif (l1seedname == 'L1_ALFA_Phys'):
-#        L1Seed = getL1_ALFA_Phys(l1items)
-#
-#    elif (l1seedname == 'L1_ALFA_PhysAny'):
-#        L1Seed = getL1_ALFA_Phys_Any(l1items)
+    elif (l1seedname == 'L1_ALFA_Phys'):
+        L1Seed = getL1_ALFA_Phys(l1items)
+
+    elif (l1seedname == 'L1_ALFA_PhysAny'):
+        L1Seed = getL1_ALFA_Phys_Any(l1items)
 #
 #    elif (l1seedname == 'L1_ALFA_Diff'):
 #        L1Seed = getL1ALFA_Diff(l1items)
@@ -386,9 +401,8 @@ def getSpecificL1Seeds(l1seedname, l1itemobject):
 #        
     elif (l1seedname == 'L1_ALFA_Calib'):
         L1Seed = getL1ALFA_Calib(l1items)
-#
-#    elif (l1seedname == 'L1_ALFA_ELAS'):
-#        L1Seed = getL1ALFA_ELAS(l1items)
+    elif (l1seedname == 'L1_ALFA_ELAS'):
+        L1Seed = getL1ALFA_ELAS(l1items)
 #
 #    elif (l1seedname == 'L1_ALFA_TRT_Calib'):
 #        L1Seed = getL1ALFA_TRT_Calib(l1items)
@@ -405,8 +419,11 @@ def getSpecificL1Seeds(l1seedname, l1itemobject):
 #    elif (l1seedname == 'L1_ALFA_TRT'):
 #        L1Seed = getL1ALFA_TRT(l1items)
 #
-#    elif (l1seedname == 'L1_ALFA_SYS'):
-#        L1Seed = getL1ALFA_SYS(l1items)
+    elif (l1seedname == 'L1_ALFA_SYS'):
+        L1Seed = getL1ALFA_SYS(l1items)
+
+    elif (l1seedname == 'L1_ALFA_SYS_Calib'):
+        L1Seed = getL1ALFA_SYS_Calib(l1items)
 
 
     elif (l1seedname == 'L1_LowLumi'):
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/menu/MC_pp_v7.py b/Trigger/TriggerCommon/TriggerMenu/python/menu/MC_pp_v7.py
index 6df6b016eefdb2df4c4cd016c7a8609181a43a3b..f4787ccb249266450223eceb10c0f3387e71462c 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/menu/MC_pp_v7.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/menu/MC_pp_v7.py
@@ -136,7 +136,7 @@ def setupMenu():
         ['mu20_nomucomb_mu8noL1' , 'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20_nomucomb','mu8noL1']]],
         ['mu22_nomucomb_mu8noL1' , 'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu22_nomucomb','mu8noL1']]],
 
-        ['mu8',                    'L1_MU6',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1], 
+        #['mu8',                    'L1_MU6',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1], 
         ['3mu6_nomucomb',                   'L1_3MU6',           [], [PhysicsStream], ['RATE:MultiMuon', 'BW:Muon'], -1],
         ['mu6_mu4noL1',            'L1_MU6',  ['L1_MU6',''],  [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu6','mu4noL1']]],
         ['mu4_mu4noL1',            'L1_MU4',  ['L1_MU4',''],  [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu4','mu4noL1']]],
@@ -162,7 +162,7 @@ def setupMenu():
         ['mu20_imedium_L1MU10',    'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu11',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu14_iloose',            'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
-        ['mu10',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        #['mu10',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu10_msonly',            'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu4_msonly',             'L1_MU4',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu14_nomucomb',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
@@ -172,8 +172,8 @@ def setupMenu():
         ['2mu10',                  'L1_2MU10',          [], [PhysicsStream], ['RATE:MultiMuon', 'BW:Muon'], -1],
         ['2mu10_nomucomb',         'L1_2MU10',          [], [PhysicsStream], ['RATE:MultiMuon', 'BW:Muon'], -1],
         ['mu20_mu8noL1',           'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20','mu8noL1']]],
-        ['2mu6',                    'L1_2MU6',  [], [PhysicsStream], [RATE_BMultiMuonTag, 'BW:Muon'], -1],
-        ['2mu4',                    'L1_2MU4',  [], [PhysicsStream], [RATE_BMultiMuonTag, 'BW:Muon'], -1],
+        #['2mu6',                    'L1_2MU6',  [], [PhysicsStream], [RATE_BMultiMuonTag, 'BW:Muon'], -1],
+        #['2mu4',                    'L1_2MU4',  [], [PhysicsStream], [RATE_BMultiMuonTag, 'BW:Muon'], -1],
         ['mu20_2mu2noL1',            'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20','2mu2noL1']]],
 
         #low-pt multi-muon chains, ATR-15704
@@ -274,17 +274,17 @@ def setupMenu():
 	['j20',                     'L1_RD0_FILLED', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j30',                     'L1_RD0_FILLED', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j30_L1TE5',               'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-	['j30_L1TE10',              'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+	#['j30_L1TE10',              'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j40',                     'L1_RD0_FILLED', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j40_L1TE10',              'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-	['j40_L1TE20',              'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+	#['j40_L1TE20',              'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j40_L1J12',               'L1_J12', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
 	['j50_L1TE20',              'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-        ['j50_L1J12',               'L1_J12', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-	['j50_L1J15',               'L1_J15', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+        #['j50_L1J12',               'L1_J12', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+	#['j50_L1J15',               'L1_J15', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
         ['j55_L1RD0_FILLED',        'L1_RD0_FILLED', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-	['j60_L1J15',               'L1_J15', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
-	['j75_L1J20',               'L1_J20', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+	#['j60_L1J15',               'L1_J15', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
+	#['j75_L1J20',               'L1_J20', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
         ['j85_L1J40',               'L1_J40', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
         ['j100',                    'L1_J25',  [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
         ['j125',                    'L1_J50', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
@@ -1228,7 +1228,7 @@ def setupMenu():
         
         ##########
         # Monopole triggers
-        ['g30_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        #['g30_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
         ['2g25_tight',                              'L1_2EM15VH', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
 
         ['e17_lhmedium_nod0_ivarloose',                  'L1_EM15VH',  [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
@@ -1251,7 +1251,7 @@ def setupMenu():
 
         ['g0_hiptrt_L1EM20VH',                  'L1_EM20VH',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1],
         ['g0_hiptrt_L1EM20VHI',                 'L1_EM20VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1],
-        ['g20_tight',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ##['g20_tight',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
 
         # Di-photon triggers
         ['g35_loose_L1EM15_g25_loose_L1EM15',       'L1_2EM15', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1], 
@@ -1449,8 +1449,8 @@ def setupMenu():
         ['2mu4_bBmumuxv2',                'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
         ['2mu4_bBmumux_BcmumuDsloose',    'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
         ['2mu4_bBmumux_BpmumuKp',         'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
-        ['2mu4_bJpsimumu',                'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
-        ['2mu4_bUpsimumu',                'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
+        #['2mu4_bJpsimumu',                'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
+        #['2mu4_bUpsimumu',                'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
         ['2mu4_bBmumu',                   'L1_2MU4', [], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
         ['mu6_mu4_bBmumu_noL2',           'L1_MU6_2MU4', ['L1_MU6','L1_MU4'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
 
@@ -2691,15 +2691,15 @@ ps_minb_list=[
     'mb_sp2100_pusup750_trk130_hmt_L1TE50',
     'mb_sp2200_pusup800_trk140_hmt_L1TE50',
     'mb_sp2400_pusup850_trk150_hmt_L1TE50',
-    'mb_sp1700_pusup650_trk110_hmt_L1TE60',
-    'mb_sp1900_pusup700_trk120_hmt_L1TE60',
-    'mb_sp2100_pusup750_trk130_hmt_L1TE60',
-    'mb_sp2200_pusup800_trk140_hmt_L1TE60',
-    'mb_sp2400_pusup850_trk150_hmt_L1TE60',
-    'mb_sp1900_pusup700_trk120_hmt_L1TE70',
-    'mb_sp2100_pusup750_trk130_hmt_L1TE70',
-    'mb_sp2200_pusup800_trk140_hmt_L1TE70',
-    'mb_sp2400_pusup850_trk150_hmt_L1TE70',
+    #'mb_sp1700_pusup650_trk110_hmt_L1TE60',
+    #'mb_sp1900_pusup700_trk120_hmt_L1TE60',
+    #'mb_sp2100_pusup750_trk130_hmt_L1TE60',
+    #'mb_sp2200_pusup800_trk140_hmt_L1TE60',
+    #'mb_sp2400_pusup850_trk150_hmt_L1TE60',
+    #'mb_sp1900_pusup700_trk120_hmt_L1TE70',
+    #'mb_sp2100_pusup750_trk130_hmt_L1TE70',
+    #'mb_sp2200_pusup800_trk140_hmt_L1TE70',
+    #'mb_sp2400_pusup850_trk150_hmt_L1TE70',
     'mb_sp600_trk40_hmt_L1TE5',
     'mb_sp700_trk50_hmt_L1TE5',
     'mb_sp900_trk50_hmt_L1TE5',
@@ -2776,15 +2776,43 @@ ps_minb_list=[
     'mb_sp2100_trk130_hmt_L1TE50',
     'mb_sp2200_trk140_hmt_L1TE50',
     'mb_sp2400_trk150_hmt_L1TE50',
-    'mb_sp1700_trk110_hmt_L1TE60',
-    'mb_sp1900_trk120_hmt_L1TE60',
-    'mb_sp2100_trk130_hmt_L1TE60',
-    'mb_sp2200_trk140_hmt_L1TE60',
-    'mb_sp2400_trk150_hmt_L1TE60',
-    'mb_sp1900_trk120_hmt_L1TE70',
-    'mb_sp2100_trk130_hmt_L1TE70',
-    'mb_sp2200_trk140_hmt_L1TE70',
-    'mb_sp2400_trk150_hmt_L1TE70',
+    #'mb_sp1700_trk110_hmt_L1TE60',
+    #'mb_sp1900_trk120_hmt_L1TE60',
+    #'mb_sp2100_trk130_hmt_L1TE60',
+    #'mb_sp2200_trk140_hmt_L1TE60',
+    #'mb_sp2400_trk150_hmt_L1TE60',
+    #'mb_sp1900_trk120_hmt_L1TE70',
+    #'mb_sp2100_trk130_hmt_L1TE70',
+    #'mb_sp2200_trk140_hmt_L1TE70',
+    #'mb_sp2400_trk150_hmt_L1TE70',
+    'mb_sp700_trk50_hmt_L1TE15',
+    'mb_sp900_trk60_hmt_L1TE15',
+    'mb_sp1100_trk70_hmt_L1TE15',
+    'mb_sp1200_trk80_hmt_L1TE15',
+    'mb_sp1400_trk90_hmt_L1TE15',
+    'mb_sp1600_trk100_hmt_L1TE15',
+    'mb_sp1700_trk110_hmt_L1TE15',
+    'mb_sp1900_trk120_hmt_L1TE15',
+    'mb_sp1100_trk70_hmt_L1TE25',
+    'mb_sp1200_trk80_hmt_L1TE25',
+    'mb_sp1400_trk90_hmt_L1TE25',
+    'mb_sp1600_trk100_hmt_L1TE25',
+    'mb_sp1700_trk110_hmt_L1TE25',
+    'mb_sp1900_trk120_hmt_L1TE25',
+    'mb_sp700_pusup350_trk50_hmt_L1TE15',
+    'mb_sp900_pusup400_trk60_hmt_L1TE15',
+    'mb_sp1100_pusup450_trk70_hmt_L1TE15',
+    'mb_sp1200_pusup500_trk80_hmt_L1TE15',
+    'mb_sp1400_pusup550_trk90_hmt_L1TE15',
+    'mb_sp1600_pusup600_trk100_hmt_L1TE15',
+    'mb_sp1700_pusup650_trk110_hmt_L1TE15',
+    'mb_sp1900_pusup700_trk120_hmt_L1TE15',
+    'mb_sp1100_pusup450_trk70_hmt_L1TE25',
+    'mb_sp1200_pusup500_trk80_hmt_L1TE25',
+    'mb_sp1400_pusup550_trk90_hmt_L1TE25',
+    'mb_sp1600_pusup600_trk100_hmt_L1TE25',
+    'mb_sp1700_pusup650_trk110_hmt_L1TE25',
+    'mb_sp1900_pusup700_trk120_hmt_L1TE25',
     #'mb_sp900_pusup400_trk50_hmt_L1TE5.0ETA24',
     #'mb_sp900_pusup400_trk60_hmt_L1TE5.0ETA24',
     #'mb_sp1000_pusup450_trk70_hmt_L1TE5.0ETA24',
@@ -2847,18 +2875,40 @@ ps_minb_list=[
     'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE10',
     'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE10',
     'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE10',
+    'mu4_mb_sp1100_trk70_hmt_L1MU4_TE20',
+    'mu4_mb_sp1200_trk80_hmt_L1MU4_TE20',
+    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE20',
+    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE20',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE20',
+    'mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE20',
+    'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE20',
+    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE20',
+    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE20',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE20',
+    'mu4_mb_sp1100_trk70_hmt_L1MU4_TE30',
+    'mu4_mb_sp1200_trk80_hmt_L1MU4_TE30',
+    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE30',
+    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE30',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE30',
+    'mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE30',
+    'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE30',
+    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE30',
+    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE30',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE30',
     'mu4_mb_sp1200_trk80_hmt_L1MU4_TE40',
     'mu4_mb_sp1400_trk90_hmt_L1MU4_TE40',
     'mu4_mb_sp1600_trk100_hmt_L1MU4_TE40',
-    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE50',
-    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE50',
-    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE50',
-    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50',
-    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50',
-    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE40',
+    #'mu4_mb_sp1400_trk90_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1600_trk100_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1700_trk110_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50',
     'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE40',
     'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE40',
     'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE40',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE40',
     'j40_mb_sp600_pusup300_trk40_hmt',
     'j40_mb_sp700_pusup350_trk50_hmt',
     'j40_mb_sp900_pusup400_trk60_hmt',
@@ -2873,20 +2923,20 @@ ps_minb_list=[
     'j40_mb_sp1200_trk80_hmt',
     'j40_mb_sp1400_trk90_hmt',
     'j40_mb_sp1600_trk100_hmt',
-    'j45_mb_sp600_pusup300_trk40_hmt',
-    'j45_mb_sp700_pusup350_trk50_hmt',
-    'j45_mb_sp900_pusup400_trk60_hmt',
-    'j45_mb_sp1100_pusup450_trk70_hmt',
-    'j45_mb_sp1200_pusup500_trk80_hmt',
-    'j45_mb_sp1400_pusup550_trk90_hmt',
-    'j45_mb_sp1600_pusup600_trk100_hmt',
-    'j45_mb_sp600_trk40_hmt',
-    'j45_mb_sp700_trk50_hmt',
-    'j45_mb_sp900_trk60_hmt',
-    'j45_mb_sp1100_trk70_hmt',
-    'j45_mb_sp1200_trk80_hmt',
-    'j45_mb_sp1400_trk90_hmt',
-    'j45_mb_sp1600_trk100_hmt',
+    'j50_mb_sp600_pusup300_trk40_hmt',
+    'j50_mb_sp700_pusup350_trk50_hmt',
+    'j50_mb_sp900_pusup400_trk60_hmt',
+    'j50_mb_sp1100_pusup450_trk70_hmt',
+    'j50_mb_sp1200_pusup500_trk80_hmt',
+    'j50_mb_sp1400_pusup550_trk90_hmt',
+    'j50_mb_sp1600_pusup600_trk100_hmt',
+    'j50_mb_sp600_trk40_hmt',
+    'j50_mb_sp700_trk50_hmt',
+    'j50_mb_sp900_trk60_hmt',
+    'j50_mb_sp1100_trk70_hmt',
+    'j50_mb_sp1200_trk80_hmt',
+    'j50_mb_sp1400_trk90_hmt',
+    'j50_mb_sp1600_trk100_hmt',
     'j60_mb_sp600_pusup300_trk40_hmt',
     'j60_mb_sp700_pusup350_trk50_hmt',
     'j60_mb_sp900_pusup400_trk60_hmt',
@@ -2915,6 +2965,34 @@ ps_minb_list=[
     'j110_mb_sp1200_trk80_hmt',
     'j110_mb_sp1400_trk90_hmt',
     'j110_mb_sp1600_trk100_hmt',
+    'j75_mb_sp600_pusup300_trk40_hmt',
+    'j75_mb_sp700_pusup350_trk50_hmt',
+    'j75_mb_sp900_pusup400_trk60_hmt',
+    'j75_mb_sp1100_pusup450_trk70_hmt',
+    'j75_mb_sp1200_pusup500_trk80_hmt',
+    'j75_mb_sp1400_pusup550_trk90_hmt',
+    'j75_mb_sp1600_pusup600_trk100_hmt',
+    'j75_mb_sp600_trk40_hmt',
+    'j75_mb_sp700_trk50_hmt',
+    'j75_mb_sp900_trk60_hmt',
+    'j75_mb_sp1100_trk70_hmt',
+    'j75_mb_sp1200_trk80_hmt',
+    'j75_mb_sp1400_trk90_hmt',
+    'j75_mb_sp1600_trk100_hmt',
+    'j85_mb_sp600_pusup300_trk40_hmt',
+    'j85_mb_sp700_pusup350_trk50_hmt',
+    'j85_mb_sp900_pusup400_trk60_hmt',
+    'j85_mb_sp1100_pusup450_trk70_hmt',
+    'j85_mb_sp1200_pusup500_trk80_hmt',
+    'j85_mb_sp1400_pusup550_trk90_hmt',
+    'j85_mb_sp1600_pusup600_trk100_hmt',
+    'j85_mb_sp600_trk40_hmt',
+    'j85_mb_sp700_trk50_hmt',
+    'j85_mb_sp900_trk60_hmt',
+    'j85_mb_sp1100_trk70_hmt',
+    'j85_mb_sp1200_trk80_hmt',
+    'j85_mb_sp1400_trk90_hmt',
+    'j85_mb_sp1600_trk100_hmt',
     'mb_sp400_trk40_hmt_L1MBTS_1_1',
     'mb_sp600_trk45_hmt_L1MBTS_1_1',
     'mb_sp700_trk55_hmt_L1MBTS_1_1',
@@ -3075,8 +3153,10 @@ ps_minb_list=[
     'noalg_mb_L1TE40',
     #'noalg_mb_L1TE40.0ETA24',
     'noalg_mb_L1TE50',
-    'noalg_mb_L1TE60',
-    'noalg_mb_L1TE70',
+    'noalg_mb_L1TE15',
+    'noalg_mb_L1TE25',
+    #'noalg_mb_L1TE60',
+    #'noalg_mb_L1TE70',
     #'noalg_mb_L1TE70.0ETA24',
     'noalg_mb_L1ZDC_A',
     'noalg_mb_L1ZDC_C',
@@ -3739,8 +3819,10 @@ ps_streamers_list = [
      'noalg_L1TE5',
      #'noalg_L1TE5.0ETA24',
      'noalg_L1TE50',
-     'noalg_L1TE60',
-     'noalg_L1TE70',
+     #'noalg_L1TE60',
+     #'noalg_L1TE70',
+     'noalg_L1TE15',
+     'noalg_L1TE25',
      'noalg_L1Topo',
      'noalg_L1XE10',
      'noalg_L1XE30',
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/menu/Physics_pp_v7.py b/Trigger/TriggerCommon/TriggerMenu/python/menu/Physics_pp_v7.py
index 59febf1363ce533d67278f02ce8be3ebbcac93f5..62fc44801a3b5ab49442d3720b65f27016d437c9 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/menu/Physics_pp_v7.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/menu/Physics_pp_v7.py
@@ -47,7 +47,7 @@ def setupMenu():
         ]
 
     TriggerFlags.MuonSlice.signatures = [
-        ['mu26_ivarmedium',	     'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream, 'express'], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu26_ivarmedium',	     'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream, 'express'], ['Primary:20000','RATE:SingleMuon', 'BW:Muon'], -1],
 #        ['mu26_ivarmedium_zROItest', 'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu28_ivarmedium',	     'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream], ['Primary:20000','RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu80',                   'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream], ['Primary:20000','RATE:SingleMuon', 'BW:Muon'], -1],
@@ -62,9 +62,9 @@ def setupMenu():
         ['mu20_msonly',            'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu14',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu14_ivarloose',         'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
-        ['mu6',                    'L1_MU6',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu6',                    'L1_MU6',            [], [PhysicsStream,'express'], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu6_msonly',             'L1_MU6',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
-        ['mu4',                    'L1_MU4',            [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu4',                    'L1_MU4',            [], [PhysicsStream,'express'], ['RATE:SingleMuon', 'BW:Muon'], -1],
         ['mu24_idperf',            'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream, 'express'], ['RATE:IDMonitoring', 'BW:Muon', 'BW:ID'], -1],
         ['mu20_idperf',            'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream, 'express'], ['RATE:IDMonitoring', 'BW:Muon', 'BW:ID'], -1],
         ['mu40_idperf',            'L1_MU20MU21',   ['L1_MU20'], [PhysicsStream, 'express'], ['RATE:IDMonitoring', 'BW:Muon', 'BW:ID'], -1],
@@ -93,12 +93,12 @@ def setupMenu():
         ['mu25_mucombTag_noEF_L1MU40', 'L1_MU20', [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
 
         # multi muons
-        ['2mu14',                  'L1_2MU10',          [], [PhysicsStream, 'express'], ['RATE:MultiMuon', 'BW:Muon'], -1],
+        ['2mu14',                  'L1_2MU10',          [], [PhysicsStream, 'express'], ['Primary:20000','RATE:MultiMuon', 'BW:Muon'], -1],
         ['2mu15_L12MU10',          'L1_2MU10',          [], [PhysicsStream], ['Primary:20000','RATE:MultiMuon', 'BW:Muon'], -1],
         ['3mu6',                   'L1_3MU6',           [], [PhysicsStream], ['Primary:20000','RATE:MultiMuon', 'BW:Muon'], -1],
         ['3mu6_msonly',            'L1_3MU6',           [], [PhysicsStream], ['Primary:20000','RATE:MultiMuon', 'BW:Muon'], -1],
         ['3mu8_msonly',            'L1_3MU6',           [], [PhysicsStream], ['Primary:20000','RATE:MultiMuon', 'BW:Muon'], -1],
-        ['mu24_mu8noL1',           'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream, 'express'], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu24','mu8noL1']]],
+        ['mu24_mu8noL1',           'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream, 'express'], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu24','mu8noL1']]],
         ['mu24_mu10noL1',          'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu24','mu10noL1']]],
         ['mu24_2mu4noL1',          'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu24','2mu4noL1']]],
         ['mu26_mu8noL1',           'L1_MU20MU21', ['L1_MU20',''], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu26','mu8noL1']]],
@@ -174,7 +174,7 @@ def setupMenu():
         ['mu20_msonly_iloosems_mu6noL1_msonly_nscan05_L1MU20_J40', 'L1_MU20_J40',   ['L1_MU20_J40','L2_mu20_msonly_iloosems'], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20_msonly_iloosems','mu6noL1_msonly_nscan05']]],
         ['mu20_msonly_iloosems_mu6noL1_msonly_nscan05_L1MU6_EMPTY', 'L1_MU6_EMPTY',   ['L1_MU20','L2_mu20_msonly_iloosems'], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20_msonly_iloosems','mu6noL1_msonly_nscan05']]],
         ['mu20_msonly_iloosems_mu6noL1_msonly_nscan05_L1MU4_UNPAIRED_ISO', 'L1_MU4_UNPAIRED_ISO',   ['L1_MU20','L2_mu20_msonly_iloosems'], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu20_msonly_iloosems','mu6noL1_msonly_nscan05']]],
-        ['mu6_dRl1_mu20_msonly_iloosems_mu6noL1_dRl1_msonly','L1_MU11_2MU6', [['L1_MU6','L1_MU6'],'L1_MU20',''], [PhysicsStream], ['RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu6_dRl1','mu20_msonly_iloosems','mu6noL1_dRl1_msonly']]],
+        ['mu6_dRl1_mu20_msonly_iloosems_mu6noL1_dRl1_msonly','L1_MU11_2MU6', [['L1_MU6','L1_MU6'],'L1_MU20',''], [PhysicsStream], ['Primary:20000','RATE:MultiMuon','BW:Muon'], -1,['serial',-1,['mu6_dRl1','mu20_msonly_iloosems','mu6noL1_dRl1_msonly']]],
 
         #Chains for testing 2e34 menus
         ['mu32_ivarmedium',          'L1_MU20MU21',           ['L1_MU20'], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
@@ -186,6 +186,22 @@ def setupMenu():
         ['3mu3_mu3noL1_calotag_0eta010_L13MU4',    'L1_3MU4', ['L1_3MU4',''], [BMultiMuonStream], [RATE_BMultiMuonTag, BW_BphysTag], -1,['serial',-1,['3mu3','mu3noL1_calotag_0eta010']]],
         ['3mu4_mu4noL1_calotag_0eta010',           'L1_3MU4', ['L1_3MU4',''], [BMultiMuonStream], [RATE_BMultiMuonTag, BW_BphysTag], -1,['serial',-1,['3mu4','mu4noL1_calotag_0eta010']]],
 
+        #HI Muons for 5TeV run ATR-17162
+        ['mu6_ivarloose',                   'L1_MU6',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu8',                   'L1_MU6',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu10',                   'L1_MU10',           [], [PhysicsStream,'express'], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu10_ivarloose',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu15_L1MU10',                   'L1_MU10',           [], [PhysicsStream,'express'], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        ['mu18_L1MU10',                   'L1_MU10',           [], [PhysicsStream], ['RATE:SingleMuon', 'BW:Muon'], -1],
+        
+        ['2mu4',                 'L1_2MU4', [], [PhysicsStream,'express'], [RATE_BMultiMuonTag, BW_BphysTag], -1],
+        ['2mu6',                 'L1_2MU6', [], [PhysicsStream,'express'], [RATE_BMultiMuonTag, BW_BphysTag], -1],
+        
+        ['2mu4_nomucomb',                 'L1_2MU4', [], [PhysicsStream], [RATE_BMultiMuonTag, BW_BphysTag], -1],
+        ['2mu6_nomucomb',                 'L1_2MU6', [], [PhysicsStream], [RATE_BMultiMuonTag, BW_BphysTag], -1],
+        
+
+        
         #AFP muons
         ['mu4_L1MU4_AFP_A_AND_C',                        'L1_MU4_AFP_A_AND_C',                  [],  ['MinBias'], [ 'RATE:MinBias','BW:MinBias'], -1],
         ['mu4_L1MU4_AFP_A_OR_C',                        'L1_MU4_AFP_A_OR_C',                  [],  ['MinBias'], [ 'RATE:MinBias','BW:MinBias'], -1],
@@ -270,7 +286,7 @@ def setupMenu():
         ['j420',                        'L1_J100', [], [PhysicsStream], ['Primary:17000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j440',                        'L1_J120', [], [PhysicsStream], ['Primary:17000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j450',                        'L1_J120', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
-        ['j460',                        'L1_J120', [], [PhysicsStream, 'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j460',                        'L1_J120', [], [PhysicsStream, 'express'], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j480',                        'L1_J120', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j500',                        'L1_J120', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
 
@@ -334,7 +350,7 @@ def setupMenu():
         ['j260_320eta490_nojcalib',     'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet',  'BW:Jet'], -1],
         ['j260_320eta490_lcw',          'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet',  'BW:Jet'], -1],
         ['j260_320eta490_lcw_subjes',   'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet',  'BW:Jet'], -1],
-        ['j260_320eta490_lcw_jes',      'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:17000','RATE:SingleJet',  'BW:Jet'], -1],
+        ['j260_320eta490_lcw_jes',      'L1_J75.31ETA49', [], [PhysicsStream], ['RATE:SingleJet',  'BW:Jet'], -1],
         ['j260_320eta490_lcw_sub',      'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet',  'BW:Jet'], -1],
         ['j260_320eta490_lcw_nojcalib', 'L1_J75.31ETA49', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet',  'BW:Jet'], -1],
         
@@ -350,7 +366,7 @@ def setupMenu():
         ['j440_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
         ['j460_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream], ['Primary:17000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j480_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
-        ['j500_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream, 'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j500_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream, 'express'], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j520_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
         ['j540_a10_lcw_subjes_L1J100',      'L1_J100', [], [PhysicsStream], ['Primary:20000','RATE:SingleJet', 'BW:Jet'], -1],
 
@@ -514,7 +530,7 @@ def setupMenu():
         ['j310_a10t_lcw_jes_60smcINF_j310_a10t_lcw_jes_L1SC111',   'L1_SC111-CJ15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
         ['j325_a10t_lcw_jes_60smcINF_j325_a10t_lcw_jes_L1SC111',   'L1_SC111-CJ15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
         ['j340_a10t_lcw_jes_60smcINF_j340_a10t_lcw_jes_L1SC111',   'L1_SC111-CJ15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
-        ['j360_a10t_lcw_jes_60smcINF_j360_a10t_lcw_jes_L1SC111',   'L1_SC111-CJ15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j360_a10t_lcw_jes_60smcINF_j360_a10t_lcw_jes_L1SC111',   'L1_SC111-CJ15', [], [PhysicsStream], ['Primary:17000','RATE:SingleJet', 'BW:Jet'], -1],
 
         # Trimmed + mass-cut di-jet support triggers (for mass efficiency bootstrap)
         ['2j330_a10t_lcw_jes_L1J100',                       'L1_J100', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
@@ -823,6 +839,55 @@ def setupMenu():
         ['j45_L1AFP_A_OR_C_J12',          'L1_AFP_A_OR_C_J12',                  [],  ['MinBias'], [ 'RATE:MinBias','BW:MinBias'], -1],
         ['j45_L1AFP_A_AND_C_J12',         'L1_AFP_A_AND_C_J12',                  [],  ['MinBias'], [ 'RATE:MinBias','BW:MinBias'], -1],
         ['j45_L1J12',                     'L1_J12', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        
+        #Jets for 5TeV run ATR-17162
+        ['j10_0eta490_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j20_0eta490_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j20_0eta490_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j30_0eta490_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j30_0eta490_L1TE20',      'L1_TE20', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j40_0eta490_L1TE20',      'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        
+        ['j10_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j20_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j20_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j30_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j30_L1TE20',      'L1_TE20', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j40_L1TE20',      'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        
+        ['j50_L1J12',      'L1_J12', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j50_L1J15',      'L1_J15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j60_L1J15',      'L1_J15', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j75_L1J20',      'L1_J20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j100_L1J20',      'L1_J20', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j100_L1J30',      'L1_J30', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j120_L1J30',      'L1_J30', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j150_L1J40',      'L1_J40', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        
+        ['j15_320eta490_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j25_320eta490_L1TE10',      'L1_TE10', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j35_320eta490_L1TE20',      'L1_TE20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j45_320eta490_L1TE30',      'L1_TE30', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j55_320eta490',      'L1_J15.31ETA49', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j75_320eta490',      'L1_J20.31ETA49', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        
+        ['j45_200eta320_L1J12',      'L1_J12', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j50_200eta320_L1J12',      'L1_J12', [], [PhysicsStream,'express'], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j60_200eta320_L1J20',      'L1_J20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        ['j75_200eta320_L1J20',      'L1_J20', [], [PhysicsStream], ['RATE:SingleJet', 'BW:Jet'], -1],
+        
+        ['2j10_320eta490_L1TE5',      'L1_TE5', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['2j20_320eta490_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['2j30_320eta490_L1TE20',      'L1_TE20', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['2j40_320eta490_L1TE30',      'L1_TE30', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        
+        ['3j50_L13J15',      'L1_3J15', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['3j60_L13J15',      'L1_3J15', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['3j75_L13J15',      'L1_3J15', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['4j50_L13J15',      'L1_3J15', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['4j60_L13J15',      'L1_3J15', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+        ['4j75_L14J20',      'L1_4J20', [], [PhysicsStream], ['RATE:MultiJet', 'BW:Jet'], -1],
+
 
 			 ]
 
@@ -964,10 +1029,10 @@ def setupMenu():
 
 				# Backup ATR-16986
         ['2j35_bmv2c1040_split_2j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
-        ['2j35_bmv2c1050_split_2j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
-        ['2j35_bmv2c1060_split_2j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
+        ['2j35_bmv2c1050_split_2j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
+        ['2j35_bmv2c1060_split_2j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
         ['2j35_bmv2c1050_split_3j35_boffperf_split', 'L1_5J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
-        ['2j35_bmv2c1060_split_3j35_boffperf_split', 'L1_5J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
+        ['2j35_bmv2c1060_split_3j35_boffperf_split', 'L1_5J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
         ['3j35_bmv2c1060_split_j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
         ['3j35_bmv2c1070_split_j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
         ['3j35_bmv2c1077_split_j35_boffperf_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
@@ -976,6 +1041,17 @@ def setupMenu():
         ['2j35_bmv2c1060_split_2j35_bmv2c1085_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
         ['2j35_bmv2c1070_split_2j35_bmv2c1085_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['Primary:20000','RATE:MultiBJet', 'BW:BJet'], -1],
         ['2j35_bmv2c1077_split_2j35_bmv2c1085_split_L14J15.0ETA25', 'L1_4J15.0ETA25', [], [PhysicsStream], ['RATE:MultiBJet', 'BW:BJet'], -1],
+			 
+		#bjets for 5TeV run ATR-17162 going to Main stream
+		['j35_bmv2c1070_split_0eta490_L1TE10',      'L1_TE10', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j40_bmv2c1070_split_L1J12',      'L1_J12', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j50_bmv2c1077_split_L1J12',      'L1_J12', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j45_gsc60_bmv2c1085_split_L1J12',      'L1_J12', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j55_gsc75_bmv2c1085_split_L1J15',      'L1_J15', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j60_gsc85_bmv2c1085_split_L1J20',      'L1_J20', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		['j60_gsc100_bmv2c1085_split_L1J20',      'L1_J20', [], [PhysicsStream], ['RATE:SingleBJet',  'BW:BJet'], -1],
+		
+		
 			 ]
    
 
@@ -1157,8 +1233,8 @@ def setupMenu():
         ['xe120_mht_em_L1XE55',                   'L1_XE55',[], [PhysicsStream], ['RATE:MET', 'BW:MET'], -1],
         ['xe120_tc_em_L1XE55','L1_XE55',[], [PhysicsStream], ['RATE:MET', 'BW:MET'], -1],
         ['xe120_tc_lcw_L1XE55',               'L1_XE55',[], [PhysicsStream], ['RATE:MET', 'BW:MET'], -1],
-  	['xe120_pufit_L1XE55',                'L1_XE55',[], [PhysicsStream], ['Primary:17000','RATE:MET', 'BW:MET'], -1],
-        ['xe120_pufit_wEFMu_L1XE55',              'L1_XE55',[], [PhysicsStream], ['Primary:17000','RATE:MET', 'BW:MET'], -1],
+        ['xe120_pufit_L1XE55',                'L1_XE55',[], [PhysicsStream], ['Primary:20000','RATE:MET', 'BW:MET'], -1],
+        ['xe120_pufit_wEFMu_L1XE55',              'L1_XE55',[], [PhysicsStream], ['Primary:20000','RATE:MET', 'BW:MET'], -1],
 #        ['xe120_trkmht_FTK_L1XE55', 'L1_XE55',[], [PhysicsStream], ['RATE:MET', 'BW:MET'], -1],
 
         ['xe130_L1XE55','L1_XE55',[], [PhysicsStream], ['Primary:17000','RATE:MET', 'BW:MET'], -1],
@@ -1194,7 +1270,7 @@ def setupMenu():
         ['xe90_mht_xe80_L1XE55', 'L1_XE55', ['L1_XE55','L1_XE55'], [PhysicsStream], ['RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe90_mht','xe80_L1XE55'] ]],
         ['xe100_mht_xe80_L1XE55','L1_XE55', ['L1_XE55','L1_XE55'], [PhysicsStream], ['RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe100_mht','xe80_L1XE55'] ]],
         ['xe110_mht_xe80_L1XE55','L1_XE55', ['L1_XE55','L1_XE55'], [PhysicsStream], ['RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe110_mht','xe80_L1XE55'] ]],
-	['xe120_mht_xe80_L1XE55','L1_XE55',  ['L1_XE55','L1_XE55'], [PhysicsStream], ['Primary:17000','RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe120_mht','xe80_L1XE55'] ]],
+	['xe120_mht_xe80_L1XE55','L1_XE55',  ['L1_XE55','L1_XE55'], [PhysicsStream], ['Primary:20000','RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe120_mht','xe80_L1XE55'] ]],
 	['xe130_mht_xe80_L1XE55','L1_XE55',  ['L1_XE55','L1_XE55'], [PhysicsStream], ['RATE:MET', 'BW:MET' ], -1, ['serial',-1,['xe130_mht','xe80_L1XE55'] ]],
 
 
@@ -1628,14 +1704,14 @@ def setupMenu():
         ['e26_lhtight_idperf_L1EM22VHIM',        'L1_EM22VHIM',    [], [PhysicsStream], ['RATE:IDMonitoring', 'BW:Egamma', 'BW:ID'],-1],
         ['e28_lhtight_idperf_L1EM24VHIM',        'L1_EM24VHIM',    [], [PhysicsStream, 'express'], ['RATE:IDMonitoring', 'BW:Egamma', 'BW:ID'],-1],
 
-        ['2g3_loose_dPhi15_L12EM3_VTE70', 'L1_2EM3_VTE70', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
-        ['2g3_loose_L12EM3_VTE70', 'L1_2EM3_VTE70', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
-        ['2g3_medium_dPhi15_L12EM3_VTE70', 'L1_2EM3_VTE70', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
+        ['2g3_loose_dPhi15_L12EM3_VTE50', 'L1_2EM3_VTE50', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
+        ['2g3_loose_L12EM3_VTE50', 'L1_2EM3_VTE50', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
+        ['2g3_medium_dPhi15_L12EM3_VTE50', 'L1_2EM3_VTE50', [], [PhysicsStream],['RATE:SinglePhoton','BW:Egamma'],-1],
 
         ['g0_perf_L1EM3_EMPTY',                  'L1_EM3_EMPTY', [], [PhysicsStream], ['RATE:SinglePhoton',   'BW:Egamma'], -1],        
         ['e0_perf_L1EM3_EMPTY',                  'L1_EM3_EMPTY', [], [PhysicsStream], ['RATE:SinglePhoton',   'BW:Egamma'], -1],        
 
-        ['g10_loose',                            'L1_EM7',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g10_loose',                            'L1_EM7',  [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
         ['g20_loose_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
 
         ['g10_etcut',                     'L1_EM7',   [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
@@ -1673,8 +1749,8 @@ def setupMenu():
         ['g0_hiptrt_L1EM24VHIM',                'L1_EM24VHIM', [], [PhysicsStream], ['Primary:20000','RATE:SinglePhoton', 'BW:Egamma'], -1],
 
         # PS-ed trigger to supmbined chains
-        ['g15_loose_L1EM7',               'L1_EM7',   [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
-        ['g20_loose_L1EM12',              'L1_EM12',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], # pass through
+        ['g15_loose_L1EM7',               'L1_EM7',   [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
+        ['g20_loose_L1EM12',              'L1_EM12',  [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'], -1], # pass through
         ['g40_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
         ['g45_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
         ['g50_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
@@ -1682,8 +1758,8 @@ def setupMenu():
         ['g100_loose',                    'L1_EM24VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'], -1], 
 
         # Rerun mode and PS
-        ['g25_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
-        ['g35_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g25_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g35_loose_L1EM15',              'L1_EM15',  [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
         ['g60_loose',                     'L1_EM24VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
         ['g70_loose',                     'L1_EM24VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
 
@@ -1724,7 +1800,7 @@ def setupMenu():
         ['2g20_loose',                   'L1_2EM15VH', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1], 
 
 
-        ['2g10_loose',                           'L1_2EM7', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
+        ['2g10_loose',                           'L1_2EM7', [], [PhysicsStream,'express'], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
 
         ['e17_lhloose_cutd0dphideta_L1EM15',     'L1_EM15', [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
         ['e17_lhloose_nod0_L1EM15',              'L1_EM15', [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
@@ -1747,7 +1823,7 @@ def setupMenu():
         ['e24_lhtight_nod0_ivarloose',                'L1_EM20VHI',    [], [PhysicsStream, 'express'], ['RATE:SingleElectron', 'BW:Egamma'],-1],  
 
         ['e26_lhtight_nod0_e15_etcut_L1EM7_Zee',    	  'L1_EM22VHI', ['L1_EM22VHI','L1_EM7'], [PhysicsStream], ['Primary:17000','RATE:MultiElectron', 'BW:Egamma'],-1 ],
-        ['e28_lhtight_nod0_e15_etcut_L1EM7_Zee',    	  'L1_EM24VHI', ['L1_EM24VHI','L1_EM7'], [PhysicsStream, 'express'], ['RATE:MultiElectron', 'BW:Egamma'],-1 ],
+        ['e28_lhtight_nod0_e15_etcut_L1EM7_Zee',    	  'L1_EM24VHI', ['L1_EM24VHI','L1_EM7'], [PhysicsStream, 'express'], ['Primary:20000','RATE:MultiElectron', 'BW:Egamma'],-1 ],
         ['e26_lhtight_nod0_L1EM22VHIM_e15_etcut_L1EM7_Zee', 'L1_EM22VHIM',  ['L1_EM22VHIM','L1_EM7'], [PhysicsStream], ['Primary:17000','RATE:MultiElectron', 'BW:Egamma'],-1],
         ['e28_lhtight_nod0_L1EM24VHIM_e15_etcut_L1EM7_Zee', 'L1_EM24VHIM',  ['L1_EM24VHIM','L1_EM7'], [PhysicsStream], ['Primary:20000','RATE:MultiElectron', 'BW:Egamma'],-1],
 
@@ -1790,7 +1866,7 @@ def setupMenu():
         ['g140_tight_L1EM24VHIM',        'L1_EM24VHIM', [], [PhysicsStream], ['Primary:20000','RATE:SinglePhoton','BW:Egamma'],-1],
         ['g160_loose',        'L1_EM24VHI', [], [PhysicsStream], ['RATE:SinglePhoton','BW:Egamma'],-1],
         ['g180_loose',        'L1_EM24VHI', [], [PhysicsStream], ['RATE:SinglePhoton','BW:Egamma'],-1],
-        ['g200_loose',        'L1_EM24VHI', [], [PhysicsStream, 'express'], ['RATE:SinglePhoton','BW:Egamma'],-1],
+        ['g200_loose',        'L1_EM24VHI', [], [PhysicsStream, 'express'], ['Primary:20000','RATE:SinglePhoton','BW:Egamma'],-1],
         ['g200_loose_L1EM24VHIM',        'L1_EM24VHIM', [], [PhysicsStream], ['Primary:20000','RATE:SinglePhoton','BW:Egamma'],-1],
         ['e140_lhloose_nod0', 'L1_EM22VHI', [], [PhysicsStream], ['Primary:17000','RATE:SingleElectron', 'BW:Egamma'],-1],
 
@@ -1904,7 +1980,7 @@ def setupMenu():
         ['2e17_lhvloose_nod0',                   'L1_2EM15VH', [], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],
         ['2e17_lhvloose_nod0_L12EM15VHI',         'L1_2EM15VHI', [], [PhysicsStream], ['Primary:20000','RATE:MultiElectron', 'BW:Egamma'],-1],
         ['2e19_lhvloose_nod0',         'L1_2EM15VHI', [], [PhysicsStream], ['Primary:20000','RATE:MultiElectron', 'BW:Egamma'],-1],
-        ['2e24_lhvloose_nod0',                   'L1_2EM20VH', [], [PhysicsStream, 'express'], ['RATE:MultiElectron', 'BW:Egamma'],-1],
+        ['2e24_lhvloose_nod0',                   'L1_2EM20VH', [], [PhysicsStream, 'express'], ['Primary:20000','RATE:MultiElectron', 'BW:Egamma'],-1],
         ['e17_lhloose_nod0_2e12_lhloose_nod0_L1EM15VH_3EM10VH',                       'L1_EM15VH_3EM10VH', ['L1_EM15VH','L1_3EM10VH'], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],  
 
         ['e22_lhloose_nod0_e12_lhloose_nod0_e10_lhloose_nod0_L1EM20VH_2EM10VH_3EM8VH',    'L1_EM20VH_2EM10VH_3EM8VH', ['L1_EM20VH','L1_2EM10VH','L1_3EM8VH'], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],
@@ -1936,7 +2012,7 @@ def setupMenu():
         #Diphoton triggers
         ['g35_loose_g25_loose',                      'L1_2EM15VH', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
         ['g35_loose_g25_loose_L12EM20VH',            'L1_2EM20VH', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
-        ['g35_medium_g25_medium_L12EM20VH',          'L1_2EM20VH', [], [PhysicsStream, 'express'], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
+        ['g35_medium_g25_medium_L12EM20VH',          'L1_2EM20VH', [], [PhysicsStream, 'express'], ['Primary:20000','RATE:MultiPhoton', 'BW:Egamma'],-1],
         ['g35_medium_g25_medium',                    'L1_2EM15VH', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1], 
 
         # LLP
@@ -1958,7 +2034,7 @@ def setupMenu():
         ['e26_lhmedium_nod0_ivartight',       'L1_EM22VHI', [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
 
         ['e28_lhtight_nod0',                  'L1_EM24VHI', [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
-        ['e28_lhtight_nod0_ivarloose',        'L1_EM24VHI', [], [PhysicsStream,'express'], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e28_lhtight_nod0_ivarloose',        'L1_EM24VHI', [], [PhysicsStream,'express'], ['Primary:20000','RATE:SingleElectron', 'BW:Egamma'],-1],
         ['e28_lhtight_nod0_ivarloose_L1EM24VHIM',        'L1_EM24VHIM', [], [PhysicsStream], ['Primary:20000','RATE:SingleElectron', 'BW:Egamma'],-1],
 
         ['e28_lhmedium_nod0_ivarloose',       'L1_EM24VHI', [], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
@@ -2109,7 +2185,50 @@ def setupMenu():
 
         ['g10_loose_L1EM3',                  'L1_EM3',                  [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['e10_lhloose_L1EM3',                  'L1_EM3',                  [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-
+        
+        #HI egamma for 5TeV run ATR-17162 going to Main stream
+        ['g15_etcut_L1EM7',                     'L1_EM7', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_medium_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_tight_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_etcut_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_medium',                     'L1_EM15VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_tight',                     'L1_EM15VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g20_etcut',                     'L1_EM15VHI', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g25_medium_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g25_tight_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g25_etcut_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g30_loose_L1EM15',                     'L1_EM15', [], [PhysicsStream,'express'], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['g30_etcut_L1EM15',                     'L1_EM15', [], [PhysicsStream], ['RATE:SinglePhoton', 'BW:Egamma'],-1],
+        ['2g10_loose_L12EM7',                     'L1_2EM7', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
+        ['2g15_loose_L12EM7',                     'L1_2EM7', [], [PhysicsStream], ['RATE:MultiPhoton', 'BW:Egamma'],-1],
+        
+        ['e10_loose_L1EM7',                     'L1_EM7',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e10_lhloose_L1EM7',                     'L1_EM7',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_loose_L1EM7',                     'L1_EM7',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_lhloose_L1EM7',                     'L1_EM7',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_lhloose_nod0_L1EM7',                     'L1_EM7',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_loose_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_lhloose_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_lhmedium_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_etcut_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e15_lhmedium_nod0_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_vloose_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_lhvloose_L1EM12',                     'L1_EM12',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_loose_L1EM15',                     'L1_EM15',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_lhloose_L1EM15',                     'L1_EM15',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_etcut_L1EM15',                     'L1_EM15',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_lhloose_nod0_L1EM15',                     'L1_EM15',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_vloose',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_lhvloose',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e20_etcut',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e24_vloose_L1EM15VH',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e24_lhvloose_L1EM15VH',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e24_etcut_L1EM15VH',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['e24_lhvloose_nod0_L1EM15VH',                     'L1_EM15VH',[], [PhysicsStream], ['RATE:SingleElectron', 'BW:Egamma'],-1],
+        ['2e15_lhloose_L12EM12',                     'L1_2EM12',[], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],
+        ['2e15_loose_L12EM12',                     'L1_2EM12',[], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],
+        ['2e15_lhloose_nod0_L12EM12',                     'L1_2EM12',[], [PhysicsStream], ['RATE:MultiElectron', 'BW:Egamma'],-1],
+        
 			 ]
 
     TriggerFlags.BphysicsSlice.signatures = [
@@ -2300,7 +2419,7 @@ def setupMenu():
         ['2mu6_bDimu_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',      'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream, 'express'], [RATE_BphysTag,BW_BphysTag], -1, False],
         ['2mu6_bDimu_novtx_noos_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',      'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1, False],
         ['2mu6_bJpsimumu_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',  'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream, 'express'], [RATE_BphysTag,BW_BphysTag], -1, False],
-        ['2mu6_bUpsimumu_L1BPH-8M15-2MU6_BPH-0DR22-2MU6', 'L1_BPH-8M15-2MU6_BPH-0DR22-2MU6',     ['L1_2MU6'], [PhysicsStream, 'express'], ['RATE:Bphysics','BW:Bphys'], -1, False],
+        ['2mu6_bUpsimumu_L1BPH-8M15-2MU6_BPH-0DR22-2MU6', 'L1_BPH-8M15-2MU6_BPH-0DR22-2MU6',     ['L1_2MU6'], [PhysicsStream, 'express'], ['Primary:20000','RATE:Bphysics','BW:Bphys'], -1, False],
         ['2mu6_bBmumu_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',     'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream, 'express'], [RATE_BphysTag,BW_BphysTag], -1, False],
         ['2mu6_bBmumuxv2_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',  'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1, False],
         ['2mu6_bBmumux_BcmumuDsloose_L1BPH-2M9-2MU6_BPH-2DR15-2MU6',  'L1_BPH-2M9-2MU6_BPH-2DR15-2MU6',     ['L1_2MU6'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1, False],
@@ -2400,6 +2519,10 @@ def setupMenu():
         # support triggers ATR-15851
         ['mu11_mu6_bNocut',                 'L1_MU11_2MU6', ['L1_MU11','L1_MU6'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
         ['mu11_mu6noL1_bNocut_L1MU11_2MU6',  'L1_MU11_2MU6', ['L1_MU11','L2_mu6'], [BPhysicsStream], [RATE_BphysTag,BW_BphysTag], -1,['serial',-1,['mu11','mu6noL1']]],
+        
+        #HI bphysics for 5TeV run ATR-17162 going to Main stream
+        ['2mu4_bJpsimumu',                 'L1_2MU4', [], [PhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
+        ['2mu4_bUpsimumu',                 'L1_2MU4', [], [PhysicsStream], [RATE_BphysTag,BW_BphysTag], -1],
 
 			 ]
 
@@ -2447,6 +2570,13 @@ def setupMenu():
         ['g20_tight_icaloloose_j35_bmv2c1077_split_3j35_0eta490_invm500', 'L1_EM18VHI_MJJ-300', ['','',''], [PhysicsStream], ['Primary:20000','RATE:EgammaJet', 'BW:Egamma', 'BW:Jet'], -1,['serial',-1,["g20_tight_icaloloose","3j35_0eta490_invm500","j35_bmv2c1077_split"]]],
         ['g27_medium_L1EM24VHI_j35_bmv2c1077_split_3j35_0eta490_invm700', 'L1_EM24VHI', ['L1_EM24VHI','',''], [PhysicsStream], ['Primary:20000','RATE:EgammaJet', 'BW:Egamma', 'BW:Jet'], -1,['serial',-1,["g27_medium_L1EM24VHI","3j35_0eta490_invm700","j35_bmv2c1077_split"]]],
         ['g27_medium_L1EM24VHI_2j35_bmv2c1077_split_2j35_0eta490', 'L1_EM24VHI', ['L1_EM24VHI','',''], [PhysicsStream], ['Primary:20000','RATE:EgammaJet', 'BW:Egamma', 'BW:Jet'], -1,['serial',-1,["g27_medium_L1EM24VHI","2j35_0eta490","2j35_bmv2c1077_split"]]],
+        
+        ['mu4_j40_dr05', 'L1_MU4',     ['L1_MU4', ''], [PhysicsStream], ['RATE:MuonBjet', 'BW:BJet_combined'], -1,['serial',-1,['mu4', 'j40'] ]],
+	    ['mu4_j50_dr05', 'L1_MU4',     ['L1_MU4', ''], [PhysicsStream], ['RATE:MuonBjet', 'BW:BJet_combined'], -1,['serial',-1,['mu4', 'j50'] ]],
+	    ['mu4_j60_dr05', 'L1_MU4',     ['L1_MU4', ''], [PhysicsStream], ['RATE:MuonBjet', 'BW:BJet_combined'], -1,['serial',-1,['mu4', 'j60'] ]],
+        ['mu6_j30_dr05', 'L1_MU6',     ['L1_MU6', ''], [PhysicsStream], ['RATE:MuonBjet', 'BW:BJet_combined'], -1,['serial',-1,['mu6', 'j30'] ]],
+
+
 
 
         ### ATR-14356: bjets+HT VBF chians
@@ -2658,7 +2788,7 @@ def setupMenu():
         ['mu6_j225_gsc320_boffperf_split_dr05_dz02', 'L1_MU6_J75', ['L1_MU6', ''], [PhysicsStream], ['RATE:MuonBJet', 'BW:BJet_combined'], -1,['serial',-1,['mu6', 'j225_gsc320_boffperf_split'] ]],
 
         ['mu6_j225_gsc320_boffperf_split', 'L1_MU6_J75',     ['L1_MU6', ''], [PhysicsStream], ['RATE:MuonBJet', 'BW:BJet_combined'], -1,['serial',-1,['mu6', 'j225_gsc320_boffperf_split'] ]],
-        ['mu6_j225_gsc400_boffperf_split_dr05_dz02', 'L1_MU6_J75', ['L1_MU6', ''], [PhysicsStream], ['Primary:17000','RATE:MuonBJet', 'BW:BJet_combined'], -1,['serial',-1,['mu6', 'j225_gsc400_boffperf_split'] ]],
+        ['mu6_j225_gsc400_boffperf_split_dr05_dz02', 'L1_MU6_J75', ['L1_MU6', ''], [PhysicsStream], ['RATE:MuonBJet', 'BW:BJet_combined'], -1,['serial',-1,['mu6', 'j225_gsc400_boffperf_split'] ]],
 
         ### ATR-14348: L1Topo egamma chains
         ['e18_etcut_trkcut_xs30_j15_perf_xe30_6dphi05_mt35_L1EM15_W-MT35_W-05DPHI-JXE-0_W-05DPHI-EM15XE_XS30', 'L1_EM15_W-MT35_W-05DPHI-JXE-0_W-05DPHI-EM15XE_XS30', ['L1_EM15','','',''], [PhysicsStream], ['RATE:EgammaMET', 'BW:Egamma'], -1, ['serial',-1,["e18_etcut_trkcut","xs30","j15_perf","xe30"]]],
@@ -3028,7 +3158,7 @@ def setupMenu():
         #HMT + muons
         ['mu4_mb_sp600_trk40_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp600_trk40_hmt'],False]],
         ['mu4_mb_sp700_trk50_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp700_trk50_hmt'],False]],
-        ['mu4_mb_sp900_trk60_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp900_trk60_hmt'],False]],
+        ['mu4_mb_sp900_trk60_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp900_trk60_hmt'],False]],
         ['mu4_mb_sp1100_trk70_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_trk70_hmt'],False]],
         ['mu4_mb_sp1200_trk80_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_trk80_hmt'],False]],
         ['mu4_mb_sp1400_trk90_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
@@ -3036,25 +3166,51 @@ def setupMenu():
 
         ['mu4_mb_sp600_pusup300_trk40_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp600_pusup300_trk40_hmt'],False]],
         ['mu4_mb_sp700_pusup350_trk50_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp700_pusup350_trk50_hmt'],False]],
-        ['mu4_mb_sp900_pusup400_trk60_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp900_pusup400_trk60_hmt'],False]],
+        ['mu4_mb_sp900_pusup400_trk60_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp900_pusup400_trk60_hmt'],False]],
         ['mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_pusup450_trk70_hmt'],False]],
         ['mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_pusup500_trk80_hmt'],False]],
         ['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
         ['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE10', 'L1_MU4_TE10', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
         
+        ['mu4_mb_sp1100_trk70_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_trk70_hmt'],False]],
+        ['mu4_mb_sp1200_trk80_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_trk80_hmt'],False]],
+        ['mu4_mb_sp1400_trk90_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
+        ['mu4_mb_sp1600_trk100_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_trk100_hmt'],False]],
+        ['mu4_mb_sp1700_trk110_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_trk110_hmt'],False]],
+        
+        ['mu4_mb_sp1100_trk70_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_trk70_hmt'],False]],
+        ['mu4_mb_sp1200_trk80_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_trk80_hmt'],False]],
+        ['mu4_mb_sp1400_trk90_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
+        ['mu4_mb_sp1600_trk100_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_trk100_hmt'],False]],
+        ['mu4_mb_sp1700_trk110_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_trk110_hmt'],False]],
+        
         ['mu4_mb_sp1200_trk80_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_trk80_hmt'],False]],
         ['mu4_mb_sp1400_trk90_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
         ['mu4_mb_sp1600_trk100_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_trk100_hmt'],False]],
-        ['mu4_mb_sp1400_trk90_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
-        ['mu4_mb_sp1600_trk100_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_trk100_hmt'],False]],
-        ['mu4_mb_sp1700_trk110_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_trk110_hmt'],False]],
-
-        ['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
-        ['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
-        ['mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_pusup650_trk110_hmt'],False]],
+        ['mu4_mb_sp1700_trk110_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_trk110_hmt'],False]],
+        #['mu4_mb_sp1400_trk90_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_trk90_hmt'],False]],
+        #['mu4_mb_sp1600_trk100_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_trk100_hmt'],False]],
+        #['mu4_mb_sp1700_trk110_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_trk110_hmt'],False]],
+
+        #['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        #['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        #['mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50', 'L1_MU4_TE50', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_pusup650_trk110_hmt'],False]],
+        ['mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_pusup450_trk70_hmt'],False]],
+        ['mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_pusup500_trk80_hmt'],False]],
+        ['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        ['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        ['mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE20', 'L1_MU4_TE20', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_pusup650_trk110_hmt'],False]],
+		
+        ['mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1100_pusup450_trk70_hmt'],False]],
+        ['mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_pusup500_trk80_hmt'],False]],
+        ['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        ['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        ['mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE30', 'L1_MU4_TE30', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_pusup650_trk110_hmt'],False]],
+		
         ['mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1200_pusup500_trk80_hmt'],False]],
         ['mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1400_pusup550_trk90_hmt'],False]],
         ['mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        ['mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE40', 'L1_MU4_TE40', ['', ''], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['mu4', 'mb_sp1700_pusup650_trk110_hmt'],False]],
 		
 		#HMT + jets
 		['j40_mb_sp600_pusup300_trk40_hmt', 'L1_J12',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j40', 'mb_sp600_pusup300_trk40_hmt'],False]],
@@ -3073,25 +3229,25 @@ def setupMenu():
         ['j40_mb_sp1400_trk90_hmt', 'L1_J12',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j40', 'mb_sp1400_trk90_hmt'],False]],
         ['j40_mb_sp1600_trk100_hmt', 'L1_J12',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j40', 'mb_sp1600_trk100_hmt'],False]],
         
-        ['j45_mb_sp600_pusup300_trk40_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp600_pusup300_trk40_hmt'],False]],
-        ['j45_mb_sp700_pusup350_trk50_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp700_pusup350_trk50_hmt'],False]],
-        ['j45_mb_sp900_pusup400_trk60_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp900_pusup400_trk60_hmt'],False]],
-        ['j45_mb_sp1100_pusup450_trk70_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1100_pusup450_trk70_hmt'],False]],
-        ['j45_mb_sp1200_pusup500_trk80_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1200_pusup500_trk80_hmt'],False]],
-        ['j45_mb_sp1400_pusup550_trk90_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1400_pusup550_trk90_hmt'],False]],
-        ['j45_mb_sp1600_pusup600_trk100_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        ['j50_mb_sp600_pusup300_trk40_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp600_pusup300_trk40_hmt'],False]],
+        ['j50_mb_sp700_pusup350_trk50_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp700_pusup350_trk50_hmt'],False]],
+        ['j50_mb_sp900_pusup400_trk60_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp900_pusup400_trk60_hmt'],False]],
+        ['j50_mb_sp1100_pusup450_trk70_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1100_pusup450_trk70_hmt'],False]],
+        ['j50_mb_sp1200_pusup500_trk80_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1200_pusup500_trk80_hmt'],False]],
+        ['j50_mb_sp1400_pusup550_trk90_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        ['j50_mb_sp1600_pusup600_trk100_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1600_pusup600_trk100_hmt'],False]],
         
-        ['j45_mb_sp600_trk40_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp600_trk40_hmt'],False]],
-        ['j45_mb_sp700_trk50_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp700_trk50_hmt'],False]],
-        ['j45_mb_sp900_trk60_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp900_trk60_hmt'],False]],
-        ['j45_mb_sp1100_trk70_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1100_trk70_hmt'],False]],
-        ['j45_mb_sp1200_trk80_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1200_trk80_hmt'],False]],
-        ['j45_mb_sp1400_trk90_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1400_trk90_hmt'],False]],
-        ['j45_mb_sp1600_trk100_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j45', 'mb_sp1600_trk100_hmt'],False]],
+        ['j50_mb_sp600_trk40_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp600_trk40_hmt'],False]],
+        ['j50_mb_sp700_trk50_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp700_trk50_hmt'],False]],
+        ['j50_mb_sp900_trk60_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp900_trk60_hmt'],False]],
+        ['j50_mb_sp1100_trk70_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1100_trk70_hmt'],False]],
+        ['j50_mb_sp1200_trk80_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1200_trk80_hmt'],False]],
+        ['j50_mb_sp1400_trk90_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1400_trk90_hmt'],False]],
+        ['j50_mb_sp1600_trk100_hmt', 'L1_J15',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j50', 'mb_sp1600_trk100_hmt'],False]],
         
         ['j60_mb_sp600_pusup300_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp600_pusup300_trk40_hmt'],False]],
         ['j60_mb_sp700_pusup350_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp700_pusup350_trk50_hmt'],False]],
-        ['j60_mb_sp900_pusup400_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp900_pusup400_trk60_hmt'],False]],
+        ['j60_mb_sp900_pusup400_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias','express'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp900_pusup400_trk60_hmt'],False]],
         ['j60_mb_sp1100_pusup450_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1100_pusup450_trk70_hmt'],False]],
         ['j60_mb_sp1200_pusup500_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1200_pusup500_trk80_hmt'],False]],
         ['j60_mb_sp1400_pusup550_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1400_pusup550_trk90_hmt'],False]],
@@ -3099,12 +3255,44 @@ def setupMenu():
         
         ['j60_mb_sp600_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp600_trk40_hmt'],False]],
         ['j60_mb_sp700_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp700_trk50_hmt'],False]],
-        ['j60_mb_sp900_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp900_trk60_hmt'],False]],
+        ['j60_mb_sp900_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias','express'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp900_trk60_hmt'],False]],
         ['j60_mb_sp1100_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1100_trk70_hmt'],False]],
         ['j60_mb_sp1200_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1200_trk80_hmt'],False]],
         ['j60_mb_sp1400_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1400_trk90_hmt'],False]],
         ['j60_mb_sp1600_trk100_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j60', 'mb_sp1600_trk100_hmt'],False]],
         
+        ['j75_mb_sp600_pusup300_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp600_pusup300_trk40_hmt'],False]],
+        ['j75_mb_sp700_pusup350_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp700_pusup350_trk50_hmt'],False]],
+        ['j75_mb_sp900_pusup400_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp900_pusup400_trk60_hmt'],False]],
+        ['j75_mb_sp1100_pusup450_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1100_pusup450_trk70_hmt'],False]],
+        ['j75_mb_sp1200_pusup500_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1200_pusup500_trk80_hmt'],False]],
+        ['j75_mb_sp1400_pusup550_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        ['j75_mb_sp1600_pusup600_trk100_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        
+        ['j75_mb_sp600_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp600_trk40_hmt'],False]],
+        ['j75_mb_sp700_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp700_trk50_hmt'],False]],
+        ['j75_mb_sp900_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp900_trk60_hmt'],False]],
+        ['j75_mb_sp1100_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1100_trk70_hmt'],False]],
+        ['j75_mb_sp1200_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1200_trk80_hmt'],False]],
+        ['j75_mb_sp1400_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1400_trk90_hmt'],False]],
+        ['j75_mb_sp1600_trk100_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j75', 'mb_sp1600_trk100_hmt'],False]],
+        
+        ['j85_mb_sp600_pusup300_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp600_pusup300_trk40_hmt'],False]],
+        ['j85_mb_sp700_pusup350_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp700_pusup350_trk50_hmt'],False]],
+        ['j85_mb_sp900_pusup400_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp900_pusup400_trk60_hmt'],False]],
+        ['j85_mb_sp1100_pusup450_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1100_pusup450_trk70_hmt'],False]],
+        ['j85_mb_sp1200_pusup500_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1200_pusup500_trk80_hmt'],False]],
+        ['j85_mb_sp1400_pusup550_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1400_pusup550_trk90_hmt'],False]],
+        ['j85_mb_sp1600_pusup600_trk100_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1600_pusup600_trk100_hmt'],False]],
+        
+        ['j85_mb_sp600_trk40_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp600_trk40_hmt'],False]],
+        ['j85_mb_sp700_trk50_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp700_trk50_hmt'],False]],
+        ['j85_mb_sp900_trk60_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp900_trk60_hmt'],False]],
+        ['j85_mb_sp1100_trk70_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1100_trk70_hmt'],False]],
+        ['j85_mb_sp1200_trk80_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1200_trk80_hmt'],False]],
+        ['j85_mb_sp1400_trk90_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1400_trk90_hmt'],False]],
+        ['j85_mb_sp1600_trk100_hmt', 'L1_J20',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j85', 'mb_sp1600_trk100_hmt'],False]],
+        
         ['j110_mb_sp600_pusup300_trk40_hmt', 'L1_J30',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j110', 'mb_sp600_pusup300_trk40_hmt'],False]],
         ['j110_mb_sp700_pusup350_trk50_hmt', 'L1_J30',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j110', 'mb_sp700_pusup350_trk50_hmt'],False]],
         ['j110_mb_sp900_pusup400_trk60_hmt', 'L1_J30',  ['', ''], ['MinBias'],["BW:MinBias", "RATE:MinBias"], 1, ['serial', -1, ['j110', 'mb_sp900_pusup400_trk60_hmt'],False]],
@@ -3319,7 +3507,7 @@ def setupMenu():
         ['mb_sp600_pusup300_trk40_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp700_pusup350_trk50_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp900_pusup400_trk50_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp900_pusup400_trk60_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp900_pusup400_trk60_hmt_L1TE5', 'L1_TE5', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1000_pusup450_trk70_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1100_pusup450_trk70_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1200_pusup500_trk80_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3336,7 +3524,7 @@ def setupMenu():
         ['mb_sp900_pusup400_trk60_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1000_pusup450_trk70_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1100_pusup450_trk70_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1200_pusup500_trk80_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_pusup500_trk80_hmt_L1TE10', 'L1_TE10', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1400_pusup550_trk90_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1600_pusup600_trk100_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1700_pusup650_trk110_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3354,7 +3542,7 @@ def setupMenu():
         ['mb_sp1600_pusup600_trk100_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1700_pusup650_trk110_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1800_pusup700_trk110_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1900_pusup700_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_pusup700_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2100_pusup750_trk130_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2100_pusup900_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2200_pusup800_trk140_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3398,23 +3586,23 @@ def setupMenu():
         ['mb_sp2200_pusup800_trk140_hmt_L1TE50', 'L1_TE50', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2400_pusup850_trk150_hmt_L1TE50', 'L1_TE50', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
-        ['mb_sp1700_pusup650_trk110_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1900_pusup700_trk120_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2100_pusup750_trk130_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2200_pusup800_trk140_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2400_pusup850_trk150_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1700_pusup650_trk110_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1900_pusup700_trk120_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2100_pusup750_trk130_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2200_pusup800_trk140_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2400_pusup850_trk150_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
-        ['mb_sp1900_pusup700_trk120_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2100_pusup750_trk130_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2200_pusup800_trk140_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2400_pusup850_trk150_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1900_pusup700_trk120_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2100_pusup750_trk130_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2200_pusup800_trk140_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2400_pusup850_trk150_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
         
         #HMT without pileup supprestion seeded by L1_TE triggers
         ['mb_sp600_trk40_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp700_trk50_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp900_trk50_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp900_trk60_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp900_trk60_hmt_L1TE5', 'L1_TE5', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1000_trk70_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1100_trk70_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1200_trk80_hmt_L1TE5', 'L1_TE5', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3431,7 +3619,7 @@ def setupMenu():
         ['mb_sp900_trk60_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1000_trk70_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1100_trk70_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1200_trk80_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_trk80_hmt_L1TE10', 'L1_TE10', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1400_trk90_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1600_trk100_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1700_trk110_hmt_L1TE10', 'L1_TE10', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3449,7 +3637,7 @@ def setupMenu():
         ['mb_sp1600_trk100_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1700_trk110_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp1800_trk110_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1900_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2100_trk130_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2100_trk120_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2200_trk140_hmt_L1TE20', 'L1_TE20', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3493,16 +3681,16 @@ def setupMenu():
         ['mb_sp2200_trk140_hmt_L1TE50', 'L1_TE50', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['mb_sp2400_trk150_hmt_L1TE50', 'L1_TE50', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
-        ['mb_sp1700_trk110_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp1900_trk120_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2100_trk130_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2200_trk140_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2400_trk150_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1700_trk110_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1900_trk120_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2100_trk130_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2200_trk140_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2400_trk150_hmt_L1TE60', 'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
-        ['mb_sp1900_trk120_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2100_trk130_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2200_trk140_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['mb_sp2400_trk150_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp1900_trk120_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2100_trk130_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2200_trk140_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['mb_sp2400_trk150_hmt_L1TE70', 'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
         #HMT with pileup supprestion seeded by L1_TE.0ETA24 triggers
         #['mb_sp900_pusup400_trk50_hmt_L1TE5.0ETA24', 'L1_TE5.0ETA24', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3560,6 +3748,36 @@ def setupMenu():
         #['mb_sp2700_pusup1200_trk150_hmt_L1TE40.0ETA24', 'L1_TE40.0ETA24', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         #['mb_sp2900_pusup1300_trk160_hmt_L1TE40.0ETA24', 'L1_TE40.0ETA24', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
+        ## HMTfor 5TeV run ATR-17162
+        ['mb_sp700_trk50_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp900_trk60_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1100_trk70_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_trk80_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1400_trk90_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1600_trk100_hmt_L1TE15', 'L1_TE15', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1700_trk110_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_trk120_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1100_trk70_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_trk80_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1400_trk90_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1600_trk100_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1700_trk110_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_trk120_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+
+        ['mb_sp700_pusup350_trk50_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp900_pusup400_trk60_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1100_pusup450_trk70_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_pusup500_trk80_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1400_pusup550_trk90_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1600_pusup600_trk100_hmt_L1TE15', 'L1_TE15', [], ['MinBias','express'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1700_pusup650_trk110_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_pusup700_trk120_hmt_L1TE15', 'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1100_pusup450_trk70_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1200_pusup500_trk80_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1400_pusup550_trk90_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1600_pusup600_trk100_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1700_pusup650_trk110_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['mb_sp1900_pusup700_trk120_hmt_L1TE25', 'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
         #HMT without pileup supprestion seeded by L1_TE.0ETA24 triggers
         #['mb_sp900_trk50_hmt_L1TE5.0ETA24', 'L1_TE5.0ETA24', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
@@ -3746,7 +3964,12 @@ def setupMenu():
 
         #ALFA Calib
         ['alfacalib',      'L1_ALFA_Calib'    , [],  ['ALFACalib'], [ 'RATE:ALFACalibration','BW:Detector'], -1],        
-
+        ['alfacalib_L1ALFA_ELAS',   'L1_ALFA_ELAS'      , [], ['ALFACalib'], [ 'RATE:ALFACalibration','BW:Detector'], -1],        
+        ['alfacalib_L1ALFA_SYS',   'L1_ALFA_SYS'     , [], ['MinBias'], ["RATE:MinBias", "RATE:ALFA", "BW:Other"], -1], 
+        ['alfacalib_L1ALFA_SYS_Calib',   'L1_ALFA_SYS_Calib'      , [], ['ALFACalib'], [ 'RATE:ALFACalibration','BW:Detector'], -1],        
+        ['noalg_L1ALFA_Phys',    'L1_ALFA_Phys',    [], ['MinBias'], ["RATE:MinBias", "RATE:ALFA", "BW:Other"], -1], 
+        ['noalg_L1ALFA_PhysAny', 'L1_ALFA_PhysAny', [], ['MinBias'], ["RATE:MinBias", "RATE:ALFA", "BW:Other"], -1], 
+        ['noalg_L1ALFA_ANY',     'L1_ALFA_ANY'     , [], ['ALFACalib'], [ 'RATE:ALFACalibration','BW:Detector'], -1],        
         #
         ['ibllumi_L1RD0_ABORTGAPNOTCALIB',    'L1_RD0_ABORTGAPNOTCALIB', [], ['IBLLumi'], [ 'RATE:IBLLumi','BW:Detector'], -1],
         ['ibllumi_L1RD0_FILLED',    'L1_RD0_FILLED', [], ['IBLLumi'], [ 'RATE:IBLLumi','BW:Detector'], -1],
@@ -3856,7 +4079,7 @@ def setupMenu():
 # Egamma streamers
         ['noalg_L1EM15',           'L1_EM15',           [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
         ['noalg_L1EM12',           'L1_EM12',           [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
-        ['noalg_L12EM7',           'L1_2EM7',           [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
+        ['noalg_L12EM7',           'L1_2EM7',           [], [PhysicsStream,'express'], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
         ['noalg_L12EM15',          'L1_2EM15',          [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
         ['noalg_L1EM15VH_3EM7',    'L1_EM15VH_3EM7',    [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
         ['noalg_L1EM7',            'L1_EM7',            [], [PhysicsStream], ['RATE:SeededStreamers', 'BW:Egamma'], -1],
@@ -3895,8 +4118,10 @@ def setupMenu():
         ['noalg_mb_L1TE30',  'L1_TE30', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1], 
         ['noalg_mb_L1TE40',  'L1_TE40', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         ['noalg_mb_L1TE50',  'L1_TE50', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['noalg_mb_L1TE60',  'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
-        ['noalg_mb_L1TE70',  'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['noalg_mb_L1TE60',  'L1_TE60', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        #['noalg_mb_L1TE70',  'L1_TE70', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['noalg_mb_L1TE15',  'L1_TE15', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
+        ['noalg_mb_L1TE25',  'L1_TE25', [], ['MinBias'], ["BW:MinBias", "RATE:MinBias"], -1],
         
         #data min-bias overlay
 #	    ['noalg_L1TE20_OVERLAY',   'L1_TE20_OVERLAY', [], ['MinBiasOverlay'], ["BW:MinBiasOverlay", "RATE:MinBiasOverlay"], 1],
@@ -4256,7 +4481,7 @@ def setupMenu():
         ['noalg_L1J30',  'L1_J30',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
         ['noalg_L1J30.31ETA49',  'L1_J30.31ETA49',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
         ['noalg_L1J40',  'L1_J40',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
-        ['noalg_L1J400',  'L1_J400',   [], [PhysicsStream, 'express'], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
+        ['noalg_L1J400',  'L1_J400',   [], [PhysicsStream, 'express'], ["Primary:20000","RATE:SeededStreamers", "BW:Jet"], -1 ],
         ['noalg_L1J50.31ETA49',  'L1_J50.31ETA49',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
         ['noalg_L1J75',  'L1_J75',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ],
         ['noalg_L1J75.31ETA49',  'L1_J75.31ETA49',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:Jet"], -1 ], 
@@ -4280,8 +4505,10 @@ def setupMenu():
         ['noalg_L1XE45',  'L1_XE45',   [], [PhysicsStream, 'express'], ["RATE:SeededStreamers", "BW:MET"], -1 ],
         ['noalg_L1XE40',  'L1_XE40',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
 	
-        ['noalg_L1TE70',  'L1_TE70',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
-        ['noalg_L1TE60',  'L1_TE60',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
+        ['noalg_L1TE15',  'L1_TE15',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
+        ['noalg_L1TE25',  'L1_TE25',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
+        #['noalg_L1TE70',  'L1_TE70',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
+        #['noalg_L1TE60',  'L1_TE60',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
         ['noalg_L1TE50',  'L1_TE50',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ],
         ['noalg_L1TE40',  'L1_TE40',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ], 
         ['noalg_L1TE30',  'L1_TE30',   [], [PhysicsStream], ["RATE:SeededStreamers", "BW:MET"], -1 ], 
@@ -5036,15 +5263,15 @@ chain_list=[
     'mb_sp2100_pusup750_trk130_hmt_L1TE50',
     'mb_sp2200_pusup800_trk140_hmt_L1TE50',
     'mb_sp2400_pusup850_trk150_hmt_L1TE50',
-    'mb_sp1700_pusup650_trk110_hmt_L1TE60',
-    'mb_sp1900_pusup700_trk120_hmt_L1TE60',
-    'mb_sp2100_pusup750_trk130_hmt_L1TE60',
-    'mb_sp2200_pusup800_trk140_hmt_L1TE60',
-    'mb_sp2400_pusup850_trk150_hmt_L1TE60',
-    'mb_sp1900_pusup700_trk120_hmt_L1TE70',
-    'mb_sp2100_pusup750_trk130_hmt_L1TE70',
-    'mb_sp2200_pusup800_trk140_hmt_L1TE70',
-    'mb_sp2400_pusup850_trk150_hmt_L1TE70',
+    #'mb_sp1700_pusup650_trk110_hmt_L1TE60',
+    #'mb_sp1900_pusup700_trk120_hmt_L1TE60',
+    #'mb_sp2100_pusup750_trk130_hmt_L1TE60',
+    #'mb_sp2200_pusup800_trk140_hmt_L1TE60',
+    #'mb_sp2400_pusup850_trk150_hmt_L1TE60',
+    #'mb_sp1900_pusup700_trk120_hmt_L1TE70',
+    #'mb_sp2100_pusup750_trk130_hmt_L1TE70',
+    #'mb_sp2200_pusup800_trk140_hmt_L1TE70',
+    #'mb_sp2400_pusup850_trk150_hmt_L1TE70',
     'mb_sp600_trk40_hmt_L1TE5',
     'mb_sp700_trk50_hmt_L1TE5',
     'mb_sp900_trk50_hmt_L1TE5',
@@ -5121,15 +5348,43 @@ chain_list=[
     'mb_sp2100_trk130_hmt_L1TE50',
     'mb_sp2200_trk140_hmt_L1TE50',
     'mb_sp2400_trk150_hmt_L1TE50',
-    'mb_sp1700_trk110_hmt_L1TE60',
-    'mb_sp1900_trk120_hmt_L1TE60',
-    'mb_sp2100_trk130_hmt_L1TE60',
-    'mb_sp2200_trk140_hmt_L1TE60',
-    'mb_sp2400_trk150_hmt_L1TE60',
-    'mb_sp1900_trk120_hmt_L1TE70',
-    'mb_sp2100_trk130_hmt_L1TE70',
-    'mb_sp2200_trk140_hmt_L1TE70',
-    'mb_sp2400_trk150_hmt_L1TE70',
+    #'mb_sp1700_trk110_hmt_L1TE60',
+    #'mb_sp1900_trk120_hmt_L1TE60',
+    #'mb_sp2100_trk130_hmt_L1TE60',
+    #'mb_sp2200_trk140_hmt_L1TE60',
+    #'mb_sp2400_trk150_hmt_L1TE60',
+    #'mb_sp1900_trk120_hmt_L1TE70',
+    #'mb_sp2100_trk130_hmt_L1TE70',
+    #'mb_sp2200_trk140_hmt_L1TE70',
+    #'mb_sp2400_trk150_hmt_L1TE70',
+    'mb_sp700_trk50_hmt_L1TE15',
+    'mb_sp900_trk60_hmt_L1TE15',
+    'mb_sp1100_trk70_hmt_L1TE15',
+    'mb_sp1200_trk80_hmt_L1TE15',
+    'mb_sp1400_trk90_hmt_L1TE15',
+    'mb_sp1600_trk100_hmt_L1TE15',
+    'mb_sp1700_trk110_hmt_L1TE15',
+    'mb_sp1900_trk120_hmt_L1TE15',
+    'mb_sp1100_trk70_hmt_L1TE25',
+    'mb_sp1200_trk80_hmt_L1TE25',
+    'mb_sp1400_trk90_hmt_L1TE25',
+    'mb_sp1600_trk100_hmt_L1TE25',
+    'mb_sp1700_trk110_hmt_L1TE25',
+    'mb_sp1900_trk120_hmt_L1TE25',
+    'mb_sp700_pusup350_trk50_hmt_L1TE15',
+    'mb_sp900_pusup400_trk60_hmt_L1TE15',
+    'mb_sp1100_pusup450_trk70_hmt_L1TE15',
+    'mb_sp1200_pusup500_trk80_hmt_L1TE15',
+    'mb_sp1400_pusup550_trk90_hmt_L1TE15',
+    'mb_sp1600_pusup600_trk100_hmt_L1TE15',
+    'mb_sp1700_pusup650_trk110_hmt_L1TE15',
+    'mb_sp1900_pusup700_trk120_hmt_L1TE15',
+    'mb_sp1100_pusup450_trk70_hmt_L1TE25',
+    'mb_sp1200_pusup500_trk80_hmt_L1TE25',
+    'mb_sp1400_pusup550_trk90_hmt_L1TE25',
+    'mb_sp1600_pusup600_trk100_hmt_L1TE25',
+    'mb_sp1700_pusup650_trk110_hmt_L1TE25',
+    'mb_sp1900_pusup700_trk120_hmt_L1TE25',
     #'mb_sp900_pusup400_trk50_hmt_L1TE5.0ETA24',
     #'mb_sp900_pusup400_trk60_hmt_L1TE5.0ETA24',
     #'mb_sp1000_pusup450_trk70_hmt_L1TE5.0ETA24',
@@ -5185,6 +5440,26 @@ chain_list=[
     'mu4_mb_sp1200_trk80_hmt_L1MU4_TE10',
     'mu4_mb_sp1400_trk90_hmt_L1MU4_TE10',
     'mu4_mb_sp1600_trk100_hmt_L1MU4_TE10',
+    'mu4_mb_sp1100_trk70_hmt_L1MU4_TE20',
+    'mu4_mb_sp1200_trk80_hmt_L1MU4_TE20',
+    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE20',
+    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE20',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE20',
+    'mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE20',
+    'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE20',
+    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE20',
+    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE20',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE20',
+    'mu4_mb_sp1100_trk70_hmt_L1MU4_TE30',
+    'mu4_mb_sp1200_trk80_hmt_L1MU4_TE30',
+    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE30',
+    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE30',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE30',
+    'mu4_mb_sp1100_pusup450_trk70_hmt_L1MU4_TE30',
+    'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE30',
+    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE30',
+    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE30',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE30',
     'mu4_mb_sp600_pusup300_trk40_hmt_L1MU4_TE10',
     'mu4_mb_sp700_pusup350_trk50_hmt_L1MU4_TE10',
     'mu4_mb_sp900_pusup400_trk60_hmt_L1MU4_TE10',
@@ -5195,15 +5470,17 @@ chain_list=[
     'mu4_mb_sp1200_trk80_hmt_L1MU4_TE40',
     'mu4_mb_sp1400_trk90_hmt_L1MU4_TE40',
     'mu4_mb_sp1600_trk100_hmt_L1MU4_TE40',
-    'mu4_mb_sp1400_trk90_hmt_L1MU4_TE50',
-    'mu4_mb_sp1600_trk100_hmt_L1MU4_TE50',
-    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE50',
-    'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50',
-    'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50',
-    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50',
+    'mu4_mb_sp1700_trk110_hmt_L1MU4_TE40',
+    #'mu4_mb_sp1400_trk90_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1600_trk100_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1700_trk110_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE50',
+    #'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE50',
     'mu4_mb_sp1200_pusup500_trk80_hmt_L1MU4_TE40',
     'mu4_mb_sp1400_pusup550_trk90_hmt_L1MU4_TE40',
     'mu4_mb_sp1600_pusup600_trk100_hmt_L1MU4_TE40',
+    'mu4_mb_sp1700_pusup650_trk110_hmt_L1MU4_TE40',
     'j40_mb_sp600_pusup300_trk40_hmt',
     'j40_mb_sp700_pusup350_trk50_hmt',
     'j40_mb_sp900_pusup400_trk60_hmt',
@@ -5218,20 +5495,20 @@ chain_list=[
     'j40_mb_sp1200_trk80_hmt',
     'j40_mb_sp1400_trk90_hmt',
     'j40_mb_sp1600_trk100_hmt',
-    'j45_mb_sp600_pusup300_trk40_hmt',
-    'j45_mb_sp700_pusup350_trk50_hmt',
-    'j45_mb_sp900_pusup400_trk60_hmt',
-    'j45_mb_sp1100_pusup450_trk70_hmt',
-    'j45_mb_sp1200_pusup500_trk80_hmt',
-    'j45_mb_sp1400_pusup550_trk90_hmt',
-    'j45_mb_sp1600_pusup600_trk100_hmt',
-    'j45_mb_sp600_trk40_hmt',
-    'j45_mb_sp700_trk50_hmt',
-    'j45_mb_sp900_trk60_hmt',
-    'j45_mb_sp1100_trk70_hmt',
-    'j45_mb_sp1200_trk80_hmt',
-    'j45_mb_sp1400_trk90_hmt',
-    'j45_mb_sp1600_trk100_hmt',
+    'j50_mb_sp600_pusup300_trk40_hmt',
+    'j50_mb_sp700_pusup350_trk50_hmt',
+    'j50_mb_sp900_pusup400_trk60_hmt',
+    'j50_mb_sp1100_pusup450_trk70_hmt',
+    'j50_mb_sp1200_pusup500_trk80_hmt',
+    'j50_mb_sp1400_pusup550_trk90_hmt',
+    'j50_mb_sp1600_pusup600_trk100_hmt',
+    'j50_mb_sp600_trk40_hmt',
+    'j50_mb_sp700_trk50_hmt',
+    'j50_mb_sp900_trk60_hmt',
+    'j50_mb_sp1100_trk70_hmt',
+    'j50_mb_sp1200_trk80_hmt',
+    'j50_mb_sp1400_trk90_hmt',
+    'j50_mb_sp1600_trk100_hmt',
     'j60_mb_sp600_pusup300_trk40_hmt',
     'j60_mb_sp700_pusup350_trk50_hmt',
     'j60_mb_sp900_pusup400_trk60_hmt',
@@ -5260,6 +5537,34 @@ chain_list=[
     'j110_mb_sp1200_trk80_hmt',
     'j110_mb_sp1400_trk90_hmt',
     'j110_mb_sp1600_trk100_hmt',
+    'j75_mb_sp600_pusup300_trk40_hmt',
+    'j75_mb_sp700_pusup350_trk50_hmt',
+    'j75_mb_sp900_pusup400_trk60_hmt',
+    'j75_mb_sp1100_pusup450_trk70_hmt',
+    'j75_mb_sp1200_pusup500_trk80_hmt',
+    'j75_mb_sp1400_pusup550_trk90_hmt',
+    'j75_mb_sp1600_pusup600_trk100_hmt',
+    'j75_mb_sp600_trk40_hmt',
+    'j75_mb_sp700_trk50_hmt',
+    'j75_mb_sp900_trk60_hmt',
+    'j75_mb_sp1100_trk70_hmt',
+    'j75_mb_sp1200_trk80_hmt',
+    'j75_mb_sp1400_trk90_hmt',
+    'j75_mb_sp1600_trk100_hmt',
+    'j85_mb_sp600_pusup300_trk40_hmt',
+    'j85_mb_sp700_pusup350_trk50_hmt',
+    'j85_mb_sp900_pusup400_trk60_hmt',
+    'j85_mb_sp1100_pusup450_trk70_hmt',
+    'j85_mb_sp1200_pusup500_trk80_hmt',
+    'j85_mb_sp1400_pusup550_trk90_hmt',
+    'j85_mb_sp1600_pusup600_trk100_hmt',
+    'j85_mb_sp600_trk40_hmt',
+    'j85_mb_sp700_trk50_hmt',
+    'j85_mb_sp900_trk60_hmt',
+    'j85_mb_sp1100_trk70_hmt',
+    'j85_mb_sp1200_trk80_hmt',
+    'j85_mb_sp1400_trk90_hmt',
+    'j85_mb_sp1600_trk100_hmt',
     'mb_sp400_trk40_hmt_L1MBTS_1_1',
     'mb_sp600_trk45_hmt_L1MBTS_1_1',
     'mb_sp700_trk55_hmt_L1MBTS_1_1',
@@ -5418,8 +5723,10 @@ chain_list=[
     'noalg_mb_L1TE40',
     #'noalg_mb_L1TE40.0ETA24',
     'noalg_mb_L1TE50',
-    'noalg_mb_L1TE60',
-    'noalg_mb_L1TE70',
+    #'noalg_mb_L1TE60',
+    #'noalg_mb_L1TE70',
+    'noalg_mb_L1TE15',
+    'noalg_mb_L1TE25',
     #'noalg_mb_L1TE70.0ETA24',
     'noalg_mb_L1ZDC_A',
     'noalg_mb_L1ZDC_C',
diff --git a/Trigger/TriggerCommon/TriggerMenu/python/menu/SignatureDicts.py b/Trigger/TriggerCommon/TriggerMenu/python/menu/SignatureDicts.py
index 3ead33bc12252e62671f6a5cd261ce36b6064a3e..c86b8c04b7204ba90c39e848e79983cc7f97e0a1 100644
--- a/Trigger/TriggerCommon/TriggerMenu/python/menu/SignatureDicts.py
+++ b/Trigger/TriggerCommon/TriggerMenu/python/menu/SignatureDicts.py
@@ -106,7 +106,7 @@ JetChainParts = {
     'chainPartName': '',
     'threshold'    : '',
     'multiplicity' : '',
-    'etaRange'     : ['0eta490','0eta320','0eta240', '240eta490',
+    'etaRange'     : ['0eta490','0eta320','0eta240', '240eta490', '200eta320',
                       '280eta320', '320eta490', 'n320eta490', 'p320eta490'],
     'gscThreshold' : ['gsc'],
     'trigType'     : ['j'],
diff --git a/Trigger/TriggerCommon/TriggerMenu/scripts/generateUnprescaledLists.py b/Trigger/TriggerCommon/TriggerMenu/scripts/generateUnprescaledLists.py
new file mode 100755
index 0000000000000000000000000000000000000000..c55787993d9b1cd9b60bccc4412d7f8bc3e87e76
--- /dev/null
+++ b/Trigger/TriggerCommon/TriggerMenu/scripts/generateUnprescaledLists.py
@@ -0,0 +1,35 @@
+#!/usr/bin/env python
+# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration
+__author__  = 'Javier Montejo'
+__version__="$Revision: 1.00 $"
+__doc__="Script generating lists of future unprescaled triggers when the package is built"
+
+from TriggerMenu.api.TriggerAPI import TriggerAPI
+from TriggerMenu.api.TriggerEnums import TriggerPeriod, TriggerType
+
+def main(outfolder):
+    with open(outfolder+"/list_unprescaled1p8e34.py","w") as outfile:
+        outfile.write(header())
+        for triggerType in TriggerType:
+            outfile.write( to_nice_list( TriggerAPI.getUnprescaled(TriggerPeriod.future1p8e34, triggerType), triggerType.name) )
+
+    with open(outfolder+"/list_unprescaled2e34.py","w") as outfile:
+        outfile.write(header())
+        for triggerType in TriggerType:
+            outfile.write( to_nice_list( TriggerAPI.getUnprescaled(TriggerPeriod.future2e34, triggerType), triggerType.name ) )
+
+def to_nice_list( alist, name ):
+    thestr = "list_%s = [\n"%name
+    for i in alist:
+        thestr += "\t'%s',\n"%i
+    thestr += "]\n\n"
+    return thestr
+
+def header():
+    thestr  = '# Copyright (C) 2002-2017 CERN for the benefit of the ATLAS collaboration\n'
+    thestr += '# File was auto-generated with generateUnprescaledLists.py\n\n'
+    return thestr
+
+if __name__ == "__main__":
+    import sys
+    sys.exit( main(sys.argv[1]) )
diff --git a/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_MC_pp_v7.xml b/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_MC_pp_v7.xml
index 7ffb5c558f22ad8293a0ec7d484940766c93fb04..15e3473a2184a7cea0a3356c080d4759664a6e4e 100644
--- a/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_MC_pp_v7.xml
+++ b/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_MC_pp_v7.xml
@@ -3,7 +3,7 @@
 <LVL1Config name="MC_pp_v7" ctpVersion="4" l1Version="1">
   <!--File is generated by TriggerMenu-->
   <!--No. L1 thresholds defined: 287-->
-  <!--No. L1 items defined: 467-->
+  <!--No. L1 items defined: 501-->
   <TriggerMenu name="MC_pp_v7" phase="lumi">
     <TriggerItem ctpid="0" partition="1" name="L1_EM3" complex_deadtime="0" definition="(EM3[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
@@ -354,6 +354,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="48" partition="1" name="L1_ALFA_ELAST1" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;!(ALFA3_B7L1L[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="49" partition="1" name="L1_TAU20" complex_deadtime="0" definition="(HA20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:111|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HA20_x1" triggerthreshold="HA20"/>
@@ -531,6 +549,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="71" partition="1" name="L1_ALFA_ELAST2" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;!(ALFA3_B7L1U[x1]|ALFA3_A7L1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="72" partition="1" name="L1_DR-MU10TAU12I_TAU12I-J25" complex_deadtime="0" definition="(0DR28-MU10ab-TAU12abi[x1]&amp;1DISAMB-TAU12abi-J25ab[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="0DR28-MU10ab-TAU12abi_x1" triggerthreshold="0DR28-MU10ab-TAU12abi"/>
@@ -571,6 +607,16 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="77" partition="1" name="L1_ALFA_ELAST11" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="78" partition="1" name="L1_EM15VHI_2TAU12IM_XE35" complex_deadtime="0" definition="(EM15VHI[x1]&amp;HA12IM[x2]&amp;XE35[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM15VHI_x1" triggerthreshold="EM15VHI"/>
@@ -580,6 +626,28 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="79" partition="1" name="L1_ALFA_ELAST12" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="80" partition="1" name="L1_ALFA_ELAST13" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="81" partition="1" name="L1_MU10_TAU12IM_XE35" complex_deadtime="0" definition="(MU10[x1]&amp;HA12IM[x1]&amp;XE35[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU10_x1" triggerthreshold="MU10"/>
@@ -605,6 +673,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="84" partition="1" name="L1_ALFA_ELAST14" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="85" partition="1" name="L1_XE30" complex_deadtime="0" definition="(XE30[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="XE30_x1" triggerthreshold="XE30"/>
@@ -619,6 +699,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="87" partition="1" name="L1_ALFA_ELAST15" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="88" partition="1" name="L1_MU6_J20" complex_deadtime="0" definition="(MU6[x1]&amp;J20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU6_x1" triggerthreshold="MU6"/>
@@ -875,10 +969,10 @@
         <InternalTrigger name="BGRP8"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="124" partition="1" name="L1_MU4_TE50" complex_deadtime="0" definition="(MU4[x1]&amp;TE50[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="124" partition="1" name="L1_MU4_TE30" complex_deadtime="0" definition="(MU4[x1]&amp;TE30[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU4_x1" triggerthreshold="MU4"/>
-        <TriggerCondition multi="1" name="TE50_x1" triggerthreshold="TE50"/>
+        <TriggerCondition multi="1" name="TE30_x1" triggerthreshold="TE30"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -898,6 +992,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="127" partition="1" name="L1_ALFA_ELAST15_Calib" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="128" partition="1" name="L1_3J40" complex_deadtime="0" definition="(J40[x3]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J40_x3" triggerthreshold="J40"/>
@@ -905,6 +1013,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="129" partition="1" name="L1_ALFA_ELAST16" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="130" partition="1" name="L1_3J50" complex_deadtime="0" definition="(J50[x3]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J50_x3" triggerthreshold="J50"/>
@@ -926,6 +1046,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="133" partition="1" name="L1_ALFA_ELAST17" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="134" partition="1" name="L1_MBTSA0" complex_deadtime="0" definition="(MBTS_A0[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_A0_x1" triggerthreshold="MBTS_A0"/>
@@ -1060,9 +1192,9 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="152" partition="1" name="L1_TE70" complex_deadtime="0" definition="(TE70[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="152" partition="1" name="L1_TE25" complex_deadtime="0" definition="(TE25[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="TE70_x1" triggerthreshold="TE70"/>
+        <TriggerCondition multi="1" name="TE25_x1" triggerthreshold="TE25"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -1118,9 +1250,9 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="160" partition="1" name="L1_TE60" complex_deadtime="0" definition="(TE60[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="160" partition="1" name="L1_TE15" complex_deadtime="0" definition="(TE15[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="TE60_x1" triggerthreshold="TE60"/>
+        <TriggerCondition multi="1" name="TE15_x1" triggerthreshold="TE15"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -1932,6 +2064,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="257" partition="1" name="L1_ALFA_ELAST18" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="258" partition="1" name="L1_HT190-J15.ETA21" complex_deadtime="0" definition="(HT190-AJ15all.ETA21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HT190-AJ15all.ETA21_x1" triggerthreshold="HT190-AJ15all.ETA21"/>
@@ -2056,6 +2202,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="275" partition="1" name="L1_ALFA_ELAST18_Calib" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="276" partition="1" name="L1_AFP_A_OR_C" complex_deadtime="0" definition="(((AFP_NSA[x1]&amp;AFP_FSA_SIT[x1])|(AFP_NSC[x1]&amp;AFP_FSC_SIT[x1]))&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <OR>
@@ -2130,6 +2290,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="285" partition="1" name="L1_ALFA_SHOWSYST5" complex_deadtime="0" definition="((ALFA_B7L1U[x1]|ALFA_B7L1L[x1]|ALFA_A7L1U[x1]|ALFA_A7L1L[x1])&amp;(ALFA_A7R1U[x1]|ALFA_A7R1L[x1]|ALFA_B7R1U[x1]|ALFA_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="286" partition="1" name="L1_EM15_W-MT35" complex_deadtime="0" definition="(35MT-EM15s6-XE0[x1]&amp;EM15[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="35MT-EM15s6-XE0_x1" triggerthreshold="35MT-EM15s6-XE0"/>
@@ -2145,6 +2323,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="288" partition="1" name="L1_ALFA_SYST9" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;!(ALFA3_B7L1L[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="289" partition="1" name="L1_MBTSA14" complex_deadtime="0" definition="(MBTS_A14[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_A14_x1" triggerthreshold="MBTS_A14"/>
@@ -2152,6 +2348,44 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="290" partition="1" name="L1_ALFA_SYST10" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;!(ALFA3_B7L1U[x1]|ALFA3_A7L1U[x1]|ALFA3_A7R1U[x1]|ALFA3_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="291" partition="1" name="L1_ALFA_SYST11" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="292" partition="1" name="L1_ALFA_SYST12" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="293" partition="1" name="L1_EM12_W-MT25_W-15DPHI-JXE-0_W-15DPHI-EMXE_W-90RO2-XEHT-0" complex_deadtime="0" definition="(25MT-EM12s6-XE0[x1]&amp;EM12[x1]&amp;15MINDPHI-AJj10s6-XE0[x1]&amp;15MINDPHI-EM12s6-XE0[x1]&amp;90RATIO2-XE0-HT0-AJj15all.ETA49[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="25MT-EM12s6-XE0_x1" triggerthreshold="25MT-EM12s6-XE0"/>
@@ -2344,6 +2578,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="316" partition="1" name="L1_ALFA_SYST17" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="317" partition="1" name="L1_AFP_A_OR_C_MBTS_2" complex_deadtime="0" definition="(((AFP_NSA[x1]&amp;AFP_FSA_SIT[x1])|(AFP_NSC[x1]&amp;AFP_FSC_SIT[x1]))&amp;(MBTS_A[x2]|MBTS_C[x2]|MBTS_A[x1])&amp;(MBTS_A[x2]|MBTS_C[x2]|MBTS_C[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <OR>
@@ -2431,6 +2679,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="326" partition="1" name="L1_ALFA_SYST18" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="327" partition="1" name="L1_MJJ-800" complex_deadtime="0" definition="(800INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="800INVM9999-AJ30s6-AJ20s6_x1" triggerthreshold="800INVM9999-AJ30s6-AJ20s6"/>
@@ -2438,6 +2700,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="328" partition="1" name="L1_ALFA_ANY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="329" partition="1" name="L1_MJJ-400" complex_deadtime="0" definition="(400INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="400INVM9999-AJ30s6-AJ20s6_x1" triggerthreshold="400INVM9999-AJ30s6-AJ20s6"/>
@@ -2445,6 +2723,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="330" partition="1" name="L1_ALFA_ANY_EMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="331" partition="1" name="L1_MBTSC7" complex_deadtime="0" definition="(MBTS_C7[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_C7_x1" triggerthreshold="MBTS_C7"/>
@@ -2576,6 +2870,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="349" partition="1" name="L1_ALFA_ANY_FIRSTEMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP6)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP6"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="350" partition="1" name="L1_DR-TAU20ITAU12I-J25" complex_deadtime="0" definition="(1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:111|HF:000">
       <AND>
         <TriggerCondition multi="1" name="1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi_x1" triggerthreshold="1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi"/>
@@ -2663,6 +2973,45 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="362" partition="1" name="L1_ALFA_ANY_UNPAIRED_ISO" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP4)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP4"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="363" partition="1" name="L1_ALFA_ANY_UNPAIRED_NONISO" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP5)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP5"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="364" partition="1" name="L1_MU21_FTK" complex_deadtime="0" definition="(MU21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="MU21_x1" triggerthreshold="MU21"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="366" partition="1" name="L1_3J20_4J20.0ETA49_MJJ-400" complex_deadtime="0" definition="(J20[x3]&amp;J20.0ETA49[x4]&amp;400INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J20_x3" triggerthreshold="J20"/>
@@ -2699,6 +3048,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="370" partition="1" name="L1_ALFA_ANY_BGRP10" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="371" partition="1" name="L1_EM7_FIRSTEMPTY" complex_deadtime="0" definition="(EM7[x1]&amp;BGRP0&amp;BGRP6)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM7_x1" triggerthreshold="EM7"/>
@@ -2720,6 +3085,50 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="374" partition="1" name="L1_ALFA_ANY_ABORTGAPNOTCALIB" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP8)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP8"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="375" partition="1" name="L1_ALFA_ANY_CALIB" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP2)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP2"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="376" partition="1" name="L1_ALFA_B1_EMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="377" partition="1" name="L1_MU10_TAU20IM_J25_2J20" complex_deadtime="0" definition="(MU10[x1]&amp;HA20IM[x1]&amp;J25[x1]&amp;J20[x2]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU10_x1" triggerthreshold="MU10"/>
@@ -2864,6 +3273,20 @@
         <InternalTrigger name="BGRP3"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="395" partition="1" name="L1_ALFA_BGT_BGRP1" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <InternalTrigger name="RNDM3"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="396" partition="1" name="L1_ALFA_BGT_BGRP4" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP4)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <InternalTrigger name="RNDM3"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP4"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="397" partition="1" name="L1_MJJ-400-CF" complex_deadtime="0" definition="(400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49_x1" triggerthreshold="400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49"/>
@@ -2941,6 +3364,18 @@
         <InternalTrigger name="BGRP6"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="407" partition="1" name="L1_ALFA_B2_EMPTY" complex_deadtime="0" definition="((ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="408" partition="1" name="L1_TAU20IM_2TAU12IM_4J12" complex_deadtime="0" definition="(HA20IM[x1]&amp;HA12IM[x2]&amp;J12[x4]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HA20IM_x1" triggerthreshold="HA20IM"/>
@@ -2950,6 +3385,21 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="409" partition="1" name="L1_2EM12" complex_deadtime="0" definition="(EM12[x2]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="2" name="EM12_x2" triggerthreshold="EM12"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="410" partition="1" name="L1_MU4_TE20" complex_deadtime="0" definition="(MU4[x1]&amp;TE20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="MU4_x1" triggerthreshold="MU4"/>
+        <TriggerCondition multi="1" name="TE20_x1" triggerthreshold="TE20"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="411" partition="1" name="L1_EM20VH_FIRSTEMPTY" complex_deadtime="0" definition="(EM20VH[x1]&amp;BGRP0&amp;BGRP6)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM20VH_x1" triggerthreshold="EM20VH"/>
@@ -3446,11 +3896,11 @@
         <InternalTrigger name="BGRP10"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="474" partition="1" name="L1_2EM3_VTE70" complex_deadtime="0" definition="(EM3[x2]&amp;!TE70[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="474" partition="1" name="L1_2EM3_VTE50" complex_deadtime="0" definition="(EM3[x2]&amp;!TE50[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="2" name="EM3_x2" triggerthreshold="EM3"/>
         <NOT>
-          <TriggerCondition multi="1" name="TE70_x1" triggerthreshold="TE70"/>
+          <TriggerCondition multi="1" name="TE50_x1" triggerthreshold="TE50"/>
         </NOT>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
@@ -3605,11 +4055,11 @@
         <InternalTrigger name="BGRP0"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="497" partition="1" name="L1_MU21_FTK" complex_deadtime="0" definition="(MU21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="497" partition="1" name="L1_ALFA_BGT_BGRP10" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="MU21_x1" triggerthreshold="MU21"/>
+        <InternalTrigger name="RNDM3"/>
         <InternalTrigger name="BGRP0"/>
-        <InternalTrigger name="BGRP1"/>
+        <InternalTrigger name="BGRP10"/>
       </AND>
     </TriggerItem>
     <TriggerItem ctpid="498" partition="1" name="L1_MU20_TAU12IM_FTK" complex_deadtime="0" definition="(MU20[x1]&amp;HA12IM[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
@@ -3751,7 +4201,7 @@
     <Prescale ctpid="45" cut="000001" value="1"/>
     <Prescale ctpid="46" cut="000001" value="1"/>
     <Prescale ctpid="47" cut="000001" value="1"/>
-    <Prescale ctpid="48" cut="-000001" value="-1"/>
+    <Prescale ctpid="48" cut="000001" value="1"/>
     <Prescale ctpid="49" cut="000001" value="1"/>
     <Prescale ctpid="50" cut="000001" value="1"/>
     <Prescale ctpid="51" cut="000001" value="1"/>
@@ -3774,23 +4224,23 @@
     <Prescale ctpid="68" cut="000001" value="1"/>
     <Prescale ctpid="69" cut="000001" value="1"/>
     <Prescale ctpid="70" cut="000001" value="1"/>
-    <Prescale ctpid="71" cut="-000001" value="-1"/>
+    <Prescale ctpid="71" cut="000001" value="1"/>
     <Prescale ctpid="72" cut="000001" value="1"/>
     <Prescale ctpid="73" cut="000001" value="1"/>
     <Prescale ctpid="74" cut="000001" value="1"/>
     <Prescale ctpid="75" cut="000001" value="1"/>
     <Prescale ctpid="76" cut="000001" value="1"/>
-    <Prescale ctpid="77" cut="-000001" value="-1"/>
+    <Prescale ctpid="77" cut="000001" value="1"/>
     <Prescale ctpid="78" cut="000001" value="1"/>
-    <Prescale ctpid="79" cut="-000001" value="-1"/>
-    <Prescale ctpid="80" cut="-000001" value="-1"/>
+    <Prescale ctpid="79" cut="000001" value="1"/>
+    <Prescale ctpid="80" cut="000001" value="1"/>
     <Prescale ctpid="81" cut="000001" value="1"/>
     <Prescale ctpid="82" cut="000001" value="1"/>
     <Prescale ctpid="83" cut="000001" value="1"/>
-    <Prescale ctpid="84" cut="-000001" value="-1"/>
+    <Prescale ctpid="84" cut="000001" value="1"/>
     <Prescale ctpid="85" cut="000001" value="1"/>
     <Prescale ctpid="86" cut="000001" value="1"/>
-    <Prescale ctpid="87" cut="-000001" value="-1"/>
+    <Prescale ctpid="87" cut="000001" value="1"/>
     <Prescale ctpid="88" cut="000001" value="1"/>
     <Prescale ctpid="89" cut="000001" value="1"/>
     <Prescale ctpid="90" cut="000001" value="1"/>
@@ -3830,13 +4280,13 @@
     <Prescale ctpid="124" cut="000001" value="1"/>
     <Prescale ctpid="125" cut="000001" value="1"/>
     <Prescale ctpid="126" cut="000001" value="1"/>
-    <Prescale ctpid="127" cut="-000001" value="-1"/>
+    <Prescale ctpid="127" cut="000001" value="1"/>
     <Prescale ctpid="128" cut="000001" value="1"/>
-    <Prescale ctpid="129" cut="-000001" value="-1"/>
+    <Prescale ctpid="129" cut="000001" value="1"/>
     <Prescale ctpid="130" cut="000001" value="1"/>
     <Prescale ctpid="131" cut="000001" value="1"/>
     <Prescale ctpid="132" cut="000001" value="1"/>
-    <Prescale ctpid="133" cut="-000001" value="-1"/>
+    <Prescale ctpid="133" cut="000001" value="1"/>
     <Prescale ctpid="134" cut="000001" value="1"/>
     <Prescale ctpid="135" cut="000001" value="1"/>
     <Prescale ctpid="136" cut="000001" value="1"/>
@@ -3960,7 +4410,7 @@
     <Prescale ctpid="254" cut="000001" value="1"/>
     <Prescale ctpid="255" cut="000001" value="1"/>
     <Prescale ctpid="256" cut="000001" value="1"/>
-    <Prescale ctpid="257" cut="-000001" value="-1"/>
+    <Prescale ctpid="257" cut="000001" value="1"/>
     <Prescale ctpid="258" cut="000001" value="1"/>
     <Prescale ctpid="259" cut="000001" value="1"/>
     <Prescale ctpid="260" cut="000001" value="1"/>
@@ -3978,7 +4428,7 @@
     <Prescale ctpid="272" cut="000001" value="1"/>
     <Prescale ctpid="273" cut="000001" value="1"/>
     <Prescale ctpid="274" cut="000001" value="1"/>
-    <Prescale ctpid="275" cut="-000001" value="-1"/>
+    <Prescale ctpid="275" cut="000001" value="1"/>
     <Prescale ctpid="276" cut="000001" value="1"/>
     <Prescale ctpid="277" cut="000001" value="1"/>
     <Prescale ctpid="278" cut="000001" value="1"/>
@@ -3988,14 +4438,14 @@
     <Prescale ctpid="282" cut="000001" value="1"/>
     <Prescale ctpid="283" cut="000001" value="1"/>
     <Prescale ctpid="284" cut="000001" value="1"/>
-    <Prescale ctpid="285" cut="-000001" value="-1"/>
+    <Prescale ctpid="285" cut="000001" value="1"/>
     <Prescale ctpid="286" cut="000001" value="1"/>
     <Prescale ctpid="287" cut="000001" value="1"/>
-    <Prescale ctpid="288" cut="-000001" value="-1"/>
+    <Prescale ctpid="288" cut="000001" value="1"/>
     <Prescale ctpid="289" cut="000001" value="1"/>
-    <Prescale ctpid="290" cut="-000001" value="-1"/>
-    <Prescale ctpid="291" cut="-000001" value="-1"/>
-    <Prescale ctpid="292" cut="-000001" value="-1"/>
+    <Prescale ctpid="290" cut="000001" value="1"/>
+    <Prescale ctpid="291" cut="000001" value="1"/>
+    <Prescale ctpid="292" cut="000001" value="1"/>
     <Prescale ctpid="293" cut="000001" value="1"/>
     <Prescale ctpid="294" cut="000001" value="1"/>
     <Prescale ctpid="295" cut="000001" value="1"/>
@@ -4019,7 +4469,7 @@
     <Prescale ctpid="313" cut="000001" value="1"/>
     <Prescale ctpid="314" cut="000001" value="1"/>
     <Prescale ctpid="315" cut="000001" value="1"/>
-    <Prescale ctpid="316" cut="-000001" value="-1"/>
+    <Prescale ctpid="316" cut="000001" value="1"/>
     <Prescale ctpid="317" cut="000001" value="1"/>
     <Prescale ctpid="318" cut="000001" value="1"/>
     <Prescale ctpid="319" cut="000001" value="1"/>
@@ -4029,11 +4479,11 @@
     <Prescale ctpid="323" cut="000001" value="1"/>
     <Prescale ctpid="324" cut="000001" value="1"/>
     <Prescale ctpid="325" cut="000001" value="1"/>
-    <Prescale ctpid="326" cut="-000001" value="-1"/>
+    <Prescale ctpid="326" cut="000001" value="1"/>
     <Prescale ctpid="327" cut="000001" value="1"/>
-    <Prescale ctpid="328" cut="-000001" value="-1"/>
+    <Prescale ctpid="328" cut="000001" value="1"/>
     <Prescale ctpid="329" cut="000001" value="1"/>
-    <Prescale ctpid="330" cut="-000001" value="-1"/>
+    <Prescale ctpid="330" cut="000001" value="1"/>
     <Prescale ctpid="331" cut="000001" value="1"/>
     <Prescale ctpid="332" cut="000001" value="1"/>
     <Prescale ctpid="333" cut="000001" value="1"/>
@@ -4052,7 +4502,7 @@
     <Prescale ctpid="346" cut="000001" value="1"/>
     <Prescale ctpid="347" cut="000001" value="1"/>
     <Prescale ctpid="348" cut="000001" value="1"/>
-    <Prescale ctpid="349" cut="-000001" value="-1"/>
+    <Prescale ctpid="349" cut="000001" value="1"/>
     <Prescale ctpid="350" cut="000001" value="1"/>
     <Prescale ctpid="351" cut="000001" value="1"/>
     <Prescale ctpid="352" cut="000001" value="1"/>
@@ -4065,21 +4515,21 @@
     <Prescale ctpid="359" cut="000001" value="1"/>
     <Prescale ctpid="360" cut="000001" value="1"/>
     <Prescale ctpid="361" cut="000001" value="1"/>
-    <Prescale ctpid="362" cut="-000001" value="-1"/>
-    <Prescale ctpid="363" cut="-000001" value="-1"/>
-    <Prescale ctpid="364" cut="-000001" value="-1"/>
+    <Prescale ctpid="362" cut="000001" value="1"/>
+    <Prescale ctpid="363" cut="000001" value="1"/>
+    <Prescale ctpid="364" cut="000001" value="1"/>
     <Prescale ctpid="365" cut="-000001" value="-1"/>
     <Prescale ctpid="366" cut="000001" value="1"/>
     <Prescale ctpid="367" cut="000001" value="1"/>
     <Prescale ctpid="368" cut="000001" value="1"/>
     <Prescale ctpid="369" cut="000001" value="1"/>
-    <Prescale ctpid="370" cut="-000001" value="-1"/>
+    <Prescale ctpid="370" cut="000001" value="1"/>
     <Prescale ctpid="371" cut="000001" value="1"/>
     <Prescale ctpid="372" cut="000001" value="1"/>
     <Prescale ctpid="373" cut="000001" value="1"/>
-    <Prescale ctpid="374" cut="-000001" value="-1"/>
-    <Prescale ctpid="375" cut="-000001" value="-1"/>
-    <Prescale ctpid="376" cut="-000001" value="-1"/>
+    <Prescale ctpid="374" cut="000001" value="1"/>
+    <Prescale ctpid="375" cut="000001" value="1"/>
+    <Prescale ctpid="376" cut="000001" value="1"/>
     <Prescale ctpid="377" cut="000001" value="1"/>
     <Prescale ctpid="378" cut="000001" value="1"/>
     <Prescale ctpid="379" cut="000001" value="1"/>
@@ -4098,8 +4548,8 @@
     <Prescale ctpid="392" cut="000001" value="1"/>
     <Prescale ctpid="393" cut="000001" value="1"/>
     <Prescale ctpid="394" cut="000001" value="1"/>
-    <Prescale ctpid="395" cut="-000001" value="-1"/>
-    <Prescale ctpid="396" cut="-000001" value="-1"/>
+    <Prescale ctpid="395" cut="000001" value="1"/>
+    <Prescale ctpid="396" cut="000001" value="1"/>
     <Prescale ctpid="397" cut="000001" value="1"/>
     <Prescale ctpid="398" cut="000001" value="1"/>
     <Prescale ctpid="399" cut="000001" value="1"/>
@@ -4110,10 +4560,10 @@
     <Prescale ctpid="404" cut="000001" value="1"/>
     <Prescale ctpid="405" cut="000001" value="1"/>
     <Prescale ctpid="406" cut="000001" value="1"/>
-    <Prescale ctpid="407" cut="-000001" value="-1"/>
+    <Prescale ctpid="407" cut="000001" value="1"/>
     <Prescale ctpid="408" cut="000001" value="1"/>
-    <Prescale ctpid="409" cut="-000001" value="-1"/>
-    <Prescale ctpid="410" cut="-000001" value="-1"/>
+    <Prescale ctpid="409" cut="000001" value="1"/>
+    <Prescale ctpid="410" cut="000001" value="1"/>
     <Prescale ctpid="411" cut="000001" value="1"/>
     <Prescale ctpid="412" cut="000001" value="1"/>
     <Prescale ctpid="413" cut="000001" value="1"/>
@@ -5537,6 +5987,9 @@
     <TriggerCounter name="1TE10.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE10.0ETA24" triggerthreshold="TE10.0ETA24" multi="1"/>
     </TriggerCounter>
+    <TriggerCounter name="1TE15" type="CTPIN">
+      <TriggerCondition name="1TE15" triggerthreshold="TE15" multi="1"/>
+    </TriggerCounter>
     <TriggerCounter name="1TE15.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE15.0ETA24" triggerthreshold="TE15.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -5546,6 +5999,9 @@
     <TriggerCounter name="1TE20.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE20.0ETA24" triggerthreshold="TE20.0ETA24" multi="1"/>
     </TriggerCounter>
+    <TriggerCounter name="1TE25" type="CTPIN">
+      <TriggerCondition name="1TE25" triggerthreshold="TE25" multi="1"/>
+    </TriggerCounter>
     <TriggerCounter name="1TE25.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE25.0ETA24" triggerthreshold="TE25.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -5570,12 +6026,6 @@
     <TriggerCounter name="1TE50" type="CTPIN">
       <TriggerCondition name="1TE50" triggerthreshold="TE50" multi="1"/>
     </TriggerCounter>
-    <TriggerCounter name="1TE60" type="CTPIN">
-      <TriggerCondition name="1TE60" triggerthreshold="TE60" multi="1"/>
-    </TriggerCounter>
-    <TriggerCounter name="1TE70" type="CTPIN">
-      <TriggerCondition name="1TE70" triggerthreshold="TE70" multi="1"/>
-    </TriggerCounter>
     <TriggerCounter name="1TE70.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE70.0ETA24" triggerthreshold="TE70.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -6741,38 +7191,38 @@
         <Signal range_begin="1" range_end="1"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="148" mapping="2" name="TE20" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE20full" phimin="0" phimax="64" priority="0" thresholdval="20" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="148" mapping="2" name="TE15" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE15full" phimin="0" phimax="64" priority="0" thresholdval="15" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="2" range_end="2"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="149" mapping="3" name="TE30" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE30full" phimin="0" phimax="64" priority="0" thresholdval="30" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="149" mapping="3" name="TE20" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE20full" phimin="0" phimax="64" priority="0" thresholdval="20" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="3" range_end="3"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="150" mapping="4" name="TE40" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE40full" phimin="0" phimax="64" priority="0" thresholdval="40" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="150" mapping="4" name="TE25" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE25full" phimin="0" phimax="64" priority="0" thresholdval="25" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="4" range_end="4"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="151" mapping="5" name="TE50" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE50full" phimin="0" phimax="64" priority="0" thresholdval="50" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="151" mapping="5" name="TE30" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE30full" phimin="0" phimax="64" priority="0" thresholdval="30" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="5" range_end="5"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="152" mapping="6" name="TE60" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE60full" phimin="0" phimax="64" priority="0" thresholdval="60" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="152" mapping="6" name="TE40" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE40full" phimin="0" phimax="64" priority="0" thresholdval="40" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="6" range_end="6"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="153" mapping="7" name="TE70" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE70full" phimin="0" phimax="64" priority="0" thresholdval="70" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="153" mapping="7" name="TE50" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE50full" phimin="0" phimax="64" priority="0" thresholdval="50" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="7" range_end="7"/>
       </Cable>
diff --git a/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_Physics_pp_v7.xml b/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_Physics_pp_v7.xml
index 07dea0837e59e94ae40d955d8444f28713c40f38..70a84fa625174f128027c9bcf83a10536aff9ff8 100644
--- a/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_Physics_pp_v7.xml
+++ b/Trigger/TriggerCommon/TriggerMenuXML/data/LVL1config_Physics_pp_v7.xml
@@ -3,7 +3,7 @@
 <LVL1Config name="Physics_pp_v7" ctpVersion="4" l1Version="1">
   <!--File is generated by TriggerMenu-->
   <!--No. L1 thresholds defined: 287-->
-  <!--No. L1 items defined: 469-->
+  <!--No. L1 items defined: 503-->
   <TriggerMenu name="Physics_pp_v7" phase="lumi">
     <TriggerItem ctpid="0" partition="1" name="L1_EM3" complex_deadtime="0" definition="(EM3[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
@@ -354,6 +354,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="48" partition="1" name="L1_ALFA_ELAST1" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;!(ALFA3_B7L1L[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="49" partition="1" name="L1_TAU20" complex_deadtime="0" definition="(HA20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:111|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HA20_x1" triggerthreshold="HA20"/>
@@ -531,6 +549,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="71" partition="1" name="L1_ALFA_ELAST2" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;!(ALFA3_B7L1U[x1]|ALFA3_A7L1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="72" partition="1" name="L1_DR-MU10TAU12I_TAU12I-J25" complex_deadtime="0" definition="(0DR28-MU10ab-TAU12abi[x1]&amp;1DISAMB-TAU12abi-J25ab[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="0DR28-MU10ab-TAU12abi_x1" triggerthreshold="0DR28-MU10ab-TAU12abi"/>
@@ -571,6 +607,16 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="77" partition="1" name="L1_ALFA_ELAST11" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="78" partition="1" name="L1_EM15VHI_2TAU12IM_XE35" complex_deadtime="0" definition="(EM15VHI[x1]&amp;HA12IM[x2]&amp;XE35[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM15VHI_x1" triggerthreshold="EM15VHI"/>
@@ -580,6 +626,28 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="79" partition="1" name="L1_ALFA_ELAST12" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="80" partition="1" name="L1_ALFA_ELAST13" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="81" partition="1" name="L1_MU10_TAU12IM_XE35" complex_deadtime="0" definition="(MU10[x1]&amp;HA12IM[x1]&amp;XE35[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU10_x1" triggerthreshold="MU10"/>
@@ -605,6 +673,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="84" partition="1" name="L1_ALFA_ELAST14" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="85" partition="1" name="L1_XE30" complex_deadtime="0" definition="(XE30[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="XE30_x1" triggerthreshold="XE30"/>
@@ -619,6 +699,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="87" partition="1" name="L1_ALFA_ELAST15" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="88" partition="1" name="L1_MU6_J20" complex_deadtime="0" definition="(MU6[x1]&amp;J20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU6_x1" triggerthreshold="MU6"/>
@@ -875,10 +969,10 @@
         <InternalTrigger name="BGRP8"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="124" partition="1" name="L1_MU4_TE50" complex_deadtime="0" definition="(MU4[x1]&amp;TE50[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="124" partition="1" name="L1_MU4_TE30" complex_deadtime="0" definition="(MU4[x1]&amp;TE30[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU4_x1" triggerthreshold="MU4"/>
-        <TriggerCondition multi="1" name="TE50_x1" triggerthreshold="TE50"/>
+        <TriggerCondition multi="1" name="TE30_x1" triggerthreshold="TE30"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -898,6 +992,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="127" partition="1" name="L1_ALFA_ELAST15_Calib" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="128" partition="1" name="L1_3J40" complex_deadtime="0" definition="(J40[x3]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J40_x3" triggerthreshold="J40"/>
@@ -905,6 +1013,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="129" partition="1" name="L1_ALFA_ELAST16" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="130" partition="1" name="L1_3J50" complex_deadtime="0" definition="(J50[x3]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J50_x3" triggerthreshold="J50"/>
@@ -926,6 +1046,18 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="133" partition="1" name="L1_ALFA_ELAST17" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="134" partition="1" name="L1_MBTSA0" complex_deadtime="0" definition="(MBTS_A0[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_A0_x1" triggerthreshold="MBTS_A0"/>
@@ -1060,9 +1192,9 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="152" partition="1" name="L1_TE70" complex_deadtime="0" definition="(TE70[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="152" partition="1" name="L1_TE25" complex_deadtime="0" definition="(TE25[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="TE70_x1" triggerthreshold="TE70"/>
+        <TriggerCondition multi="1" name="TE25_x1" triggerthreshold="TE25"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -1118,9 +1250,9 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="160" partition="1" name="L1_TE60" complex_deadtime="0" definition="(TE60[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="160" partition="1" name="L1_TE15" complex_deadtime="0" definition="(TE15[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="TE60_x1" triggerthreshold="TE60"/>
+        <TriggerCondition multi="1" name="TE15_x1" triggerthreshold="TE15"/>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
       </AND>
@@ -1932,6 +2064,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="257" partition="1" name="L1_ALFA_ELAST18" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="258" partition="1" name="L1_HT190-J15.ETA21" complex_deadtime="0" definition="(HT190-AJ15all.ETA21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HT190-AJ15all.ETA21_x1" triggerthreshold="HT190-AJ15all.ETA21"/>
@@ -2056,6 +2202,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="275" partition="1" name="L1_ALFA_ELAST18_Calib" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="276" partition="1" name="L1_AFP_A_OR_C" complex_deadtime="0" definition="(((AFP_NSA[x1]&amp;AFP_FSA_SIT[x1])|(AFP_NSC[x1]&amp;AFP_FSC_SIT[x1]))&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <OR>
@@ -2130,6 +2290,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="285" partition="1" name="L1_ALFA_SHOWSYST5" complex_deadtime="0" definition="((ALFA_B7L1U[x1]|ALFA_B7L1L[x1]|ALFA_A7L1U[x1]|ALFA_A7L1L[x1])&amp;(ALFA_A7R1U[x1]|ALFA_A7R1L[x1]|ALFA_B7R1U[x1]|ALFA_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="286" partition="1" name="L1_EM15_W-MT35" complex_deadtime="0" definition="(35MT-EM15s6-XE0[x1]&amp;EM15[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="35MT-EM15s6-XE0_x1" triggerthreshold="35MT-EM15s6-XE0"/>
@@ -2145,6 +2323,24 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="288" partition="1" name="L1_ALFA_SYST9" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;!(ALFA3_B7L1L[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="289" partition="1" name="L1_MBTSA14" complex_deadtime="0" definition="(MBTS_A14[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_A14_x1" triggerthreshold="MBTS_A14"/>
@@ -2152,6 +2348,44 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="290" partition="1" name="L1_ALFA_SYST10" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;!(ALFA3_B7L1U[x1]|ALFA3_A7L1U[x1]|ALFA3_A7R1U[x1]|ALFA3_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <NOT>
+          <OR>
+            <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+            <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+            <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          </OR>
+        </NOT>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="291" partition="1" name="L1_ALFA_SYST11" complex_deadtime="0" definition="(ALFA_B7L1U[x1]&amp;ALFA_A7L1U[x1]&amp;ALFA_A7R1U[x1]&amp;ALFA_B7R1U[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1U_x1" triggerthreshold="ALFA_B7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1U_x1" triggerthreshold="ALFA_A7L1U"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1U_x1" triggerthreshold="ALFA_A7R1U"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1U_x1" triggerthreshold="ALFA_B7R1U"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="292" partition="1" name="L1_ALFA_SYST12" complex_deadtime="0" definition="(ALFA_B7L1L[x1]&amp;ALFA_A7L1L[x1]&amp;ALFA_A7R1L[x1]&amp;ALFA_B7R1L[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="ALFA_B7L1L_x1" triggerthreshold="ALFA_B7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7L1L_x1" triggerthreshold="ALFA_A7L1L"/>
+        <TriggerCondition multi="1" name="ALFA_A7R1L_x1" triggerthreshold="ALFA_A7R1L"/>
+        <TriggerCondition multi="1" name="ALFA_B7R1L_x1" triggerthreshold="ALFA_B7R1L"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="293" partition="1" name="L1_EM12_W-MT25_W-15DPHI-JXE-0_W-15DPHI-EMXE_W-90RO2-XEHT-0" complex_deadtime="0" definition="(25MT-EM12s6-XE0[x1]&amp;EM12[x1]&amp;15MINDPHI-AJj10s6-XE0[x1]&amp;15MINDPHI-EM12s6-XE0[x1]&amp;90RATIO2-XE0-HT0-AJj15all.ETA49[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="25MT-EM12s6-XE0_x1" triggerthreshold="25MT-EM12s6-XE0"/>
@@ -2344,6 +2578,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="316" partition="1" name="L1_ALFA_SYST17" complex_deadtime="0" definition="((ALFA2_A7L1U[x1]|ALFA2_B7L1U[x1])&amp;(ALFA2_A7R1U[x1]|ALFA2_B7R1U[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7L1U_x1" triggerthreshold="ALFA2_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7L1U_x1" triggerthreshold="ALFA2_B7L1U"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1U_x1" triggerthreshold="ALFA2_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1U_x1" triggerthreshold="ALFA2_B7R1U"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="317" partition="1" name="L1_AFP_A_OR_C_MBTS_2" complex_deadtime="0" definition="(((AFP_NSA[x1]&amp;AFP_FSA_SIT[x1])|(AFP_NSC[x1]&amp;AFP_FSC_SIT[x1]))&amp;(MBTS_A[x2]|MBTS_C[x2]|MBTS_A[x1])&amp;(MBTS_A[x2]|MBTS_C[x2]|MBTS_C[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <OR>
@@ -2431,6 +2679,20 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="326" partition="1" name="L1_ALFA_SYST18" complex_deadtime="0" definition="((ALFA2_B7L1L[x1]|ALFA2_A7L1L[x1])&amp;(ALFA2_A7R1L[x1]|ALFA2_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_B7L1L_x1" triggerthreshold="ALFA2_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA2_A7L1L_x1" triggerthreshold="ALFA2_A7L1L"/>
+        </OR>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA2_A7R1L_x1" triggerthreshold="ALFA2_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA2_B7R1L_x1" triggerthreshold="ALFA2_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="327" partition="1" name="L1_MJJ-800" complex_deadtime="0" definition="(800INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="800INVM9999-AJ30s6-AJ20s6_x1" triggerthreshold="800INVM9999-AJ30s6-AJ20s6"/>
@@ -2438,6 +2700,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="328" partition="1" name="L1_ALFA_ANY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="329" partition="1" name="L1_MJJ-400" complex_deadtime="0" definition="(400INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="400INVM9999-AJ30s6-AJ20s6_x1" triggerthreshold="400INVM9999-AJ30s6-AJ20s6"/>
@@ -2445,6 +2723,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="330" partition="1" name="L1_ALFA_ANY_EMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="331" partition="1" name="L1_MBTSC7" complex_deadtime="0" definition="(MBTS_C7[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MBTS_C7_x1" triggerthreshold="MBTS_C7"/>
@@ -2576,6 +2870,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="349" partition="1" name="L1_ALFA_ANY_FIRSTEMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP6)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP6"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="350" partition="1" name="L1_DR-TAU20ITAU12I-J25" complex_deadtime="0" definition="(1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:111|HF:000">
       <AND>
         <TriggerCondition multi="1" name="1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi_x1" triggerthreshold="1DISAMB-J25ab-0DR28-TAU20abi-TAU12abi"/>
@@ -2663,6 +2973,45 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="362" partition="1" name="L1_ALFA_ANY_UNPAIRED_ISO" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP4)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP4"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="363" partition="1" name="L1_ALFA_ANY_UNPAIRED_NONISO" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP5)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP5"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="364" partition="1" name="L1_MU21_FTK" complex_deadtime="0" definition="(MU21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="MU21_x1" triggerthreshold="MU21"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="366" partition="1" name="L1_3J20_4J20.0ETA49_MJJ-400" complex_deadtime="0" definition="(J20[x3]&amp;J20.0ETA49[x4]&amp;400INVM9999-AJ30s6-AJ20s6[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="3" name="J20_x3" triggerthreshold="J20"/>
@@ -2699,6 +3048,22 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="370" partition="1" name="L1_ALFA_ANY_BGRP10" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP10"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="371" partition="1" name="L1_EM7_FIRSTEMPTY" complex_deadtime="0" definition="(EM7[x1]&amp;BGRP0&amp;BGRP6)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM7_x1" triggerthreshold="EM7"/>
@@ -2720,6 +3085,50 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="374" partition="1" name="L1_ALFA_ANY_ABORTGAPNOTCALIB" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP8)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP8"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="375" partition="1" name="L1_ALFA_ANY_CALIB" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1]|ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP2)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP2"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="376" partition="1" name="L1_ALFA_B1_EMPTY" complex_deadtime="0" definition="((ALFA3_B7L1U[x1]|ALFA3_B7L1L[x1]|ALFA3_A7L1U[x1]|ALFA3_A7L1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_B7L1U_x1" triggerthreshold="ALFA3_B7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7L1L_x1" triggerthreshold="ALFA3_B7L1L"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1U_x1" triggerthreshold="ALFA3_A7L1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7L1L_x1" triggerthreshold="ALFA3_A7L1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="377" partition="1" name="L1_MU10_TAU20IM_J25_2J20" complex_deadtime="0" definition="(MU10[x1]&amp;HA20IM[x1]&amp;J25[x1]&amp;J20[x2]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="MU10_x1" triggerthreshold="MU10"/>
@@ -2864,6 +3273,20 @@
         <InternalTrigger name="BGRP3"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="395" partition="1" name="L1_ALFA_BGT_BGRP1" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP1)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <InternalTrigger name="RNDM3"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="396" partition="1" name="L1_ALFA_BGT_BGRP4" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP4)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <InternalTrigger name="RNDM3"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP4"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="397" partition="1" name="L1_MJJ-400-CF" complex_deadtime="0" definition="(400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000000" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49_x1" triggerthreshold="400INVM9999-AJ30s6.ETA31-AJ20s6.31ETA49"/>
@@ -2941,6 +3364,18 @@
         <InternalTrigger name="BGRP6"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="407" partition="1" name="L1_ALFA_B2_EMPTY" complex_deadtime="0" definition="((ALFA3_A7R1U[x1]|ALFA3_A7R1L[x1]|ALFA3_B7R1U[x1]|ALFA3_B7R1L[x1])&amp;BGRP0&amp;BGRP3)" trigger_type="11000000" monitor="LF:000|HF:000">
+      <AND>
+        <OR>
+          <TriggerCondition multi="1" name="ALFA3_A7R1U_x1" triggerthreshold="ALFA3_A7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_A7R1L_x1" triggerthreshold="ALFA3_A7R1L"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1U_x1" triggerthreshold="ALFA3_B7R1U"/>
+          <TriggerCondition multi="1" name="ALFA3_B7R1L_x1" triggerthreshold="ALFA3_B7R1L"/>
+        </OR>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP3"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="408" partition="1" name="L1_TAU20IM_2TAU12IM_4J12" complex_deadtime="0" definition="(HA20IM[x1]&amp;HA12IM[x2]&amp;J12[x4]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="HA20IM_x1" triggerthreshold="HA20IM"/>
@@ -2950,6 +3385,21 @@
         <InternalTrigger name="BGRP1"/>
       </AND>
     </TriggerItem>
+    <TriggerItem ctpid="409" partition="1" name="L1_2EM12" complex_deadtime="0" definition="(EM12[x2]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="2" name="EM12_x2" triggerthreshold="EM12"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
+    <TriggerItem ctpid="410" partition="1" name="L1_MU4_TE20" complex_deadtime="0" definition="(MU4[x1]&amp;TE20[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10001000" monitor="LF:000|HF:000">
+      <AND>
+        <TriggerCondition multi="1" name="MU4_x1" triggerthreshold="MU4"/>
+        <TriggerCondition multi="1" name="TE20_x1" triggerthreshold="TE20"/>
+        <InternalTrigger name="BGRP0"/>
+        <InternalTrigger name="BGRP1"/>
+      </AND>
+    </TriggerItem>
     <TriggerItem ctpid="411" partition="1" name="L1_EM20VH_FIRSTEMPTY" complex_deadtime="0" definition="(EM20VH[x1]&amp;BGRP0&amp;BGRP6)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="1" name="EM20VH_x1" triggerthreshold="EM20VH"/>
@@ -3460,11 +3910,11 @@
         <InternalTrigger name="BGRP10"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="474" partition="1" name="L1_2EM3_VTE70" complex_deadtime="0" definition="(EM3[x2]&amp;!TE70[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="474" partition="1" name="L1_2EM3_VTE50" complex_deadtime="0" definition="(EM3[x2]&amp;!TE50[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10000100" monitor="LF:000|HF:000">
       <AND>
         <TriggerCondition multi="2" name="EM3_x2" triggerthreshold="EM3"/>
         <NOT>
-          <TriggerCondition multi="1" name="TE70_x1" triggerthreshold="TE70"/>
+          <TriggerCondition multi="1" name="TE50_x1" triggerthreshold="TE50"/>
         </NOT>
         <InternalTrigger name="BGRP0"/>
         <InternalTrigger name="BGRP1"/>
@@ -3619,11 +4069,11 @@
         <InternalTrigger name="BGRP0"/>
       </AND>
     </TriggerItem>
-    <TriggerItem ctpid="497" partition="1" name="L1_MU21_FTK" complex_deadtime="0" definition="(MU21[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
+    <TriggerItem ctpid="497" partition="1" name="L1_ALFA_BGT_BGRP10" complex_deadtime="0" definition="(RNDM3&amp;BGRP0&amp;BGRP10)" trigger_type="11000000" monitor="LF:000|HF:000">
       <AND>
-        <TriggerCondition multi="1" name="MU21_x1" triggerthreshold="MU21"/>
+        <InternalTrigger name="RNDM3"/>
         <InternalTrigger name="BGRP0"/>
-        <InternalTrigger name="BGRP1"/>
+        <InternalTrigger name="BGRP10"/>
       </AND>
     </TriggerItem>
     <TriggerItem ctpid="498" partition="1" name="L1_MU20_TAU12IM_FTK" complex_deadtime="0" definition="(MU20[x1]&amp;HA12IM[x1]&amp;BGRP0&amp;BGRP1)" trigger_type="10100000" monitor="LF:000|HF:000">
@@ -3765,7 +4215,7 @@
     <Prescale ctpid="45" cut="000001" value="1"/>
     <Prescale ctpid="46" cut="000001" value="1"/>
     <Prescale ctpid="47" cut="000001" value="1"/>
-    <Prescale ctpid="48" cut="-000001" value="-1"/>
+    <Prescale ctpid="48" cut="000001" value="1"/>
     <Prescale ctpid="49" cut="000001" value="1"/>
     <Prescale ctpid="50" cut="000001" value="1"/>
     <Prescale ctpid="51" cut="000001" value="1"/>
@@ -3788,23 +4238,23 @@
     <Prescale ctpid="68" cut="000001" value="1"/>
     <Prescale ctpid="69" cut="000001" value="1"/>
     <Prescale ctpid="70" cut="000001" value="1"/>
-    <Prescale ctpid="71" cut="-000001" value="-1"/>
+    <Prescale ctpid="71" cut="000001" value="1"/>
     <Prescale ctpid="72" cut="000001" value="1"/>
     <Prescale ctpid="73" cut="000001" value="1"/>
     <Prescale ctpid="74" cut="000001" value="1"/>
     <Prescale ctpid="75" cut="000001" value="1"/>
     <Prescale ctpid="76" cut="000001" value="1"/>
-    <Prescale ctpid="77" cut="-000001" value="-1"/>
+    <Prescale ctpid="77" cut="000001" value="1"/>
     <Prescale ctpid="78" cut="000001" value="1"/>
-    <Prescale ctpid="79" cut="-000001" value="-1"/>
-    <Prescale ctpid="80" cut="-000001" value="-1"/>
+    <Prescale ctpid="79" cut="000001" value="1"/>
+    <Prescale ctpid="80" cut="000001" value="1"/>
     <Prescale ctpid="81" cut="000001" value="1"/>
     <Prescale ctpid="82" cut="000001" value="1"/>
     <Prescale ctpid="83" cut="000001" value="1"/>
-    <Prescale ctpid="84" cut="-000001" value="-1"/>
+    <Prescale ctpid="84" cut="000001" value="1"/>
     <Prescale ctpid="85" cut="000001" value="1"/>
     <Prescale ctpid="86" cut="000001" value="1"/>
-    <Prescale ctpid="87" cut="-000001" value="-1"/>
+    <Prescale ctpid="87" cut="000001" value="1"/>
     <Prescale ctpid="88" cut="000001" value="1"/>
     <Prescale ctpid="89" cut="000001" value="1"/>
     <Prescale ctpid="90" cut="000001" value="1"/>
@@ -3844,13 +4294,13 @@
     <Prescale ctpid="124" cut="000001" value="1"/>
     <Prescale ctpid="125" cut="000001" value="1"/>
     <Prescale ctpid="126" cut="000001" value="1"/>
-    <Prescale ctpid="127" cut="-000001" value="-1"/>
+    <Prescale ctpid="127" cut="000001" value="1"/>
     <Prescale ctpid="128" cut="000001" value="1"/>
-    <Prescale ctpid="129" cut="-000001" value="-1"/>
+    <Prescale ctpid="129" cut="000001" value="1"/>
     <Prescale ctpid="130" cut="000001" value="1"/>
     <Prescale ctpid="131" cut="000001" value="1"/>
     <Prescale ctpid="132" cut="000001" value="1"/>
-    <Prescale ctpid="133" cut="-000001" value="-1"/>
+    <Prescale ctpid="133" cut="000001" value="1"/>
     <Prescale ctpid="134" cut="000001" value="1"/>
     <Prescale ctpid="135" cut="000001" value="1"/>
     <Prescale ctpid="136" cut="000001" value="1"/>
@@ -3974,7 +4424,7 @@
     <Prescale ctpid="254" cut="000001" value="1"/>
     <Prescale ctpid="255" cut="000001" value="1"/>
     <Prescale ctpid="256" cut="000001" value="1"/>
-    <Prescale ctpid="257" cut="-000001" value="-1"/>
+    <Prescale ctpid="257" cut="000001" value="1"/>
     <Prescale ctpid="258" cut="000001" value="1"/>
     <Prescale ctpid="259" cut="000001" value="1"/>
     <Prescale ctpid="260" cut="000001" value="1"/>
@@ -3992,7 +4442,7 @@
     <Prescale ctpid="272" cut="000001" value="1"/>
     <Prescale ctpid="273" cut="000001" value="1"/>
     <Prescale ctpid="274" cut="000001" value="1"/>
-    <Prescale ctpid="275" cut="-000001" value="-1"/>
+    <Prescale ctpid="275" cut="000001" value="1"/>
     <Prescale ctpid="276" cut="000001" value="1"/>
     <Prescale ctpid="277" cut="000001" value="1"/>
     <Prescale ctpid="278" cut="000001" value="1"/>
@@ -4002,14 +4452,14 @@
     <Prescale ctpid="282" cut="000001" value="1"/>
     <Prescale ctpid="283" cut="000001" value="1"/>
     <Prescale ctpid="284" cut="000001" value="1"/>
-    <Prescale ctpid="285" cut="-000001" value="-1"/>
+    <Prescale ctpid="285" cut="000001" value="1"/>
     <Prescale ctpid="286" cut="000001" value="1"/>
     <Prescale ctpid="287" cut="000001" value="1"/>
-    <Prescale ctpid="288" cut="-000001" value="-1"/>
+    <Prescale ctpid="288" cut="000001" value="1"/>
     <Prescale ctpid="289" cut="000001" value="1"/>
-    <Prescale ctpid="290" cut="-000001" value="-1"/>
-    <Prescale ctpid="291" cut="-000001" value="-1"/>
-    <Prescale ctpid="292" cut="-000001" value="-1"/>
+    <Prescale ctpid="290" cut="000001" value="1"/>
+    <Prescale ctpid="291" cut="000001" value="1"/>
+    <Prescale ctpid="292" cut="000001" value="1"/>
     <Prescale ctpid="293" cut="000001" value="1"/>
     <Prescale ctpid="294" cut="000001" value="1"/>
     <Prescale ctpid="295" cut="000001" value="1"/>
@@ -4033,7 +4483,7 @@
     <Prescale ctpid="313" cut="000001" value="1"/>
     <Prescale ctpid="314" cut="000001" value="1"/>
     <Prescale ctpid="315" cut="000001" value="1"/>
-    <Prescale ctpid="316" cut="-000001" value="-1"/>
+    <Prescale ctpid="316" cut="000001" value="1"/>
     <Prescale ctpid="317" cut="000001" value="1"/>
     <Prescale ctpid="318" cut="000001" value="1"/>
     <Prescale ctpid="319" cut="000001" value="1"/>
@@ -4043,11 +4493,11 @@
     <Prescale ctpid="323" cut="000001" value="1"/>
     <Prescale ctpid="324" cut="000001" value="1"/>
     <Prescale ctpid="325" cut="000001" value="1"/>
-    <Prescale ctpid="326" cut="-000001" value="-1"/>
+    <Prescale ctpid="326" cut="000001" value="1"/>
     <Prescale ctpid="327" cut="000001" value="1"/>
-    <Prescale ctpid="328" cut="-000001" value="-1"/>
+    <Prescale ctpid="328" cut="000001" value="1"/>
     <Prescale ctpid="329" cut="000001" value="1"/>
-    <Prescale ctpid="330" cut="-000001" value="-1"/>
+    <Prescale ctpid="330" cut="000001" value="1"/>
     <Prescale ctpid="331" cut="000001" value="1"/>
     <Prescale ctpid="332" cut="000001" value="1"/>
     <Prescale ctpid="333" cut="000001" value="1"/>
@@ -4066,7 +4516,7 @@
     <Prescale ctpid="346" cut="000001" value="1"/>
     <Prescale ctpid="347" cut="000001" value="1"/>
     <Prescale ctpid="348" cut="000001" value="1"/>
-    <Prescale ctpid="349" cut="-000001" value="-1"/>
+    <Prescale ctpid="349" cut="000001" value="1"/>
     <Prescale ctpid="350" cut="000001" value="1"/>
     <Prescale ctpid="351" cut="000001" value="1"/>
     <Prescale ctpid="352" cut="000001" value="1"/>
@@ -4079,21 +4529,21 @@
     <Prescale ctpid="359" cut="000001" value="1"/>
     <Prescale ctpid="360" cut="000001" value="1"/>
     <Prescale ctpid="361" cut="000001" value="1"/>
-    <Prescale ctpid="362" cut="-000001" value="-1"/>
-    <Prescale ctpid="363" cut="-000001" value="-1"/>
-    <Prescale ctpid="364" cut="-000001" value="-1"/>
+    <Prescale ctpid="362" cut="000001" value="1"/>
+    <Prescale ctpid="363" cut="000001" value="1"/>
+    <Prescale ctpid="364" cut="000001" value="1"/>
     <Prescale ctpid="365" cut="-000001" value="-1"/>
     <Prescale ctpid="366" cut="000001" value="1"/>
     <Prescale ctpid="367" cut="000001" value="1"/>
     <Prescale ctpid="368" cut="000001" value="1"/>
     <Prescale ctpid="369" cut="000001" value="1"/>
-    <Prescale ctpid="370" cut="-000001" value="-1"/>
+    <Prescale ctpid="370" cut="000001" value="1"/>
     <Prescale ctpid="371" cut="000001" value="1"/>
     <Prescale ctpid="372" cut="000001" value="1"/>
     <Prescale ctpid="373" cut="000001" value="1"/>
-    <Prescale ctpid="374" cut="-000001" value="-1"/>
-    <Prescale ctpid="375" cut="-000001" value="-1"/>
-    <Prescale ctpid="376" cut="-000001" value="-1"/>
+    <Prescale ctpid="374" cut="000001" value="1"/>
+    <Prescale ctpid="375" cut="000001" value="1"/>
+    <Prescale ctpid="376" cut="000001" value="1"/>
     <Prescale ctpid="377" cut="000001" value="1"/>
     <Prescale ctpid="378" cut="000001" value="1"/>
     <Prescale ctpid="379" cut="000001" value="1"/>
@@ -4112,8 +4562,8 @@
     <Prescale ctpid="392" cut="000001" value="1"/>
     <Prescale ctpid="393" cut="000001" value="1"/>
     <Prescale ctpid="394" cut="000001" value="1"/>
-    <Prescale ctpid="395" cut="-000001" value="-1"/>
-    <Prescale ctpid="396" cut="-000001" value="-1"/>
+    <Prescale ctpid="395" cut="000001" value="1"/>
+    <Prescale ctpid="396" cut="000001" value="1"/>
     <Prescale ctpid="397" cut="000001" value="1"/>
     <Prescale ctpid="398" cut="000001" value="1"/>
     <Prescale ctpid="399" cut="000001" value="1"/>
@@ -4124,10 +4574,10 @@
     <Prescale ctpid="404" cut="000001" value="1"/>
     <Prescale ctpid="405" cut="000001" value="1"/>
     <Prescale ctpid="406" cut="000001" value="1"/>
-    <Prescale ctpid="407" cut="-000001" value="-1"/>
+    <Prescale ctpid="407" cut="000001" value="1"/>
     <Prescale ctpid="408" cut="000001" value="1"/>
-    <Prescale ctpid="409" cut="-000001" value="-1"/>
-    <Prescale ctpid="410" cut="-000001" value="-1"/>
+    <Prescale ctpid="409" cut="000001" value="1"/>
+    <Prescale ctpid="410" cut="000001" value="1"/>
     <Prescale ctpid="411" cut="000001" value="1"/>
     <Prescale ctpid="412" cut="000001" value="1"/>
     <Prescale ctpid="413" cut="000001" value="1"/>
@@ -5551,6 +6001,9 @@
     <TriggerCounter name="1TE10.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE10.0ETA24" triggerthreshold="TE10.0ETA24" multi="1"/>
     </TriggerCounter>
+    <TriggerCounter name="1TE15" type="CTPIN">
+      <TriggerCondition name="1TE15" triggerthreshold="TE15" multi="1"/>
+    </TriggerCounter>
     <TriggerCounter name="1TE15.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE15.0ETA24" triggerthreshold="TE15.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -5560,6 +6013,9 @@
     <TriggerCounter name="1TE20.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE20.0ETA24" triggerthreshold="TE20.0ETA24" multi="1"/>
     </TriggerCounter>
+    <TriggerCounter name="1TE25" type="CTPIN">
+      <TriggerCondition name="1TE25" triggerthreshold="TE25" multi="1"/>
+    </TriggerCounter>
     <TriggerCounter name="1TE25.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE25.0ETA24" triggerthreshold="TE25.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -5584,12 +6040,6 @@
     <TriggerCounter name="1TE50" type="CTPIN">
       <TriggerCondition name="1TE50" triggerthreshold="TE50" multi="1"/>
     </TriggerCounter>
-    <TriggerCounter name="1TE60" type="CTPIN">
-      <TriggerCondition name="1TE60" triggerthreshold="TE60" multi="1"/>
-    </TriggerCounter>
-    <TriggerCounter name="1TE70" type="CTPIN">
-      <TriggerCondition name="1TE70" triggerthreshold="TE70" multi="1"/>
-    </TriggerCounter>
     <TriggerCounter name="1TE70.0ETA24" type="CTPIN">
       <TriggerCondition name="1TE70.0ETA24" triggerthreshold="TE70.0ETA24" multi="1"/>
     </TriggerCounter>
@@ -6755,38 +7205,38 @@
         <Signal range_begin="1" range_end="1"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="148" mapping="2" name="TE20" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE20full" phimin="0" phimax="64" priority="0" thresholdval="20" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="148" mapping="2" name="TE15" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE15full" phimin="0" phimax="64" priority="0" thresholdval="15" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="2" range_end="2"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="149" mapping="3" name="TE30" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE30full" phimin="0" phimax="64" priority="0" thresholdval="30" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="149" mapping="3" name="TE20" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE20full" phimin="0" phimax="64" priority="0" thresholdval="20" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="3" range_end="3"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="150" mapping="4" name="TE40" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE40full" phimin="0" phimax="64" priority="0" thresholdval="40" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="150" mapping="4" name="TE25" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE25full" phimin="0" phimax="64" priority="0" thresholdval="25" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="4" range_end="4"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="151" mapping="5" name="TE50" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE50full" phimin="0" phimax="64" priority="0" thresholdval="50" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="151" mapping="5" name="TE30" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE30full" phimin="0" phimax="64" priority="0" thresholdval="30" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="5" range_end="5"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="152" mapping="6" name="TE60" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE60full" phimin="0" phimax="64" priority="0" thresholdval="60" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="152" mapping="6" name="TE40" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE40full" phimin="0" phimax="64" priority="0" thresholdval="40" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="6" range_end="6"/>
       </Cable>
     </TriggerThreshold>
-    <TriggerThreshold active="1" bitnum="1" id="153" mapping="7" name="TE70" type="TE" input="ctpin" version="1">
-      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE70full" phimin="0" phimax="64" priority="0" thresholdval="70" type="TE" window="0"/>
+    <TriggerThreshold active="1" bitnum="1" id="153" mapping="7" name="TE50" type="TE" input="ctpin" version="1">
+      <TriggerThresholdValue em_isolation="63" etamin="-49" etamax="49" had_isolation="63" had_veto="63" name="TE50full" phimin="0" phimax="64" priority="0" thresholdval="50" type="TE" window="0"/>
       <Cable connector="CON2" input="SLOT8" name="EN1">
         <Signal range_begin="7" range_end="7"/>
       </Cable>
diff --git a/Trigger/TriggerRelease/python/Modifiers.py b/Trigger/TriggerRelease/python/Modifiers.py
index 227bac482d3f16f625b0887d62e713c881b9dabb..21e70803a62c8940ee09b5324e59a2e03ac20d39 100644
--- a/Trigger/TriggerRelease/python/Modifiers.py
+++ b/Trigger/TriggerRelease/python/Modifiers.py
@@ -116,30 +116,6 @@ class BunchSpacing50ns(_modifier):
         from InDetTrigRecExample.InDetTrigFlags import InDetTrigFlags
         InDetTrigFlags.InDet25nsec.set_Value_and_Lock(False)
 
-class TRTCalibFromDB(_modifier):
-    """
-    setup TRT calibration from DB 
-    """
-    def preSetup(self):
-        if TriggerFlags.doID():
-            from AthenaCommon.AppMgr import ToolSvc
-            from TRT_DriftFunctionTool.TRT_DriftFunctionToolConf import TRT_DriftFunctionTool
-            TRT_DriftFunctionTool = TRT_DriftFunctionTool(name = "TRT_DriftFunctionTool")
-            ToolSvc += TRT_DriftFunctionTool
-
-            from IOVDbSvc.CondDB import conddb
-            from AthenaCommon.GlobalFlags import globalflags
-            if globalflags.DetGeo=='commis':
-                conddb.addFolder("TRT","/TRT/Calib/RT<tag>TrtCalibRt-bootstrap-01</tag>" )
-                conddb.addFolder("TRT","/TRT/Calib/T0<tag>TrtCalibT0-bootstrap-01</tag>" )
-                conddb.addOverride("/TRT/Calib/RT","TrtCalibRt-bootstrap-01")
-                conddb.addOverride("/TRT/Calib/T0","TrtCalibT0-bootstrap-01")
-            else:
-                if not conddb.folderRequested("/TRT/Calib/RT"):
-                    conddb.addFolder("TRT","/TRT/Calib/RT" )
-                if not conddb.folderRequested("/TRT/Calib/T0"):
-                    conddb.addFolder("TRT","/TRT/Calib/T0" )   
-
 class disableTRTActiveFraction(_modifier):
     """
     remove TRT ActiveFractionSvc from the configuration 
@@ -582,17 +558,6 @@ class enableHotIDMasking(_modifier):
             ToolSvc.OnlineSpacePointProviderTool.UsePixelClusterThreshold=True
             ToolSvc.OnlineSpacePointProviderTool.UseSctClusterThreshold=True
 
-class softTRTsettings(_modifier):
-    """
-    Lower cuts for standalone TRT tracking in cosmic chains
-    """
-    def postSetup(self):
-        from AthenaCommon.AppMgr import ToolSvc
-        if hasattr(ToolSvc,"InDetL2_TRT_TrackSegmentsMaker_BarrelCosmics"):
-            ToolSvc.InDetL2_TRT_TrackSegmentsMaker_BarrelCosmics.MinimalNumberOfTRTHits = 15
-        if hasattr(ToolSvc,"InDetL2_TRT_TrackSegmentsMaker_BarrelCosmics_NoField"):
-            ToolSvc.InDetL2_TRT_TrackSegmentsMaker_BarrelCosmics_NoField.MinimalNumberOfTRTHits = 15
-
 class disableCaloAllSamples(_modifier):
     """
     Request calorimeter data in 4 requests. Inefficient more needed for large sample (>5) running
@@ -1329,11 +1294,6 @@ class detailedTiming(_modifier):
         svcMgr.TrigTimerSvc.IncludeName=".+"
         from AthenaCommon.AlgSequence import AlgSequence
         topSequence = AlgSequence()
-        if hasattr(topSequence,'TrigSteer_L2'):
-            for instance in ['muFast_Muon','muFast_900GeV']:
-                muFast = topSequence.TrigSteer_L2.allConfigurables.get(instance)
-                if muFast:
-                    muFast.Timing=True
         if hasattr(topSequence,'TrigSteer_HLT'):
             for instance in ['muFast_Muon','muFast_900GeV']:
                 muFast = topSequence.TrigSteer_HLT.allConfigurables.get(instance)
@@ -1595,19 +1555,6 @@ class doEnhancedBiasWeights(_modifier):
         except:
             print 'TrigCostD3PDMaker packages not available, will not produce Enhanced Bias weighting D3PD.' 
         
-class ForceMCSCTMapping(_modifier):
-    """
-    Hardcoded SCT cable map to use the full MC ones
-    MC cabling map is not the default setting anymore
-    """
-    def postSetup(self):
-        from AthenaCommon.AppMgr import ServiceMgr as svcMgr
-        if not hasattr(svcMgr,"SCT_CablingSvc"):
-            from SCT_Cabling.SCT_CablingConf import SCT_CablingSvc
-            svcMgr+=SCT_CablingSvc()
-        svcMgr.SCT_CablingSvc.DataSource = "SCT_MC_FullCabling_svc.dat"
-
-
 class BeamspotFromSqlite(_modifier):
     """
     Read beamspot from sqlite file (./beampos.db)
@@ -1658,7 +1605,28 @@ class useDynamicAlignFolders(_modifier):
         from AtlasGeoModel.InDetGMJobProperties import GeometryFlags;
         GeometryFlags.useDynamicAlignFolders.set_Value_and_Lock(True)
 
-    
+
+class PixelOnlyZFinder(_modifier):
+    """
+    use only Pixel information in the ZFinder
+    it affects the operation of the beamspot
+    it should not be used in special runs:
+    evaluation of the beamspot w/o stable beams for example
+    """
+    def postSetup(self):
+        try:
+            from AthenaCommon.AppMgr import ToolSvc
+            zf = ToolSvc.TrigZFinder
+            zf.NumberOfPeaks = 4
+            zf.TripletMode = 1
+            zf.TripletDZ = 1
+            zf.PhiBinSize = 0.1
+            zf.MaxLayer = 3
+            zf.MinVtxSignificance = 10
+            zf.Percentile = 0.95
+        except:
+            log.error("PixelOnlyZFinder set but no public instance of TrigZFinder")
+
 ###############################################################
 # Modifiers believed to be obsolete.
 ###############################################################
diff --git a/Trigger/TriggerRelease/share/runHLT_standalone.py b/Trigger/TriggerRelease/share/runHLT_standalone.py
index 6365aa5c027b736a38d543d4d060524dcf16bfdf..ff648a238ea3a980c5c98cbc0d90efcd4bd5d9ac 100755
--- a/Trigger/TriggerRelease/share/runHLT_standalone.py
+++ b/Trigger/TriggerRelease/share/runHLT_standalone.py
@@ -221,7 +221,6 @@ defaultOptions['setModifiers']=[#Common modifiers for MC and data
                                 'detailedErrorStreams',
                                 'optimizeChainOrder',    
                                 'enableHotIDMasking',
-                                'softTRTsettings',
                                 'openThresholdRPCCabling',
                                 #special streaming setup
                                 'enable7BitL1TTStreaming',