KLFitter
v1.3.2
Documentation of the KLFitter library -- The Kinematic Likelihood Fitter
|
A class implementing a likelihood for the SgTop Wt -> lepton+jets channel. More...
#include <LikelihoodSgTopWtLJ.h>
Public Member Functions | |
Constructors and destructors | |
LikelihoodSgTopWtLJ () | |
The default constructor. | |
~LikelihoodSgTopWtLJ () | |
The (defaulted) destructor. | |
Member functions (Get) | |
TLorentzVector * | GetLepton (KLFitter::Particles *particles) |
Get a pointer to the lepton in a particles object, depending on value of fTypeLepton. More... | |
int | GetLeptonType () |
Return the lepton type. More... | |
bool | GetHadronicTop () |
Return the top decay hypothesis. More... | |
Member functions (BAT) | |
void | DefineParameters () override |
Define the parameters of the fit. | |
double | LogLikelihood (const std::vector< double > ¶meters) override |
The posterior probability definition, overloaded from BCModel. More... | |
std::vector< double > | GetInitialParameters () override |
Get initial values for the parameters. More... | |
std::vector< double > | LogLikelihoodComponents (std::vector< double >) override |
Dummy reimplementation from the abstract base class. | |
![]() | |
LikelihoodBase (Particles **particles=0) | |
The default constructor. More... | |
virtual | ~LikelihoodBase () |
The default destructor. | |
KLFitter::PhysicsConstants * | PhysicsConstants () |
Return the table of physics constants. More... | |
KLFitter::DetectorBase * | Detector () |
Return the detector. More... | |
KLFitter::Particles ** | PParticlesPermuted () |
Return the set of measured particles. More... | |
KLFitter::Particles * | ParticlesModel () |
Return the set of model particles. More... | |
int | NParticlesModel () |
Return the number of model particles. More... | |
int | NParameters () |
Return the number of parameters. More... | |
double | ParMin (int index) |
Return the lower boundary of a parameter. More... | |
double | ParMax (int index) |
Return the upper boundary of a parameter. More... | |
BtaggingMethod | GetBTagging () |
Get flag to use b-tagging or not. More... | |
bool | FlagIntegrate () |
int | SetPhysicsConstants (KLFitter::PhysicsConstants *physicsconstants) |
Set the physics constants. More... | |
virtual int | SetDetector (KLFitter::DetectorBase **detector) |
Set the detector. More... | |
int | SetParticlesPermuted (KLFitter::Particles **particles) |
Set the measured particles. More... | |
int | SetPermutations (std::unique_ptr< KLFitter::Permutations > *permutations) |
Set the permutation object. More... | |
int | SetParameterRange (int index, double parmin, double parmax) |
Set the range of a model parameter. More... | |
int | SetInitialParameters (std::vector< double > const ¶meters) |
Set the initial values for the minimization, etc. More... | |
int | SetInitialParametersNChains (std::vector< double > const ¶meters, unsigned int nchains) |
Set the initial values for the minimization, etc. More... | |
int | SetBTagging (BtaggingMethod btagmethod) |
Set which b-tagging you wish to use. More... | |
int | SetFlagBTagging (bool flag) |
THIS IS AN OUTDATED METHOD - JUST HERE FOR BACKWARD COMPATIBILITY. More... | |
int | SetFlagIsNan (bool flag) |
Set flag FlagIsNan. More... | |
bool | GetFlagIsNan (void) |
Get flag FlagIsNan. More... | |
int | SetFlagIntegrate (bool flag) |
Set flag to integrate or not. More... | |
void | SetFlagUseJetMass (bool flag) |
Set flag to use measured jet masses (true) instead of parton masses (false);. | |
void | PropagateBTaggingInformation () |
Propagate the b-tagging information from the permuted (measured) particles to the model particles. | |
virtual double | LogAPrioriProbability (const std::vector< double > &) override |
The prior probability definition, overloaded from BCModel. More... | |
virtual double | LogEventProbability () |
Return the log of the event probability fof the current combination. More... | |
virtual double | LogEventProbabilityBTag () |
Return the contribution from b tagging to the log of the event probability for the current combination. More... | |
virtual int | RemoveForbiddenParticlePermutations () |
Remove forbidden particle permutations. More... | |
virtual bool | NoTFProblem (std::vector< double > parameters) |
Check if there are TF problems. More... | |
std::vector< double > | GetBestFitParameters () |
Returns the best fit parameters, overloaded from BCModel. More... | |
std::vector< double > | GetBestFitParameterErrors () |
Returns the errors of the best fit parameters, overloaded from BCModel. More... | |
double | GetBestFitParameter (unsigned int index) |
Returns the best fit parameters, overloaded from BCModel. More... | |
double | GetBestFitParameterError (unsigned int index) |
Returns the errors of the best fit parameter i, overloaded from BCModel. More... | |
virtual int | LHInvariantPermutationPartner (int, int, int *, int *) |
Check if the permutation is LH invariant. More... | |
int | GetParametersFromCache (int iperm) |
Write parameters from fCachedParametersVector.at(iperm) to fCachedParameters. More... | |
int | SetParametersToCache (int iperm, int nperms) |
Write parameters to fCachedParametersVector.at(iperm) from GetBestFitParameter() More... | |
double | GetIntegral () |
int | ResetCache () |
Resets the values of all parameter cache vectors. More... | |
Protected Member Functions | |
std::vector< double > | GetNeutrinoPzSolutions () |
Calculates the neutrino pz solutions from the measured values and the W mass. More... | |
int | SavePermutedParticles () override |
Save permuted particles. | |
int | SaveResolutionFunctions () override |
Save resolution functions. | |
Member functions (misc) | |
int | CalculateLorentzVectors (const std::vector< double > ¶meters) override |
Update 4-vectors of model particles. More... | |
int | Initialize () override |
Initialize the likelihood for the event. | |
int | AdjustParameterRanges () override |
Adjust parameter ranges. | |
int | DefineModelParticles () override |
Define the model particles. More... | |
int | RemoveInvariantParticlePermutations () override |
Remove invariant particle permutations. More... | |
int | BuildModelParticles () override |
Build the model particles from the best fit parameters. More... | |
![]() | |
double | SetPartonMass (double jetmass, double quarkmass, double *px, double *py, double *pz, double e) |
Set model parton mass according to fFlagUseJetMass. More... | |
Protected Attributes | |
bool | fHadronicTop |
A flag for associating either the hadronic (true) or the leponic (false) leg of the event to the top quark for likelihood calculation. | |
double | ETmiss_x |
The values of the x component of the missing ET. | |
double | ETmiss_y |
The values of the y component of the missing ET. | |
double | SumET |
The values of the total scalar ET. | |
int | fTypeLepton |
An index deciding if the event is electron (1) or muon (2) plus jets. | |
ResolutionBase * | fResEnergyB |
Save resolution functions since the eta of the partons is not fitted. | |
ResolutionBase * | fResEnergyLQ1 |
ResolutionBase * | fResEnergyLQ2 |
ResolutionBase * | fResLepton |
ResolutionBase * | fResMET |
double | b_meas_e |
Save measured particle values for frequent calls. | |
double | b_meas_p |
double | b_meas_m |
double | b_meas_deteta |
double | b_meas_eta |
double | b_meas_phi |
double | b_meas_px |
double | b_meas_py |
double | b_meas_pz |
double | lq1_meas_e |
double | lq1_meas_p |
double | lq1_meas_m |
double | lq1_meas_deteta |
double | lq1_meas_eta |
double | lq1_meas_phi |
double | lq1_meas_px |
double | lq1_meas_py |
double | lq1_meas_pz |
double | lq2_meas_e |
double | lq2_meas_p |
double | lq2_meas_m |
double | lq2_meas_deteta |
double | lq2_meas_eta |
double | lq2_meas_phi |
double | lq2_meas_px |
double | lq2_meas_py |
double | lq2_meas_pz |
double | lep_meas_e |
double | lep_meas_deteta |
double | lep_meas_sintheta |
double | lep_meas_pt |
double | lep_meas_px |
double | lep_meas_py |
double | lep_meas_pz |
double | b_fit_e |
Save fit particle values for frequent calls. | |
double | b_fit_px |
double | b_fit_py |
double | b_fit_pz |
double | lq1_fit_e |
double | lq1_fit_px |
double | lq1_fit_py |
double | lq1_fit_pz |
double | lq2_fit_e |
double | lq2_fit_px |
double | lq2_fit_py |
double | lq2_fit_pz |
double | lep_fit_e |
double | lep_fit_px |
double | lep_fit_py |
double | lep_fit_pz |
double | nu_fit_e |
double | nu_fit_px |
double | nu_fit_py |
double | nu_fit_pz |
double | whad_fit_m |
double | wlep_fit_m |
double | thad_fit_m |
double | tlep_fit_m |
![]() | |
KLFitter::Particles ** | fParticlesPermuted |
A pointer to the measured particles. | |
std::unique_ptr< KLFitter::Permutations > * | fPermutations |
A pointer to the permutation object. | |
std::unique_ptr< KLFitter::Particles > | fParticlesModel |
A pointer to the model particles. | |
KLFitter::PhysicsConstants | fPhysicsConstants |
A pointer to the table of physics constants. | |
KLFitter::DetectorBase ** | fDetector |
A pointer to the detector. | |
std::vector< double > | fEventProbability |
The event probabilities for the different permutations. | |
bool | fFlagIntegrate |
A flag to integrate over the likelihood or not. | |
bool | fFlagIsNan |
A flag for knowing that Minuit gave parameters with NaN values to LogLikelihood. | |
bool | fFlagUseJetMass |
A flag for using the measured jet masses (true) instead of parton masses (false);. | |
bool | fTFgood |
Global variable for TF problems. | |
BtaggingMethod | fBTagMethod |
Name of btagging enum. | |
std::vector< double > | fCachedParameters |
The cached parameters used for the current permutation. | |
std::vector< double > | fCachedParameterErrors |
The cached parameter errors used for the current permutation. | |
std::vector< std::vector< double > > | fCachedParametersVector |
A vector of cached parameters, one for each permutation. More... | |
std::vector< std::vector< double > > | fCachedParameterErrorsVector |
A vector of cached parameter errors, one for each permutation. More... | |
double | fCachedNormalization |
The cached normalization, needed for the overloaded BCIntegrate::GetIntegral. | |
std::vector< double > | fCachedNormalizationVector |
A vector of cached parameters, one for each permutation. More... | |
Member functions (Set) | |
enum | LeptonType { kElectron, kMuon } |
Enumerator for the lepton type. | |
enum | Parameters { parBE, parLQ1E, parLQ2E, parLepE, parNuPx, parNuPy, parNuPz } |
Enumerator for the parameters. | |
int | SetET_miss_XY_SumET (double etx, double ety, double sumet) override |
Set the values for the missing ET x and y components and the SumET. More... | |
void | RequestResolutionFunctions () override |
Request the necessary resolution functions from the detector. | |
void | SetHadronicTop () |
Associate the hadronic leg of the event to the top quark for likelihood calculation. | |
void | SetLeptonicTop () |
Associate the leptonic leg of the event to the top quark for likelihood calculation. | |
void | SetLeptonType (int leptontype) |
Set the type of lepton. More... | |
Additional Inherited Members | |
![]() | |
enum | BtaggingMethod { kNotag, kVeto, kVetoNoFit, kVetoNoFitLight, kVetoNoFitBoth, kVetoHybridNoFit, kWorkingPoint, kVetoLight, kVetoBoth } |
Enumerate for b-tagging possibilities. | |
A class implementing a likelihood for the SgTop Wt -> lepton+jets channel.
This class represents a likelihood for the single top Wt channel into lepton+jets.
|
overrideprotectedvirtual |
Build the model particles from the best fit parameters.
Implements KLFitter::LikelihoodBase.
|
overrideprotectedvirtual |
|
overrideprotectedvirtual |
|
inline |
Return the top decay hypothesis.
|
overridevirtual |
Get initial values for the parameters.
Implements KLFitter::LikelihoodBase.
TLorentzVector * KLFitter::LikelihoodSgTopWtLJ::GetLepton | ( | KLFitter::Particles * | particles | ) |
Get a pointer to the lepton in a particles object, depending on value of fTypeLepton.
int KLFitter::LikelihoodSgTopWtLJ::GetLeptonType | ( | ) |
Return the lepton type.
|
protected |
Calculates the neutrino pz solutions from the measured values and the W mass.
|
overridevirtual |
The posterior probability definition, overloaded from BCModel.
parameters | A vector of parameters (double values). |
Implements KLFitter::LikelihoodBase.
|
overrideprotectedvirtual |
|
overridevirtual |
Set the values for the missing ET x and y components and the SumET.
etx | missing ET x component. |
ety | missing ET y component. |
sumet | total scalar ET. |
Implements KLFitter::LikelihoodBase.
void KLFitter::LikelihoodSgTopWtLJ::SetLeptonType | ( | int | leptontype | ) |
Set the type of lepton.
leptontype | The type of lepton: electron(1) or muon (2) |