CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Private Member Functions | Private Attributes
external::HEPTopTaggerV2_fixed_R Class Reference

#include <HEPTopTaggerV2.h>

Public Types

typedef fastjet::ClusterSequence ClusterSequence
 
typedef fastjet::JetAlgorithm JetAlgorithm
 
typedef fastjet::JetDefinition JetDefinition
 
typedef fastjet::PseudoJet PseudoJet
 

Public Member Functions

const PseudoJetb () const
 
double delta_top () const
 
double djsum () const
 
void do_qjets (bool qjets)
 
double f_rec ()
 
const PseudoJetfat_initial ()
 
void get_info () const
 
void get_setting () const
 
const std::vector< PseudoJet > & hardparts () const
 
 HEPTopTaggerV2_fixed_R ()
 
 HEPTopTaggerV2_fixed_R (fastjet::PseudoJet jet)
 
 HEPTopTaggerV2_fixed_R (fastjet::PseudoJet jet, double mtmass, double mwmass)
 
bool is_masscut_passed () const
 
bool is_maybe_top () const
 
bool is_minptcut_passed () const
 
bool is_tagged () const
 
const PseudoJetj1 () const
 
const PseudoJetj2 () const
 
const PseudoJetj3 () const
 
double nsub (fastjet::PseudoJet jet, int order, fastjet::contrib::Njettiness::AxesMode axes=fastjet::contrib::Njettiness::kt_axes, double beta=1., double R0=1.)
 
double pruned_mass () const
 
double q_weight ()
 
void run ()
 
void set_debug (bool debug)
 
void set_filtering_jetalgorithm (JetAlgorithm jet_algorithm)
 
void set_filtering_minpt_subjet (double x)
 
void set_filtering_n (unsigned nfilt)
 
void set_filtering_R (double Rfilt)
 
void set_fw (double fw)
 
void set_mass_drop_threshold (double x)
 
void set_mass_ratio_cut (double m23cut, double m13cutmin, double m13cutmax)
 
void set_mass_ratio_range (double rmin, double rmax)
 
void set_max_subjet_mass (double x)
 
void set_mode (enum Mode mode)
 
void set_mt (double x)
 
void set_mw (double x)
 
void set_pruning_rcut_factor (double rcut_factor)
 
void set_pruning_zcut (double zcut)
 
void set_qjets (double q_zcut, double q_dcut_fctr, double q_exp_min, double q_exp_max, double q_rigidity, double q_truncation_fctr)
 
void set_qjets_rng (CLHEP::HepRandomEngine *engine)
 
void set_reclustering_jetalgorithm (JetAlgorithm jet_algorithm)
 
void set_top_mass_range (double xmin, double xmax)
 
void set_top_minpt (double x)
 
const PseudoJett () const
 
const std::vector< PseudoJet > & top_hadrons () const
 
const std::vector< PseudoJet > & top_subjets () const
 
double unfiltered_mass () const
 
const PseudoJetW () const
 
const PseudoJetW1 () const
 
const PseudoJetW2 () const
 

Private Member Functions

bool check_mass_criteria (const std::vector< fastjet::PseudoJet > &top_subs) const
 
double djademod (const fastjet::PseudoJet &subjet_i, const fastjet::PseudoJet &subjet_j, const fastjet::PseudoJet &ref)
 
std::vector< PseudoJetFiltering (const std::vector< PseudoJet > &top_constits, const JetDefinition &filtering_def)
 
void FindHardSubst (const PseudoJet &jet, std::vector< fastjet::PseudoJet > &t_parts)
 
double perp (const PseudoJet &vec, const fastjet::PseudoJet &ref)
 
void print_banner ()
 
void store_topsubjets (const std::vector< PseudoJet > &top_subs)
 

Private Attributes

bool _debug
 
double _delta_top
 
double _djsum
 
bool _do_qjets
 
PseudoJet _fat
 
bool _first_time
 
double _fw
 
PseudoJet _initial_jet
 
bool _is_masscut_passed
 
bool _is_maybe_top
 
bool _is_ptmincut_passed
 
PseudoJet _jet
 
JetAlgorithm _jet_algorithm_filter
 
JetAlgorithm _jet_algorithm_recluster
 
double _m13cutmax
 
double _m13cutmin
 
double _m23cut
 
double _mass_drop_threshold
 
double _max_subjet_mass
 
double _minpt_subjet
 
double _minpt_tag
 
Mode _mode
 
double _mtmass
 
double _mtmax
 
double _mtmin
 
double _mwmass
 
unsigned _nfilt
 
unsigned _parts_size
 
double _pruned_mass
 
double _q_dcut_fctr
 
double _q_exp_max
 
double _q_exp_min
 
double _q_rigidity
 
double _q_truncation_fctr
 
double _q_zcut
 
JetDefinition _qjet_def
 
double _qweight
 
double _rcut_factor
 
double _Rfilt
 
double _rmax
 
double _rmin
 
CLHEP::HepRandomEngine * _rnEngine
 
PseudoJet _top_candidate
 
std::vector< PseudoJet_top_hadrons
 
std::vector< PseudoJet_top_parts
 
std::vector< PseudoJet_top_subjets
 
std::vector< PseudoJet_top_subs
 
double _unfiltered_mass
 
PseudoJet _W
 
double _zcut
 

Detailed Description

Definition at line 32 of file HEPTopTaggerV2.h.

Member Typedef Documentation

typedef fastjet::ClusterSequence external::HEPTopTaggerV2_fixed_R::ClusterSequence

Definition at line 34 of file HEPTopTaggerV2.h.

typedef fastjet::JetAlgorithm external::HEPTopTaggerV2_fixed_R::JetAlgorithm

Definition at line 35 of file HEPTopTaggerV2.h.

typedef fastjet::JetDefinition external::HEPTopTaggerV2_fixed_R::JetDefinition

Definition at line 36 of file HEPTopTaggerV2.h.

typedef fastjet::PseudoJet external::HEPTopTaggerV2_fixed_R::PseudoJet

Definition at line 37 of file HEPTopTaggerV2.h.

Constructor & Destructor Documentation

external::HEPTopTaggerV2_fixed_R::HEPTopTaggerV2_fixed_R ( )

Definition at line 141 of file HEPTopTaggerV2.cc.

References _delta_top, _djsum, _is_masscut_passed, _is_maybe_top, _is_ptmincut_passed, _parts_size, _pruned_mass, _qweight, _top_candidate, _top_hadrons, _top_parts, _top_subjets, _top_subs, and _unfiltered_mass.

141  : _do_qjets(false),
143  _mode(Mode(0)), _mtmass(172.3), _mwmass(80.4), _mtmin(150.), _mtmax(200.), _rmin(0.85*80.4/172.3), _rmax(1.15*80.4/172.3),
144  _m23cut(0.35), _m13cutmin(0.2), _m13cutmax(1.3), _minpt_tag(200.),
145  _nfilt(5), _Rfilt(0.3), _jet_algorithm_filter(fastjet::cambridge_algorithm), _minpt_subjet(0.),
146  _jet_algorithm_recluster(fastjet::cambridge_algorithm),
147  _zcut(0.1), _rcut_factor(0.5),
148  _q_zcut(0.1), _q_dcut_fctr(0.5), _q_exp_min(0.), _q_exp_max(0.), _q_rigidity(0.1), _q_truncation_fctr(0.0), _rnEngine(nullptr),
149  //_qjet_plugin(_q_zcut, _q_dcut_fctr, _q_exp_min, _q_exp_max, _q_rigidity, _q_truncation_fctr),
150  _debug(false),_first_time(true)
151 {
152  _djsum = 0.;
153  _delta_top = 1000000000000.0;
154  _pruned_mass = 0.;
155  _unfiltered_mass = 0.;
156  _top_candidate.reset(0., 0., 0., 0.);
157  _parts_size = 0;
159  _top_subs.clear();
160  _top_subjets.clear();
161  _top_hadrons.clear();
162  _top_parts.clear();
163  _qweight= -1.;
164 
165 }
std::vector< PseudoJet > _top_subs
std::vector< PseudoJet > _top_subjets
CLHEP::HepRandomEngine * _rnEngine
std::vector< PseudoJet > _top_hadrons
std::vector< PseudoJet > _top_parts
external::HEPTopTaggerV2_fixed_R::HEPTopTaggerV2_fixed_R ( fastjet::PseudoJet  jet)

Definition at line 167 of file HEPTopTaggerV2.cc.

167  : _do_qjets(false),
170  _mode(Mode(0)), _mtmass(172.3), _mwmass(80.4), _mtmin(150.), _mtmax(200.), _rmin(0.85*80.4/172.3), _rmax(1.15*80.4/172.3),
171  _m23cut(0.35), _m13cutmin(0.2), _m13cutmax(1.3), _minpt_tag(200.),
172  _nfilt(5), _Rfilt(0.3), _jet_algorithm_filter(fastjet::cambridge_algorithm), _minpt_subjet(0.),
173  _jet_algorithm_recluster(fastjet::cambridge_algorithm),
174  _zcut(0.1), _rcut_factor(0.5),
175  _q_zcut(0.1), _q_dcut_fctr(0.5), _q_exp_min(0.), _q_exp_max(0.), _q_rigidity(0.1), _q_truncation_fctr(0.0),
176  _fat(jet), _rnEngine(nullptr),
177  _debug(false),_first_time(true)
178 {}
CLHEP::HepRandomEngine * _rnEngine
external::HEPTopTaggerV2_fixed_R::HEPTopTaggerV2_fixed_R ( fastjet::PseudoJet  jet,
double  mtmass,
double  mwmass 
)

Definition at line 180 of file HEPTopTaggerV2.cc.

181  : _do_qjets(false),
184  _mode(Mode(0)), _mtmass(mtmass), _mwmass(mwmass), _rmin(0.85*80.4/172.3), _rmax(1.15*80.4/172.3),
185  _m23cut(0.35), _m13cutmin(0.2), _m13cutmax(1.3), _minpt_tag(200.),
186  _nfilt(5), _Rfilt(0.3), _jet_algorithm_filter(fastjet::cambridge_algorithm), _minpt_subjet(0.),
187  _jet_algorithm_recluster(fastjet::cambridge_algorithm),
188  _zcut(0.1), _rcut_factor(0.5),
189  _q_zcut(0.1), _q_dcut_fctr(0.5), _q_exp_min(0.), _q_exp_max(0.), _q_rigidity(0.1), _q_truncation_fctr(0.0),
190  _fat(jet), _rnEngine(nullptr),
191  _debug(false),_first_time(true)
192 {}
CLHEP::HepRandomEngine * _rnEngine

Member Function Documentation

const PseudoJet& external::HEPTopTaggerV2_fixed_R::b ( ) const
inline

Definition at line 93 of file HEPTopTaggerV2.h.

93 {return _top_subjets[0];}
std::vector< PseudoJet > _top_subjets
bool external::HEPTopTaggerV2_fixed_R::check_mass_criteria ( const std::vector< fastjet::PseudoJet > &  top_subs) const
private

Definition at line 102 of file HEPTopTaggerV2.cc.

References _m13cutmax, _m13cutmin, _m23cut, _rmax, _rmin, and funct::m.

Referenced by run().

102  {
103  bool is_passed = false;
104  double m12 = (top_subs[0] + top_subs[1]).m();
105  double m13 = (top_subs[0] + top_subs[2]).m();
106  double m23 = (top_subs[1] + top_subs[2]).m();
107  double m123 = (top_subs[0] + top_subs[1] + top_subs[2]).m();
108  double atan1312 = atan(m13/m12);
109  double m23_over_m123 = m23/m123;
110  double m23_over_m123_square = m23_over_m123 * m23_over_m123;
111  double rmin_square = _rmin * _rmin;
112  double rmax_square = _rmax * _rmax;
113  double m13m12_square_p1 = (1 + (m13/m12) * (m13/m12));
114  double m12m13_square_p1 = (1 + (m12/m13) * (m12/m13));
115  if (
116  (atan1312 > _m13cutmin && _m13cutmax > atan1312
117  && (m23_over_m123 > _rmin && _rmax > m23_over_m123))
118  ||
119  ((m23_over_m123_square < 1 - rmin_square * m13m12_square_p1)
120  &&
121  (m23_over_m123_square > 1 - rmax_square * m13m12_square_p1)
122  &&
123  (m23_over_m123 > _m23cut))
124  ||
125  ((m23_over_m123_square < 1 - rmin_square * m12m13_square_p1)
126  &&
127  (m23_over_m123_square > 1 - rmax_square * m12m13_square_p1)
128  &&
129  (m23_over_m123 > _m23cut))
130  ) {
131  is_passed = true;
132  }
133  return is_passed;
134 }
double external::HEPTopTaggerV2_fixed_R::delta_top ( ) const
inline

Definition at line 86 of file HEPTopTaggerV2.h.

double external::HEPTopTaggerV2_fixed_R::djademod ( const fastjet::PseudoJet &  subjet_i,
const fastjet::PseudoJet &  subjet_j,
const fastjet::PseudoJet &  ref 
)
private

Definition at line 37 of file HEPTopTaggerV2.cc.

References caloCompatibility_cff::delta_eta, caloCompatibility_cff::delta_phi, kinem::delta_R(), perp(), funct::pow(), and mathSSE::sqrt().

Referenced by run().

37  {
38  double dj = -1.0;
39  double delta_phi = subjet_i.delta_phi_to(subjet_j);
40  double delta_eta = subjet_i.eta() - subjet_j.eta();
41  double delta_R = sqrt(delta_eta * delta_eta + delta_phi * delta_phi);
42  dj = perp(subjet_i, ref) * perp(subjet_j, ref) * pow(delta_R, 4.);
43  return dj;
44 }
double perp(const PseudoJet &vec, const fastjet::PseudoJet &ref)
T sqrt(T t)
Definition: SSEVec.h:18
double delta_R(double eta1, double phi1, double eta2, double phi2)
Definition: AnglesUtil.h:106
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:40
double external::HEPTopTaggerV2_fixed_R::djsum ( ) const
inline

Definition at line 87 of file HEPTopTaggerV2.h.

Referenced by run().

void external::HEPTopTaggerV2_fixed_R::do_qjets ( bool  qjets)
inline

Definition at line 50 of file HEPTopTaggerV2.h.

double external::HEPTopTaggerV2_fixed_R::f_rec ( )

Definition at line 47 of file HEPTopTaggerV2.cc.

References _mtmass, _mwmass, _top_subs, funct::m, and min().

Referenced by external::HEPTopTaggerV2::optimalR_type().

47  {
48  double m12 = (_top_subs[0] + _top_subs[1]).m();
49  double m13 = (_top_subs[0] + _top_subs[2]).m();
50  double m23 = (_top_subs[1] + _top_subs[2]).m();
51  double m123 = (_top_subs[0] + _top_subs[1] + _top_subs[2]).m();
52 
53  double fw12 = fabs( (m12/m123) / (_mwmass/_mtmass) - 1);
54  double fw13 = fabs( (m13/m123) / (_mwmass/_mtmass) - 1);
55  double fw23 = fabs( (m23/m123) / (_mwmass/_mtmass) - 1);
56 
57  return std::min(fw12, std::min(fw13, fw23));
58 }
std::vector< PseudoJet > _top_subs
T min(T a, T b)
Definition: MathUtil.h:58
const PseudoJet& external::HEPTopTaggerV2_fixed_R::fat_initial ( )
inline
std::vector<PseudoJet> external::HEPTopTaggerV2_fixed_R::Filtering ( const std::vector< PseudoJet > &  top_constits,
const JetDefinition filtering_def 
)
private
void external::HEPTopTaggerV2_fixed_R::FindHardSubst ( const PseudoJet jet,
std::vector< fastjet::PseudoJet > &  t_parts 
)
private

Definition at line 61 of file HEPTopTaggerV2.cc.

References _mass_drop_threshold, _max_subjet_mass, and std::swap().

Referenced by run().

61  {
62  PseudoJet parent1(0, 0, 0, 0), parent2(0, 0, 0, 0);
63  if (this_jet.m() < _max_subjet_mass || !this_jet.validated_cs()->has_parents(this_jet, parent1, parent2)) {
64  t_parts.push_back(this_jet);
65  } else {
66  if (parent1.m() < parent2.m())
67  std::swap(parent1, parent2);
68  FindHardSubst(parent1, t_parts);
69  if (parent1.m() < _mass_drop_threshold * this_jet.m())
70  FindHardSubst(parent2, t_parts);
71  }
72 }
void FindHardSubst(const PseudoJet &jet, std::vector< fastjet::PseudoJet > &t_parts)
void swap(edm::DataFrameContainer &lhs, edm::DataFrameContainer &rhs)
void external::HEPTopTaggerV2_fixed_R::get_info ( ) const

Definition at line 363 of file HEPTopTaggerV2.cc.

References _delta_top, _djsum, _is_masscut_passed, _is_maybe_top, _is_ptmincut_passed, _parts_size, _top_candidate, and _top_hadrons.

363  {
364  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
365  edm::LogInfo("HEPTopTaggerV2") << "# HEPTopTaggerV2 Result" << std::endl;
366  edm::LogInfo("HEPTopTaggerV2") << "#" << std::endl;
367  edm::LogInfo("HEPTopTaggerV2") << "# is top candidate: " << _is_maybe_top << std::endl;
368  edm::LogInfo("HEPTopTaggerV2") << "# mass plane cuts passed: " << _is_masscut_passed << std::endl;
369  edm::LogInfo("HEPTopTaggerV2") << "# top candidate mass: " << _top_candidate.m() << std::endl;
370  edm::LogInfo("HEPTopTaggerV2") << "# top candidate (pt, eta, phi): ("
371  << _top_candidate.perp() << ", "
372  << _top_candidate.eta() << ", "
373  << _top_candidate.phi_std() << ")" << std::endl;
374  edm::LogInfo("HEPTopTaggerV2") << "# top hadrons: " << _top_hadrons.size() << std::endl;
375  edm::LogInfo("HEPTopTaggerV2") << "# hard substructures: " << _parts_size << std::endl;
376  edm::LogInfo("HEPTopTaggerV2") << "# |m - mtop| : " << _delta_top << std::endl;
377  edm::LogInfo("HEPTopTaggerV2") << "# djsum : " << _djsum << std::endl;
378  edm::LogInfo("HEPTopTaggerV2") << "# is consistency cut passed: " << _is_ptmincut_passed << std::endl;
379  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
380  return;
381 }
std::vector< PseudoJet > _top_hadrons
void external::HEPTopTaggerV2_fixed_R::get_setting ( ) const

Definition at line 383 of file HEPTopTaggerV2.cc.

References _jet_algorithm_filter, _jet_algorithm_recluster, _m13cutmax, _m13cutmin, _m23cut, _mass_drop_threshold, _max_subjet_mass, _minpt_subjet, _minpt_tag, _mode, _mtmass, _mtmax, _mtmin, _mwmass, _nfilt, _Rfilt, _rmax, and _rmin.

383  {
384  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
385  edm::LogInfo("HEPTopTaggerV2") << "# HEPTopTaggerV2 Settings" << std::endl;
386  edm::LogInfo("HEPTopTaggerV2") << "#" << std::endl;
387  edm::LogInfo("HEPTopTaggerV2") << "# mode: " << _mode << " (0 = EARLY_MASSRATIO_SORT_MASS) " << std::endl;
388  edm::LogInfo("HEPTopTaggerV2") << "# " << " (1 = LATE_MASSRATIO_SORT_MASS) " << std::endl;
389  edm::LogInfo("HEPTopTaggerV2") << "# " << " (2 = EARLY_MASSRATIO_SORT_MODDJADE) " << std::endl;
390  edm::LogInfo("HEPTopTaggerV2") << "# " << " (3 = LATE_MASSRATIO_SORT_MODDJADE) " << std::endl;
391  edm::LogInfo("HEPTopTaggerV2") << "# " << " (4 = TWO_STEP_FILTER) " << std::endl;
392  edm::LogInfo("HEPTopTaggerV2") << "# top mass: " << _mtmass << " ";
393  edm::LogInfo("HEPTopTaggerV2") << "W mass: " << _mwmass << std::endl;
394  edm::LogInfo("HEPTopTaggerV2") << "# top mass window: [" << _mtmin << ", " << _mtmax << "]" << std::endl;
395  edm::LogInfo("HEPTopTaggerV2") << "# W mass ratio: [" << _rmin << ", " << _rmax << "] (["
396  <<_rmin*_mtmass/_mwmass<< "%, "<< _rmax*_mtmass/_mwmass << "%])"<< std::endl;
397  edm::LogInfo("HEPTopTaggerV2") << "# mass plane cuts: (m23cut, m13min, m13max) = ("
398  << _m23cut << ", " << _m13cutmin << ", " << _m13cutmax << ")" << std::endl;
399  edm::LogInfo("HEPTopTaggerV2") << "# mass_drop_threshold: " << _mass_drop_threshold << " ";
400  edm::LogInfo("HEPTopTaggerV2") << "max_subjet_mass: " << _max_subjet_mass << std::endl;
401  edm::LogInfo("HEPTopTaggerV2") << "# R_filt: " << _Rfilt << " ";
402  edm::LogInfo("HEPTopTaggerV2") << "n_filt: " << _nfilt << std::endl;
403  edm::LogInfo("HEPTopTaggerV2") << "# minimal subjet pt: " << _minpt_subjet << std::endl;
404  edm::LogInfo("HEPTopTaggerV2") << "# minimal reconstructed pt: " << _minpt_tag << std::endl;
405  edm::LogInfo("HEPTopTaggerV2") << "# internal jet algorithms (0 = kt, 1 = C/A, 2 = anti-kt): " << std::endl;
406  edm::LogInfo("HEPTopTaggerV2") << "# filtering: "<< _jet_algorithm_filter << std::endl;
407  edm::LogInfo("HEPTopTaggerV2") << "# reclustering: "<< _jet_algorithm_recluster << std::endl;
408  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
409 
410  return;
411 }
const std::vector<PseudoJet>& external::HEPTopTaggerV2_fixed_R::hardparts ( ) const
inline

Definition at line 102 of file HEPTopTaggerV2.h.

102 {return _top_parts;}
std::vector< PseudoJet > _top_parts
bool external::HEPTopTaggerV2_fixed_R::is_masscut_passed ( ) const
inline

Definition at line 82 of file HEPTopTaggerV2.h.

bool external::HEPTopTaggerV2_fixed_R::is_maybe_top ( ) const
inline

Definition at line 81 of file HEPTopTaggerV2.h.

bool external::HEPTopTaggerV2_fixed_R::is_minptcut_passed ( ) const
inline

Definition at line 83 of file HEPTopTaggerV2.h.

bool external::HEPTopTaggerV2_fixed_R::is_tagged ( ) const
inline
const PseudoJet& external::HEPTopTaggerV2_fixed_R::j1 ( ) const
inline

Definition at line 98 of file HEPTopTaggerV2.h.

98 {return _top_subs[0];}
std::vector< PseudoJet > _top_subs
const PseudoJet& external::HEPTopTaggerV2_fixed_R::j2 ( ) const
inline

Definition at line 99 of file HEPTopTaggerV2.h.

99 {return _top_subs[1];}
std::vector< PseudoJet > _top_subs
const PseudoJet& external::HEPTopTaggerV2_fixed_R::j3 ( ) const
inline

Definition at line 100 of file HEPTopTaggerV2.h.

100 {return _top_subs[2];}
std::vector< PseudoJet > _top_subs
double external::HEPTopTaggerV2_fixed_R::nsub ( fastjet::PseudoJet  jet,
int  order,
fastjet::contrib::Njettiness::AxesMode  axes = fastjet::contrib::Njettiness::kt_axes,
double  beta = 1.,
double  R0 = 1. 
)

Definition at line 136 of file HEPTopTaggerV2.cc.

136  {
137  fastjet::contrib::Nsubjettiness nsub(order, axes, beta, R0);
138  return nsub.result(jet);
139 }
double nsub(fastjet::PseudoJet jet, int order, fastjet::contrib::Njettiness::AxesMode axes=fastjet::contrib::Njettiness::kt_axes, double beta=1., double R0=1.)
double external::HEPTopTaggerV2_fixed_R::perp ( const PseudoJet vec,
const fastjet::PseudoJet &  ref 
)
private

Definition at line 25 of file HEPTopTaggerV2.cc.

References mathSSE::sqrt().

Referenced by djademod(), and run().

25  {
26  double ref_ref = ref.px() * ref.px() + ref.py() * ref.py() + ref.pz() * ref.pz();
27  double vec_ref = vec.px() * ref.px() + vec.py() * ref.py() + vec.pz() * ref.pz();
28  double per_per = vec.px() * vec.px() + vec.py() * vec.py() + vec.pz() * vec.pz();
29  if (ref_ref > 0.)
30  per_per -= vec_ref * vec_ref / ref_ref;
31  if (per_per < 0.)
32  per_per = 0.;
33  return sqrt(per_per);
34 }
T sqrt(T t)
Definition: SSEVec.h:18
void external::HEPTopTaggerV2_fixed_R::print_banner ( )
private

Definition at line 11 of file HEPTopTaggerV2.cc.

References _first_time.

Referenced by run().

11  {
12  if (!_first_time) {return;}
13  _first_time = false;
14 
15 
16  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
17  edm::LogInfo("HEPTopTaggerV2") << "# HEPTopTaggerV2 - under construction \n";
18  edm::LogInfo("HEPTopTaggerV2") << "# \n";
19  edm::LogInfo("HEPTopTaggerV2") << "# Please cite JHEP 1010 (2010) 078 [arXiv:1006.2833 [hep-ph]] \n";
20  edm::LogInfo("HEPTopTaggerV2") << "# and Phys.Rev. D89 (2014) 074047 [arXiv:1312.1504 [hep-ph]] \n";
21  edm::LogInfo("HEPTopTaggerV2") << "#--------------------------------------------------------------------------\n";
22 }
double external::HEPTopTaggerV2_fixed_R::pruned_mass ( ) const
inline

Definition at line 88 of file HEPTopTaggerV2.h.

double external::HEPTopTaggerV2_fixed_R::q_weight ( )
inline

Definition at line 109 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::run ( )

Definition at line 194 of file HEPTopTaggerV2.cc.

References _debug, _delta_top, _djsum, _do_qjets, _fat, _initial_jet, _is_masscut_passed, _is_maybe_top, _is_ptmincut_passed, _jet, _jet_algorithm_filter, _jet_algorithm_recluster, _minpt_subjet, _minpt_tag, _mode, _mtmass, _mtmax, _mtmin, _nfilt, _parts_size, _pruned_mass, _q_dcut_fctr, _q_exp_max, _q_exp_min, _q_rigidity, _q_truncation_fctr, _q_zcut, _qjet_def, _qweight, _rcut_factor, _Rfilt, _rnEngine, _top_candidate, _top_hadrons, _top_parts, _top_subjets, _top_subs, _unfiltered_mass, _zcut, check_mass_criteria(), djademod(), djsum(), external::EARLY_MASSRATIO_SORT_MASS, external::EARLY_MASSRATIO_SORT_MODDJADE, ALCARECOTkAlBeamHalo_cff::filter, FindHardSubst(), join(), GetRecoTauVFromDQM_MC_cff::kk, external::LATE_MASSRATIO_SORT_MASS, external::LATE_MASSRATIO_SORT_MODDJADE, min(), perp(), print_banner(), findQualityFiles::rr, QjetsPlugin::SetRNEngine(), mathSSE::sqrt(), store_topsubjets(), external::TWO_STEP_FILTER, and QjetsBaseExtras::weight().

Referenced by external::HEPTopTaggerV2::run().

194  {
195  print_banner();
196 
201  && (_mode != TWO_STEP_FILTER) ) {
202  edm::LogError("HEPTopTaggerV2") << "ERROR: UNKNOWN MODE" << std::endl;
203  return;
204  }
205 
206  //Qjets
208  _qjet_def = fastjet::JetDefinition(&_qjet_plugin);
209  _qweight=-1;
210  vector<fastjet::PseudoJet> _q_constits;
211  ClusterSequence* _qjet_seq;
212  PseudoJet _qjet;
213  if (_do_qjets){
214  _q_constits = _initial_jet.associated_cluster_sequence()->constituents(_initial_jet);
215  _qjet_seq = new ClusterSequence(_q_constits, _qjet_def);
216  _qjet = sorted_by_pt(_qjet_seq->inclusive_jets())[0];
217  _qjet_seq->delete_self_when_unused();
218  const QjetsBaseExtras* ext =
219  dynamic_cast<const QjetsBaseExtras*>(_qjet_seq->extras());
220  _qweight=ext->weight();
221  _jet = _qjet;
222  _fat = _qjet;
223  _qjet_plugin.SetRNEngine(_rnEngine);
224  }
225 
226  //initialization
227  _djsum = 0.;
228  _delta_top = 1000000000000.0;
229  _pruned_mass = 0.;
230  _unfiltered_mass = 0.;
231  _top_candidate.reset(0., 0., 0., 0.);
232  _parts_size = 0;
234  _top_subs.clear();
235  _top_subjets.clear();
236  _top_hadrons.clear();
237  _top_parts.clear();
238 
239  //find hard substructures
241 
242  if (_top_parts.size() < 3) {
243  if (_debug) {edm::LogInfo("HEPTopTaggerV2") << "< 3 hard substructures " << std::endl;}
244  return; //such events are not interesting
245  }
246 
247  // Sort subjets-after-unclustering by pT.
248  // Necessary so that two-step-filtering can use the leading-three.
249  _top_parts=sorted_by_pt(_top_parts);
250 
251  // loop over triples
252  _top_parts = sorted_by_pt(_top_parts);
253  for (unsigned rr = 0; rr < _top_parts.size(); rr++) {
254  for (unsigned ll = rr + 1; ll < _top_parts.size(); ll++) {
255  for (unsigned kk = ll + 1; kk < _top_parts.size(); kk++) {
256 
257  // two-step filtering
258  // This means that we only look at the triplet formed by the
259  // three leading-in-pT subjets-after-unclustering.
260  if((_mode==TWO_STEP_FILTER) && rr>0)
261  continue;
262  if((_mode==TWO_STEP_FILTER) && ll>1)
263  continue;
264  if((_mode==TWO_STEP_FILTER) && kk>2)
265  continue;
266 
267  //pick triple
268  PseudoJet triple = join(_top_parts[rr], _top_parts[ll], _top_parts[kk]);
269 
270  //filtering
271  double filt_top_R
272  = std::min(_Rfilt, 0.5*sqrt(std::min(_top_parts[kk].squared_distance(_top_parts[ll]),
273  std::min(_top_parts[rr].squared_distance(_top_parts[ll]),
274  _top_parts[kk].squared_distance(_top_parts[rr])))));
275  JetDefinition filtering_def(_jet_algorithm_filter, filt_top_R);
276  fastjet::Filter filter(filtering_def, fastjet::SelectorNHardest(_nfilt) * fastjet::SelectorPtMin(_minpt_subjet));
277  PseudoJet topcandidate = filter(triple);
278 
279  //mass window cut
280  if (topcandidate.m() < _mtmin || _mtmax < topcandidate.m()) continue;
281 
282  // Sanity cut: can't recluster less than 3 objects into three subjets
283  if (topcandidate.pieces().size() < 3)
284  continue;
285 
286  // Recluster to 3 subjets and apply mass plane cuts
287  JetDefinition reclustering(_jet_algorithm_recluster, 3.14);
288  ClusterSequence * cs_top_sub = new ClusterSequence(topcandidate.constituents(), reclustering);
289  std::vector <PseudoJet> top_subs = sorted_by_pt(cs_top_sub->exclusive_jets(3));
290  cs_top_sub->delete_self_when_unused();
291 
292  // Require the third subjet to be above the pT threshold
293  if (top_subs[2].perp() < _minpt_subjet)
294  continue;
295 
296  // Modes with early 2d-massplane cuts
297  if (_mode == EARLY_MASSRATIO_SORT_MASS && !check_mass_criteria(top_subs)) {continue;}
298  if (_mode == EARLY_MASSRATIO_SORT_MODDJADE && !check_mass_criteria(top_subs)) {continue;}
299 
300  //is this candidate better than the other? -> update
301  double deltatop = fabs(topcandidate.m() - _mtmass);
302  double djsum = djademod(top_subs[0], top_subs[1], topcandidate)
303  + djademod(top_subs[0], top_subs[2], topcandidate)
304  + djademod(top_subs[1], top_subs[2], topcandidate);
305  bool better = false;
306 
307  // Modes 0 and 1 sort by top mass
310  if (deltatop < _delta_top)
311  better = true;
312  }
313  // Modes 2 and 3 sort by modified jade distance
314  else if ( (_mode == EARLY_MASSRATIO_SORT_MODDJADE)
316  if (djsum > _djsum)
317  better = true;
318  }
319  // Mode 4 is the two-step filtering. No sorting necessary as
320  // we just look at the triplet of highest pT objects after
321  // unclustering
322  else if (_mode == TWO_STEP_FILTER) {
323  better = true;
324  }
325  else {
326  edm::LogError("HEPTopTaggerV2") << "ERROR: UNKNOWN MODE (IN DISTANCE MEASURE SELECTION)" << std::endl;
327  return;
328  }
329 
330  if (better) {
331  _djsum = djsum;
332  _delta_top = deltatop;
333  _is_maybe_top = true;
334  _top_candidate = topcandidate;
335  _top_subs = top_subs;
336  store_topsubjets(top_subs);
337  _top_hadrons = topcandidate.constituents();
338  // Pruning
339  double _Rprun = _initial_jet.validated_cluster_sequence()->jet_def().R();
340  JetDefinition jet_def_prune(fastjet::cambridge_algorithm, _Rprun);
341  fastjet::Pruner pruner(jet_def_prune, _zcut, _rcut_factor);
342  PseudoJet prunedjet = pruner(triple);
343  _pruned_mass = prunedjet.m();
344  _unfiltered_mass = triple.m();
345 
346  //are all criteria fulfilled?
347  _is_masscut_passed = false;
348  if (check_mass_criteria(top_subs)) {
349  _is_masscut_passed = true;
350  }
351  _is_ptmincut_passed = false;
352  if (_top_candidate.pt() > _minpt_tag) {
353  _is_ptmincut_passed = true;
354  }
355  }//end better
356  }//end kk
357  }//end ll
358  }//end rr
359 
360  return;
361 }
std::vector< PseudoJet > _top_subs
std::vector< PseudoJet > _top_subjets
double perp(const PseudoJet &vec, const fastjet::PseudoJet &ref)
CLHEP::HepRandomEngine * _rnEngine
std::vector< PseudoJet > _top_hadrons
bool check_mass_criteria(const std::vector< fastjet::PseudoJet > &top_subs) const
void store_topsubjets(const std::vector< PseudoJet > &top_subs)
void FindHardSubst(const PseudoJet &jet, std::vector< fastjet::PseudoJet > &t_parts)
T sqrt(T t)
Definition: SSEVec.h:18
double djademod(const fastjet::PseudoJet &subjet_i, const fastjet::PseudoJet &subjet_j, const fastjet::PseudoJet &ref)
T min(T a, T b)
Definition: MathUtil.h:58
fastjet::ClusterSequence ClusterSequence
static std::string join(char **cmd)
Definition: RemoteFile.cc:18
cms::Filter Filter
std::vector< PseudoJet > _top_parts
fastjet::JetDefinition JetDefinition
Definition: memstream.h:15
virtual double weight() const
Definition: Qjets.h:73
void external::HEPTopTaggerV2_fixed_R::set_debug ( bool  debug)
inline

Definition at line 74 of file HEPTopTaggerV2.h.

References debug.

Referenced by external::HEPTopTaggerV2::run().

74 {_debug = debug;}
#define debug
Definition: HDRShower.cc:19
void external::HEPTopTaggerV2_fixed_R::set_filtering_jetalgorithm ( JetAlgorithm  jet_algorithm)
inline

Definition at line 58 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

58 {_jet_algorithm_filter = jet_algorithm;}
void external::HEPTopTaggerV2_fixed_R::set_filtering_minpt_subjet ( double  x)
inline
void external::HEPTopTaggerV2_fixed_R::set_filtering_n ( unsigned  nfilt)
inline

Definition at line 55 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

55 {_nfilt = nfilt;}
void external::HEPTopTaggerV2_fixed_R::set_filtering_R ( double  Rfilt)
inline

Definition at line 56 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_fw ( double  fw)
inline
void external::HEPTopTaggerV2_fixed_R::set_mass_drop_threshold ( double  x)
inline
void external::HEPTopTaggerV2_fixed_R::set_mass_ratio_cut ( double  m23cut,
double  m13cutmin,
double  m13cutmax 
)
inline

Definition at line 68 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_mass_ratio_range ( double  rmin,
double  rmax 
)
inline

Definition at line 67 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_max_subjet_mass ( double  x)
inline
void external::HEPTopTaggerV2_fixed_R::set_mode ( enum Mode  mode)
inline
void external::HEPTopTaggerV2_fixed_R::set_mt ( double  x)
inline

Definition at line 63 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_mw ( double  x)
inline

Definition at line 64 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_pruning_rcut_factor ( double  rcut_factor)
inline
void external::HEPTopTaggerV2_fixed_R::set_pruning_zcut ( double  zcut)
inline
void external::HEPTopTaggerV2_fixed_R::set_qjets ( double  q_zcut,
double  q_dcut_fctr,
double  q_exp_min,
double  q_exp_max,
double  q_rigidity,
double  q_truncation_fctr 
)
inline

Definition at line 75 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

void external::HEPTopTaggerV2_fixed_R::set_qjets_rng ( CLHEP::HepRandomEngine *  engine)
inline

Definition at line 78 of file HEPTopTaggerV2.h.

78 { _rnEngine = engine;}
CLHEP::HepRandomEngine * _rnEngine
void external::HEPTopTaggerV2_fixed_R::set_reclustering_jetalgorithm ( JetAlgorithm  jet_algorithm)
inline

Definition at line 60 of file HEPTopTaggerV2.h.

Referenced by external::HEPTopTaggerV2::run().

60 {_jet_algorithm_recluster = jet_algorithm;}
void external::HEPTopTaggerV2_fixed_R::set_top_mass_range ( double  xmin,
double  xmax 
)
inline
void external::HEPTopTaggerV2_fixed_R::set_top_minpt ( double  x)
inline
void external::HEPTopTaggerV2_fixed_R::store_topsubjets ( const std::vector< PseudoJet > &  top_subs)
private

Definition at line 75 of file HEPTopTaggerV2.cc.

References _mwmass, _top_subjets, _W, and funct::m.

Referenced by run().

75  {
76  _top_subjets.resize(0);
77  double m12 = (top_subs[0] + top_subs[1]).m();
78  double m13 = (top_subs[0] + top_subs[2]).m();
79  double m23 = (top_subs[1] + top_subs[2]).m();
80  double dm12 = fabs(m12 - _mwmass);
81  double dm13 = fabs(m13 - _mwmass);
82  double dm23 = fabs(m23 - _mwmass);
83 
84  if (dm23 <= dm12 && dm23 <= dm13) {
85  _top_subjets.push_back(top_subs[0]);
86  _top_subjets.push_back(top_subs[1]);
87  _top_subjets.push_back(top_subs[2]);
88  } else if (dm13 <= dm12 && dm13 < dm23) {
89  _top_subjets.push_back(top_subs[1]);
90  _top_subjets.push_back(top_subs[0]);
91  _top_subjets.push_back(top_subs[2]);
92  } else if (dm12 < dm23 && dm12 < dm13) {
93  _top_subjets.push_back(top_subs[2]);
94  _top_subjets.push_back(top_subs[0]);
95  _top_subjets.push_back(top_subs[1]);
96  }
97  _W = _top_subjets[1] + _top_subjets[2];
98  return;
99 }
std::vector< PseudoJet > _top_subjets
const PseudoJet& external::HEPTopTaggerV2_fixed_R::t ( ) const
inline
const std::vector<PseudoJet>& external::HEPTopTaggerV2_fixed_R::top_hadrons ( ) const
inline

Definition at line 101 of file HEPTopTaggerV2.h.

101 {return _top_hadrons;}
std::vector< PseudoJet > _top_hadrons
const std::vector<PseudoJet>& external::HEPTopTaggerV2_fixed_R::top_subjets ( ) const
inline

Definition at line 97 of file HEPTopTaggerV2.h.

97 {return _top_subjets;}
std::vector< PseudoJet > _top_subjets
double external::HEPTopTaggerV2_fixed_R::unfiltered_mass ( ) const
inline

Definition at line 89 of file HEPTopTaggerV2.h.

const PseudoJet& external::HEPTopTaggerV2_fixed_R::W ( ) const
inline

Definition at line 94 of file HEPTopTaggerV2.h.

94 {return _W;}
const PseudoJet& external::HEPTopTaggerV2_fixed_R::W1 ( ) const
inline

Definition at line 95 of file HEPTopTaggerV2.h.

95 {return _top_subjets[1];}
std::vector< PseudoJet > _top_subjets
const PseudoJet& external::HEPTopTaggerV2_fixed_R::W2 ( ) const
inline

Definition at line 96 of file HEPTopTaggerV2.h.

96 {return _top_subjets[2];}
std::vector< PseudoJet > _top_subjets

Member Data Documentation

bool external::HEPTopTaggerV2_fixed_R::_debug
private
double external::HEPTopTaggerV2_fixed_R::_delta_top
private

Definition at line 150 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

double external::HEPTopTaggerV2_fixed_R::_djsum
private

Definition at line 151 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

bool external::HEPTopTaggerV2_fixed_R::_do_qjets
private

Definition at line 112 of file HEPTopTaggerV2.h.

Referenced by run().

PseudoJet external::HEPTopTaggerV2_fixed_R::_fat
private

Definition at line 140 of file HEPTopTaggerV2.h.

Referenced by run().

bool external::HEPTopTaggerV2_fixed_R::_first_time
private

Definition at line 166 of file HEPTopTaggerV2.h.

Referenced by print_banner().

double external::HEPTopTaggerV2_fixed_R::_fw
private

Definition at line 156 of file HEPTopTaggerV2.h.

PseudoJet external::HEPTopTaggerV2_fixed_R::_initial_jet
private

Definition at line 115 of file HEPTopTaggerV2.h.

Referenced by run().

bool external::HEPTopTaggerV2_fixed_R::_is_masscut_passed
private

Definition at line 146 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

bool external::HEPTopTaggerV2_fixed_R::_is_maybe_top
private

Definition at line 148 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

bool external::HEPTopTaggerV2_fixed_R::_is_ptmincut_passed
private

Definition at line 147 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

PseudoJet external::HEPTopTaggerV2_fixed_R::_jet
private

Definition at line 114 of file HEPTopTaggerV2.h.

Referenced by run().

JetAlgorithm external::HEPTopTaggerV2_fixed_R::_jet_algorithm_filter
private

Definition at line 129 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

JetAlgorithm external::HEPTopTaggerV2_fixed_R::_jet_algorithm_recluster
private

Definition at line 132 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_m13cutmax
private

Definition at line 124 of file HEPTopTaggerV2.h.

Referenced by check_mass_criteria(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_m13cutmin
private

Definition at line 124 of file HEPTopTaggerV2.h.

Referenced by check_mass_criteria(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_m23cut
private

Definition at line 124 of file HEPTopTaggerV2.h.

Referenced by check_mass_criteria(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_mass_drop_threshold
private

Definition at line 117 of file HEPTopTaggerV2.h.

Referenced by FindHardSubst(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_max_subjet_mass
private

Definition at line 118 of file HEPTopTaggerV2.h.

Referenced by FindHardSubst(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_minpt_subjet
private

Definition at line 130 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_minpt_tag
private

Definition at line 125 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

Mode external::HEPTopTaggerV2_fixed_R::_mode
private

Definition at line 120 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_mtmass
private

Definition at line 121 of file HEPTopTaggerV2.h.

Referenced by f_rec(), get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_mtmax
private

Definition at line 122 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_mtmin
private

Definition at line 122 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_mwmass
private

Definition at line 121 of file HEPTopTaggerV2.h.

Referenced by f_rec(), get_setting(), and store_topsubjets().

unsigned external::HEPTopTaggerV2_fixed_R::_nfilt
private

Definition at line 127 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

unsigned external::HEPTopTaggerV2_fixed_R::_parts_size
private

Definition at line 157 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

double external::HEPTopTaggerV2_fixed_R::_pruned_mass
private

Definition at line 153 of file HEPTopTaggerV2.h.

Referenced by HEPTopTaggerV2_fixed_R(), and run().

double external::HEPTopTaggerV2_fixed_R::_q_dcut_fctr
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_q_exp_max
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_q_exp_min
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_q_rigidity
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_q_truncation_fctr
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_q_zcut
private

Definition at line 137 of file HEPTopTaggerV2.h.

Referenced by run().

JetDefinition external::HEPTopTaggerV2_fixed_R::_qjet_def
private

Definition at line 138 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_qweight
private

Definition at line 167 of file HEPTopTaggerV2.h.

Referenced by HEPTopTaggerV2_fixed_R(), and run().

double external::HEPTopTaggerV2_fixed_R::_rcut_factor
private

Definition at line 135 of file HEPTopTaggerV2.h.

Referenced by run().

double external::HEPTopTaggerV2_fixed_R::_Rfilt
private

Definition at line 128 of file HEPTopTaggerV2.h.

Referenced by get_setting(), and run().

double external::HEPTopTaggerV2_fixed_R::_rmax
private

Definition at line 123 of file HEPTopTaggerV2.h.

Referenced by check_mass_criteria(), and get_setting().

double external::HEPTopTaggerV2_fixed_R::_rmin
private

Definition at line 123 of file HEPTopTaggerV2.h.

Referenced by check_mass_criteria(), and get_setting().

CLHEP::HepRandomEngine* external::HEPTopTaggerV2_fixed_R::_rnEngine
private

Definition at line 142 of file HEPTopTaggerV2.h.

Referenced by run().

PseudoJet external::HEPTopTaggerV2_fixed_R::_top_candidate
private

Definition at line 159 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

std::vector<PseudoJet> external::HEPTopTaggerV2_fixed_R::_top_hadrons
private

Definition at line 163 of file HEPTopTaggerV2.h.

Referenced by get_info(), HEPTopTaggerV2_fixed_R(), and run().

std::vector<PseudoJet> external::HEPTopTaggerV2_fixed_R::_top_parts
private

Definition at line 164 of file HEPTopTaggerV2.h.

Referenced by HEPTopTaggerV2_fixed_R(), and run().

std::vector<PseudoJet> external::HEPTopTaggerV2_fixed_R::_top_subjets
private

Definition at line 162 of file HEPTopTaggerV2.h.

Referenced by HEPTopTaggerV2_fixed_R(), run(), and store_topsubjets().

std::vector<PseudoJet> external::HEPTopTaggerV2_fixed_R::_top_subs
private

Definition at line 161 of file HEPTopTaggerV2.h.

Referenced by f_rec(), HEPTopTaggerV2_fixed_R(), and run().

double external::HEPTopTaggerV2_fixed_R::_unfiltered_mass
private

Definition at line 154 of file HEPTopTaggerV2.h.

Referenced by HEPTopTaggerV2_fixed_R(), and run().

PseudoJet external::HEPTopTaggerV2_fixed_R::_W
private

Definition at line 160 of file HEPTopTaggerV2.h.

Referenced by store_topsubjets().

double external::HEPTopTaggerV2_fixed_R::_zcut
private

Definition at line 134 of file HEPTopTaggerV2.h.

Referenced by run().