// Author: Patrick Rieck <mailto:rieck@physik.hu-berlin.de>
// Copyright: 2009 (C) Patrick Rieck
//
#ifndef ATLAS_AtlSgTop_WtChannelFinder
#define ATLAS_AtlSgTop_WtChannelFinder
#ifndef ATLAS_AtlKinFitterTool
#include <AtlKinFitterTool.h>
#endif
#ifndef HEP_HepDatabasePDG
#include <HepDatabasePDG.h>
#endif
#ifndef ROOT_AtlSelector
#include <AtlSelector.h>
#endif
#ifndef TFITCONSTRAINTETA_H
#include <TFitConstraintEta.h>
#endif
#ifndef ATLAS_AtlCutFlowTool
#include <AtlCutFlowTool.h>
#endif

#include <fstream>
#include <iostream>
#include <TH2F.h>

//____________________________________________________________________

class TH1F;
class AtlEvent;
class TTree;
class TString;
class TROOT;
class TFile;
class TBranch;
//____________________________________________________________________

class AtlSgTop_WtChannelFinder : public AtlKinFitterTool {

  public:
    
    enum EModeMass { kGauss, kBW };
    enum EMode     { kAll, kKinFit, kCutBased };
    enum ELeptonMode {
	kElectronMode = BIT(0), // Search for W -> e nu_e events
	kMuonMode     = BIT(1), // Search for W -> mu nu_mu events
	kTauMode      = BIT(2), // Search for W -> tau nu_tau events
	kLeptonAll    = ( kElectronMode | kMuonMode ) // e or mu channel only (at present)
    };

 
  private:

    ofstream fOut; // write text file with event info for acceptance challenges
    AtlCutFlowTool         *fCutflow_tool;
    AtlCutFlowTool         *fCutflow_tool_AC;

    TKinFitter *fKinFitter_HadronicTop; // KinFitter object for reco of hadron. top
    
    TList *fLeptons;        // Merged list of electrons and muons
    TList *fJets;           // List of all jets
    TList *fWhadJets;       // List of jets for hadronic W reconstruction
    TList *fBJets;          // List of b-jets used for reconstruction

    Int_t fNJets;           // number of jets in generic list

    TVector2 fMET;          // MissingEt of current event
    Float_t  fMET_Mag;      // Magnitude of MissingEt of current event
    Float_t  fMET_Phi;      // Phi of MissingEt of current event

    
    HepParticle *fLepton;           // Current lepton used as input for the fit

    HepParticle *fNeutrino;         // Current neutrino (missing Et) used as input for the fit
 
    AtlJet      *fBJet;             // Current b-jet candidate used as input for the fit
    AtlJet      *fBJet_had;             // Current b-jet candidate used as input for the fit
    AtlJet      *fBestLeptonicBJet; // b-jet candidate used in best KinFitter reconstruction,
                                    // leptonic top decay
    AtlJet      *fBestHadronicBJet; // b-jet candidate used in best KinFitter reconstruction,
                                    // hadronic top decay
    AtlJet      *fJet1;             // 1st Jet candidate from W boson
    AtlJet      *fJet2;             // 2nd Jet candidate from W boson
    AtlJet      *fJet1_had;             // 1st Jet candidate from W boson
    AtlJet      *fJet2_had;             // 2nd Jet candidate from W boson

    AtlJet      *fBestLeptonicJet1; // 1st jet used in best KinFitter reconstruction,
                                    // leptonic top decay
    AtlJet      *fBestLeptonicJet2; // 2nd jet used in best KinFitter reconstruction,
                                    // leptonic top decay
    AtlJet      *fBestHadronicJet1; // 1st jet used in best KinFitter reconstruction,
                                    // hadronic top decay
    AtlJet      *fBestHadronicJet2; // 2nd jet used in best KinFitter reconstruction,
                                    // hadronic top decay
    
    TMatrixD fCovLepton;    // Covariance matrix of the charged lepton from the W decay
    TMatrixD fCovNeutrino;  // Covariance matrix of the neutrino from the W decay
    TMatrixD fCovBJet;      // Covariance matrix of the b-jet candidate from the t decay
    TMatrixD fCovWJet1;     // Covariance matrix of the 1st jet candidate from the W hadronic decay
    TMatrixD fCovWJet2;     // Covariance matrix of the 2nd jet candidate from the W hadronic decay

    TMatrixD fCovLepton_had;    // Covariance matrix of the charged lepton from the W decay
    //TMatrixD fCovNeutrino_had;  // Covariance matrix of the neutrino from the W decay
    TMatrixD fCovBJet_had;      // Covariance matrix of the b-jet candidate from the t decay
    TMatrixD fCovWJet1_had;     // Covariance matrix of the 1st jet candidate from the W hadronic decay
    TMatrixD fCovWJet2_had;     // Covariance matrix of the 2nd jet candidate from the W hadronic decay

    
    // true particles to be compared with reconstruction
    // so far only looking into t->Wb
    HepMCParticle *fTrueChargedLepton;
    HepMCParticle *fTrueNeutrino;
    HepMCParticle *fTrueBQuark;
    HepMCParticle *fTrueWQuark1;
    HepMCParticle *fTrueWQuark2;
    
    TLorentzVector *fNeutrinoLeptonicKinFit; // momentum 4 vector of reco. KinFitter Neutrino
    TLorentzVector *fLeptonLeptonicKinFit;   // momentum 4 vector of reco. KinFitter Charged lepton
    TLorentzVector *fBJetLeptonicKinFit;     // momentum 4 vector of reco. KinFitter b-jet,
                                             // leptonic top decay
    TLorentzVector *fJet1LeptonicKinFit;     // momentum 4 vector of reco. KinFitter jet1,
                                             // leptonic top decay
    TLorentzVector *fJet2LeptonicKinFit;     // momentum 4 vector of reco. KinFitter jet2,

    TLorentzVector *fNeutrinoHadronicKinFit; // momentum 4 vector of reco. KinFitter Neutrino
    TLorentzVector *fLeptonHadronicKinFit;   // momentum 4 vector of reco. KinFitter Charged lepton
                                              // leptonic top decay
    TLorentzVector *fBJetHadronicKinFit;     // momentum 4 vector of reco. KinFitter b-jet,
                                             // hadronic top decay
    TLorentzVector *fJet1HadronicKinFit;     // momentum 4 vector of reco. KinFitter jet1,
                                             // hadronic top decay
    TLorentzVector *fJet2HadronicKinFit;     // momentum 4 vector of reco. KinFitter jet2,

    Double_t fChi2Whad;          // Chi square of hadronic W reconstruction
                                 // done in ApplyTTbarVeto()
    Int_t    fNDoFWhad;          // No. of D.o.F. of hadronic W kinematic fit

    Int_t fN_Converged_lept;          // No. of fits that DID converge in this event
    Int_t fN_NotConverged_lept;       // No. of fits that did not converge in this event
    Int_t fN_FailNumeric_lept;        // No. of fits that failed numerically in this event
    Int_t fN_Converged_hadr;          // No. of fits that DID converge in this event
    Int_t fN_NotConverged_hadr;       // No. of fits that did not converge in this event
    Int_t fN_FailNumeric_hadr;        // No. of fits that failed numerically in this event

    Int_t fN_WorseTopCandidates; // No. of top-quark candidates with higher
                                 // Chi2 than chosen one in this event
    // mass term in chi square function
    // for Breit Wigner constraints:
    //     mu_top^2+mu_W^2, mu are the transformed masses
    // for Gauss constraints:
    // [(alpha_top-1)/(Gamma_Top/M_Top)]^2+[Top->W],
    // alpha are the additional variables used appearing in the constraint equations
    Float_t fMassConstraintParameterAll;   // mass term
    Float_t fMassConstraintParameterTop;   // mass term of top quark
    Float_t fMassConstraintParameterWtop;     // mass term of W boson
    Float_t fMassConstraintParameterWnoTop;     // mass term of W boson
    
    Float_t fPullLeptonPt;   // Pull of lepton Pt
    Float_t fPullLeptonEta;  // Pull of lepton eta
    Float_t fPullLeptonPhi;  // Pull of lepton phi
    Float_t fPullEtMissMag;  // Pull of missing Et magnitude
    Float_t fPullEtMissPhi;  // Pull of missing Et phi
    Float_t fPullBJetPt;     // Pull of Bjet Pt
    Float_t fPullBJetEta;    // Pull of Bjet eta
    Float_t fPullBJetPhi;    // Pull of Bjet phi
    Float_t fPullJet1Pt;     // Pull of jet1 Pt
    Float_t fPullJet1Eta;    // Pull of jet1 eta
    Float_t fPullJet1Phi;    // Pull of jet1 phi
    Float_t fPullJet2Pt;     // Pull of jet2 Pt
    Float_t fPullJet2Eta;    // Pull of jet2 eta
    Float_t fPullJet2Phi;    // Pull of jet2 phi
    Float_t fPullLeptonPt_had;   // Pull of lepton Pt
    Float_t fPullLeptonEta_had;  // Pull of lepton eta
    Float_t fPullLeptonPhi_had;  // Pull of lepton phi
    Float_t fPullEtMissMag_had;  // Pull of missing Et magnitude
    Float_t fPullEtMissPhi_had;  // Pull of missing Et phi
    Float_t fPullBJetPt_had;     // Pull of Bjet Pt
    Float_t fPullBJetEta_had;    // Pull of Bjet eta
    Float_t fPullBJetPhi_had;    // Pull of Bjet phi
    Float_t fPullJet1Pt_had;     // Pull of jet1 Pt
    Float_t fPullJet1Eta_had;    // Pull of jet1 eta
    Float_t fPullJet1Phi_had;    // Pull of jet1 phi
    Float_t fPullJet2Pt_had;     // Pull of jet2 Pt
    Float_t fPullJet2Eta_had;    // Pull of jet2 eta
    Float_t fPullJet2Phi_had;    // Pull of jet2 phi

    Float_t fResidualLeptonPt;   // Residual of lepton Pt
    Float_t fResidualLeptonEta;  // Residual of lepton eta
    Float_t fResidualLeptonPhi;  // Residual of lepton phi
    Float_t fResidualEtMissMag;  // Residual of missing Et magnitude
    Float_t fResidualEtMissPhi;  // Residual of missing Et phi
    Float_t fResidualBJetPt;     // Residual of Bjet Pt
    Float_t fResidualBJetEta;    // Residual of Bjet eta
    Float_t fResidualBJetPhi;    // Residual of Bjet phi
    Float_t fResidualJet1Pt;     // Residual of jet1 Pt
    Float_t fResidualJet1Eta;    // Residual of jet1 eta
    Float_t fResidualJet1Phi;    // Residual of jet1 phi
    Float_t fResidualJet2Pt;     // Residual of jet2 Pt
    Float_t fResidualJet2Eta;    // Residual of jet2 eta
    Float_t fResidualJet2Phi;    // Residual of jet2 phi

    Float_t fBeforeLeptonPt;   // Before of lepton Pt
    Float_t fBeforeLeptonEta;  // Before of lepton eta
    Float_t fBeforeLeptonPhi;  // Before of lepton phi
    Float_t fBeforeEtMissMag;  // Before of missing Et magnitude
    Float_t fBeforeEtMissEta;
    Float_t fBeforeEtMissPhi;  // Before of missing Et phi
    Float_t fBeforeBJetPt;     // Before of Bjet Pt
    Float_t fBeforeBJetEta;    // Before of Bjet eta
    Float_t fBeforeBJetPhi;    // Before of Bjet phi
    Float_t fBeforeJet1Pt;     // Before of jet1 Pt
    Float_t fBeforeJet1Eta;    // Before of jet1 eta
    Float_t fBeforeJet1Phi;    // Before of jet1 phi
    Float_t fBeforeJet2Pt;     // Before of jet2 Pt
    Float_t fBeforeJet2Eta;    // Before of jet2 eta
    Float_t fBeforeJet2Phi;    // Before of jet2 phi
    Float_t fAfterLeptonPt;   // After of lepton Pt
    Float_t fAfterLeptonEta;  // After of lepton eta
    Float_t fAfterLeptonPhi;  // After of lepton phi
    Float_t fAfterEtMissMag;  // After of missing Et magnitude
    Float_t fAfterEtMissEta;
    Float_t fAfterEtMissPhi;  // After of missing Et phi
    Float_t fAfterBJetPt;     // After of Bjet Pt
    Float_t fAfterBJetEta;    // After of Bjet eta
    Float_t fAfterBJetPhi;    // After of Bjet phi
    Float_t fAfterJet1Pt;     // After of jet1 Pt
    Float_t fAfterJet1Eta;    // After of jet1 eta
    Float_t fAfterJet1Phi;    // After of jet1 phi
    Float_t fAfterJet2Pt;     // After of jet2 Pt
    Float_t fAfterJet2Eta;    // After of jet2 eta
    Float_t fAfterJet2Phi;    // Before of jet2 phi
    
    Float_t fResidualLeptonPt_hadr;   // Residual of lepton Pt
    Float_t fResidualLeptonEta_hadr;  // Residual of lepton eta
    Float_t fResidualLeptonPhi_hadr;  // Residual of lepton phi
    Float_t fResidualEtMissMag_hadr;  // Residual of missing Et magnitude
    Float_t fResidualEtMissPhi_hadr;  // Residual of missing Et phi
    Float_t fResidualBJetPt_hadr;     // Residual of Bjet Pt
    Float_t fResidualBJetEta_hadr;    // Residual of Bjet eta
    Float_t fResidualBJetPhi_hadr;    // Residual of Bjet phi
    Float_t fResidualJet1Pt_hadr;     // Residual of jet1 Pt
    Float_t fResidualJet1Eta_hadr;    // Residual of jet1 eta
    Float_t fResidualJet1Phi_hadr;    // Residual of jet1 phi
    Float_t fResidualJet2Pt_hadr;     // Residual of jet2 Pt
    Float_t fResidualJet2Eta_hadr;    // Residual of jet2 eta
    Float_t fResidualJet2Phi_hadr;    // Residual of jet2 phi

    Float_t fBeforeLeptonPt_hadr;   // Before of lepton Pt
    Float_t fBeforeLeptonEta_hadr;  // Before of lepton eta
    Float_t fBeforeLeptonPhi_hadr;  // Before of lepton phi
    Float_t fBeforeEtMissMag_hadr;  // Before of missing Et magnitude
    Float_t fBeforeEtMissPhi_hadr;  // Before of missing Et phi
    Float_t fBeforeBJetPt_hadr;     // Before of Bjet Pt
    Float_t fBeforeBJetEta_hadr;    // Before of Bjet eta
    Float_t fBeforeBJetPhi_hadr;    // Before of Bjet phi
    Float_t fBeforeJet1Pt_hadr;     // Before of jet1 Pt
    Float_t fBeforeJet1Eta_hadr;    // Before of jet1 eta
    Float_t fBeforeJet1Phi_hadr;    // Before of jet1 phi
    Float_t fBeforeJet2Pt_hadr;     // Before of jet2 Pt
    Float_t fBeforeJet2Eta_hadr;    // Before of jet2 eta
    Float_t fBeforeJet2Phi_hadr;    // Before of jet2 phi
    Float_t fAfterLeptonPt_hadr;   // After of lepton Pt
    Float_t fAfterLeptonEta_hadr;  // After of lepton eta
    Float_t fAfterLeptonPhi_hadr;  // After of lepton phi
    Float_t fAfterEtMissMag_hadr;  // After of missing Et magnitude
    Float_t fAfterEtMissPhi_hadr;  // After of missing Et phi
    Float_t fAfterBJetPt_hadr;     // After of Bjet Pt
    Float_t fAfterBJetEta_hadr;    // After of Bjet eta
    Float_t fAfterBJetPhi_hadr;    // After of Bjet phi
    Float_t fAfterJet1Pt_hadr;     // After of jet1 Pt
    Float_t fAfterJet1Eta_hadr;    // After of jet1 eta
    Float_t fAfterJet1Phi_hadr;    // After of jet1 phi
    Float_t fAfterJet2Pt_hadr;     // After of jet2 Pt
    Float_t fAfterJet2Eta_hadr;    // After of jet2 eta
    Float_t fAfterJet2Phi_hadr;    // Before of jet2 phi

    
    static const char* fgStatusNames[]; // Status strings from KinFitter object

    // kinematic quantities of kinematic fit "ingredients" before and after the fit

    TTree *fCommonTree;

    // WtFinder performance histograms
    TH1F *fHist_KinFit_NbIterLeptonicTop;
    TH1F *fHist_KinFit_KinFitterStatus_LeptonicTop;
    TH1F *fHist_KinFit_NbFitsConverged_LeptonicTop;  // Number of fits converged
    TH1F *fHist_KinFit_NbFitsNotConverged_LeptonicTop;  // Number of fits not converged
    TH1F *fHist_KinFit_NbFitsFailedNumerically_LeptonicTop;// Number of fits failing numerically (1 or more matrix inversions fail)

    TH1F *fHist_KinFit_NbIterHadronicTop;
    TH1F *fHist_KinFit_KinFitterStatus_HadronicTop;
    TH1F *fHist_KinFit_NbFitsConverged_HadronicTop;  // Number of fits converged
    TH1F *fHist_KinFit_NbFitsNotConverged_HadronicTop;  // Number of fits not converged
    TH1F *fHist_KinFit_NbFitsFailedNumerically_HadronicTop;// Number of fits failing numerically (1 or more matrix inversions fail)

    TH2F *fHist_PValue_LeptHadrComp;
    TH2F *fHist_Chi2_LeptHadrComp;
    TH1F *fHistPerformanceComparison_before;
    TH1F *fHistPerformanceComparison_after;
    TH2F *fHist_W_hadr_top_reco_comp_MChi2;
    TH2F *fHist_W_hadr_top_reco_comp_MPChi2;
    TH2F *fHist_t_hadr_top_reco_comp_MChi2;
    TH2F *fHist_t_hadr_top_reco_comp_MPChi2;
    TH2F *fHist_W_hadr_top_reco_comp_MChi2_after;
    TH2F *fHist_W_hadr_top_reco_comp_MPChi2_after;
    TH2F *fHist_t_hadr_top_reco_comp_MChi2_after;
    TH2F *fHist_t_hadr_top_reco_comp_MPChi2_after;

    TH2F *fHist_W_hadr_top_reco_comp_Mptbjet;
    TH2F *fHist_W_hadr_top_reco_comp_Metabjet;
    TH2F *fHist_W_hadr_top_reco_comp_Mptjet1;
    TH2F *fHist_W_hadr_top_reco_comp_Metajet1;
    TH2F *fHist_W_hadr_top_reco_comp_Mptjet2;
    TH2F *fHist_W_hadr_top_reco_comp_Metajet2;

    TH2F *fHist_W_hadr_top_reco_comp_chi2ptbjet;
    TH2F *fHist_W_hadr_top_reco_comp_chi2etabjet;
    TH2F *fHist_W_hadr_top_reco_comp_chi2ptjet1;
    TH2F *fHist_W_hadr_top_reco_comp_chi2etajet1;
    TH2F *fHist_W_hadr_top_reco_comp_chi2ptjet2;
    TH2F *fHist_W_hadr_top_reco_comp_chi2etajet2;

    // histograms showing Wt system pt vs top eta 
    TH2F *fHistWtSystem_vs_TopEta_sliced_fine;      // 2D fine binning
    TH2F *fHistWtSystem_vs_TopEta_sliced;           // 2D coarse binning
    TH1F *fHistWtSystem_rolled_TopEta_sliced_fine;  // rolled wrt top eta - fine binning
    TH1F *fHistWtSystem_rolled_TopEta_sliced;       // rolled wrt top eta - coarse binning
    TH2F *fHistWtSystem_vs_TopEta_sliced_fine_more;      // 2D fine binning
    TH2F *fHistWtSystem_vs_TopEta_sliced_more;           // 2D coarse binning
    TH1F *fHistWtSystem_rolled_TopEta_sliced_fine_more;  // rolled wrt top eta - fine binning
    TH1F *fHistWtSystem_rolled_TopEta_sliced_more;       // rolled wrt top eta - coarse binning

    TH2F *fHistWtSystem_vs_TopEta_sliced_less;           // 2D coarse binning
    TH1F *fHistWtSystem_rolled_TopEta_sliced_less;       // rolled wrt top eta - coarse binning
    
    
    Int_t nbins_pt_fine;
    Int_t nbins_pt_coarse;
    Int_t n_eta_slices;
    Int_t n_eta_slices_more;
    
    TH2F *fHist_comp_MM;
    TH2F *fHist_comp_MM_after;
    // Et Miss histograms
    
    TH1F *fHistEtMissMag;
    TH1F *fHistEtMissPhi;
    TH1F *fHistSumEt;

    
    TH1F *fHistEtMissMag_pretag;  // EtMiss pretag
    TH1F *fHistEtMissPhi_pretag;  // EtMiss Phi pretag
    TH1F *fHistEtMissMag_tag;     // EtMiss tag
    TH1F *fHistEtMissPhi_tag;     // EtMiss Phi tag
    TH1F *fHistSumEt_pretag;      // SumEt pretag
    TH1F *fHistSumEt_tag;         // SumEt tagH
    TH1F *fHistTotalYield_allCuts; // Total weighted yield after all cuts
    TH1F *fHistTotalYield_p10WtPt;
    TH1F *fHistTotalYield_allCuts_cut20; // Total weighted yield after all cuts
    TH1F *fHistTotalYield_allCuts_cut30; // Total weighted yield after all cuts
    TH1F *fHistTotalYield_allCuts_cut40; // Total weighted yield after all cuts
    TH1F *fHistTotalYield_allCuts_cut50; // Total weighted yield after all cuts
    TH1F *fHistTotalYield_allCuts_cut60; // Total weighted yield after all cuts

    TH1F *fHistCountLepPlus_pretag; // Pretag count positive leptons 
    TH1F *fHistCountLepMinus_pretag; // Pretag count negative leptons 
    TH1F *fHistCountLepAll_tag; // Tag count (all leptons)
    TH1F *fHistCountLepPlus_tag; // Tag count positive leptons
    TH1F *fHistCountLepMinus_tag; // Tag count negative leptons
    TH1F *fHistCountLepAll_tag_refQCD; // Tag count (all leptons), reference for QCD norm.
    TH1F *fHistCountLepPlus_tag_refQCD; // Tag count (positive leptons), reference for QCD norm.
    TH1F *fHistCountLepMinus_tag_refQCD; // Tag count (negative leptons), reference for QCD norm.
    TH1I *fHist_HFOR_flag_pretag; // top_hfor_flag for use by wjets flavour reweighting tool

    TH1F *fHistCountFwdElectrons_pretag;// no. of events (pretag) for fwd electrons
    TH1F *fHistCountCentralElectrons_pretag;// no. of events (pretag) for central electrons
    TH1F *fHistCountFwdElectrons_tag;// no. of events (tag) for fwd electrons
    TH1F *fHistCountCentralElectrons_tag;// no. of events (tag) for central electrons
    TH1F *fHistCountFwdElectrons_WCtrl;// no. of events (W control region) for fwd electrons
    TH1F *fHistCountCentralElectrons_WCtrl;// no. of events (W control region) for central electrons
    
    
    TH1F *fHistW_Mt_QCDValidation_pretag; // transverse mass lept-etmiss for qcd validation plot - pretag
    TH1F *fHistW_Mt_QCDValidation_tag;    // transverse mass lept-etmiss for qcd validation plot - tag
    // Signal lepton histograms 
    
    TH1F *fHistSignalLepton_pt;    // Pt of leading signal lepton
    TH1F *fHistSignalLepton_eta;   // Eta of leading signal lepton
    TH1F *fHistSignalLepton_eta_cells;
    TH1F *fHistSignalLepton_phi;   // Phi of leading signal lepton  

    TH1F *fHistSignalElectron_author; // Author of signal electron
    TH1F *fHistSignalElectron_pt;  // Pt of leading signal electron
    TH1F *fHistSignalElectron_eta; // Eta of leading signal electron  
    TH1F *fHistSignalElectron_phi; // Phi of leading signal electron  
    TH1F *fHistSignalEplus_pt;     // Pt of leading signal e+
    TH1F *fHistSignalEplus_eta;    // Eta of leading signal e+  
    TH1F *fHistSignalEplus_phi;    // Phi of leading signal e+  
    TH1F *fHistSignalEminus_pt;    // Pt of leading signal e-
    TH1F *fHistSignalEminus_eta;   // Eta of leading signal e-  
    TH1F *fHistSignalEminus_phi;   // Phi of leading signal e-  

    TH1F *fHistSignalMuon_pt;      // Pt of leading signal muon
    TH1F *fHistSignalMuon_eta;     // Eta of leading signal muon  
    TH1F *fHistSignalMuon_phi;     // Phi of leading signal muon  
    TH1F *fHistSignalMuplus_pt;    // Pt of leading signal mu+
    TH1F *fHistSignalMuplus_eta;   // Eta of leading signal mu+  
    TH1F *fHistSignalMuplus_phi;   // Phi of leading signal mu+  
    TH1F *fHistSignalMuminus_pt;   // Pt of leading signal mu-
    TH1F *fHistSignalMuminus_eta;  // Eta of leading signal mu-  
    TH1F *fHistSignalMuminus_phi;  // Phi of leading signal mu-  

    TH1F *fHistSignalTau_pt;       // Pt of leading signal tau
    TH1F *fHistSignalTau_eta;      // Eta of leading signal tau  
    TH1F *fHistSignalTau_phi;      // Phi of leading signal tau  
    TH1F *fHistSignalTauplus_pt;   // Pt of leading signal tau+
    TH1F *fHistSignalTauplus_eta;  // Eta of leading signal tau+  
    TH1F *fHistSignalTauplus_phi;  // Phi of leading signal tau+  
    TH1F *fHistSignalTauminus_pt;  // Pt of leading signal tau-
    TH1F *fHistSignalTauminus_eta; // Eta of leading signal tau-  
    TH1F *fHistSignalTauminus_phi; // Phi of leading signal tau-  

    // Before/after fit comparison histograms
    TH1F *fHistSignalLeptonPt_before_lept;
    TH1F *fHistSignalLeptonEta_before_lept;
    TH1F *fHistSignalLeptonEta_before_cells_lept;
    TH1F *fHistSignalLeptonPhi_before_lept;
    TH1F *fHistBJetEt_before_lept;
    TH1F *fHistBJetEta_before_lept;
    TH1F *fHistBJetPhi_before_lept;
    TH1F *fHistBJetWeight_before_lept;
    TH1F *fHistJet1Et_before_lept;
    TH1F *fHistJet1Eta_before_lept;
    TH1F *fHistJet1Phi_before_lept;
    TH1F *fHistJet2Et_before_lept;
    TH1F *fHistJet2Eta_before_lept;
    TH1F *fHistJet2Phi_before_lept;
    TH1F *fHistEtMissMag_before_lept;
    TH1F *fHistEtMissPhi_before_lept;
    TH1F *fHistSumEt_before_lept;

    TH1F *fHistSignalLeptonPt_after_lept;
    TH1F *fHistSignalLeptonEta_after_lept;
    TH1F *fHistSignalLeptonEta_after_cells_lept;
    TH1F *fHistSignalLeptonPhi_after_lept;
    TH1F *fHistBJetEt_after_lept;
    TH1F *fHistBJetEta_after_lept;
    TH1F *fHistBJetPhi_after_lept;
    TH1F *fHistBJetWeight_after_lept;
    TH1F *fHistJet1Et_after_lept;
    TH1F *fHistJet1Eta_after_lept;
    TH1F *fHistJet1Phi_after_lept;
    TH1F *fHistJet2Et_after_lept;
    TH1F *fHistJet2Eta_after_lept;
    TH1F *fHistJet2Phi_after_lept;
    TH1F *fHistEtMissMag_after_lept;
    TH1F *fHistEtMissPhi_after_lept;
    
    TH1F *fHistSignalLeptonPt_before_hadr;
    TH1F *fHistSignalLeptonEta_before_hadr;
    TH1F *fHistSignalLeptonEta_before_cells_hadr;
    TH1F *fHistSignalLeptonPhi_before_hadr;
    TH1F *fHistBJetEt_before_hadr;
    TH1F *fHistBJetEta_before_hadr;
    TH1F *fHistBJetPhi_before_hadr;
    TH1F *fHistBJetWeight_before_hadr;
    TH1F *fHistJet1Et_before_hadr;
    TH1F *fHistJet1Eta_before_hadr;
    TH1F *fHistJet1Phi_before_hadr;
    TH1F *fHistJet2Et_before_hadr;
    TH1F *fHistJet2Eta_before_hadr;
    TH1F *fHistJet2Phi_before_hadr;
    TH1F *fHistEtMissMag_before_hadr;
    TH1F *fHistEtMissPhi_before_hadr;
    TH1F *fHistSumEt_before_hadr;

    TH1F *fHistSignalLeptonPt_after_hadr;
    TH1F *fHistSignalLeptonEta_after_hadr;
    TH1F *fHistSignalLeptonEta_after_hadr_cells;
    TH1F *fHistSignalLeptonPhi_after_hadr;
    TH1F *fHistBJetEt_after_hadr;
    TH1F *fHistBJetEta_after_hadr;
    TH1F *fHistBJetPhi_after_hadr;
    TH1F *fHistBJetWeight_after_hadr;
    TH1F *fHistJet1Et_after_hadr;
    TH1F *fHistJet1Eta_after_hadr;
    TH1F *fHistJet1Phi_after_hadr;
    TH1F *fHistJet2Et_after_hadr;
    TH1F *fHistJet2Eta_after_hadr;
    TH1F *fHistJet2Phi_after_hadr;

    TH1F *fHistEtMissMag_after_hadr;
    TH1F *fHistEtMissPhi_after_hadr;
    
    // Jets
    TH1F *fHistJet_n;      // No. of jets
    TH1F *fHistJet_Et;     // Et of all jets
    TH1F *fHistJet_eta;    // Eta of all jets
    TH1F *fHistJet_phi;    // Phi of all jets

    TH1F *fHistJet1_Et;    // Pt of leading jet
    TH1F *fHistJet1_eta;   // Eta of leading jet
    TH1F *fHistJet1_phi;   // Phi of leading jet
    TH1F *fHistJet2_Et;    // Pt of 2nd leading jet
    TH1F *fHistJet2_eta;   // Eta of 2nd leading jet
    TH1F *fHistJet2_phi;   // Phi of 2nd leading jet
    
    TH1F *fHistBJet_n;      // No. of b-jets
    TH1F *fHistBJet_Et;     // Et of all b-jets
    TH1F *fHistBJet_eta;    // Eta of all b-jets
    TH1F *fHistBJet_phi;    // Phi of all b-jets
    TH1F *fHistBJet_weight;// Weight of all b-jets
    TH1F *fHistBJet1_Et;    // Pt of leading b-jet
    TH1F *fHistBJet1_eta;   // Eta of leading b-jet
    TH1F *fHistBJet1_phi;   // Phi of leading b-jet
    TH1F *fHistBJet1_weight;// Weight of leading b-jet
    TH1F *fHistBJet2_Et;    // Pt of 2nd leading b-jet
    TH1F *fHistBJet2_eta;   // Eta of 2nd leading b-jet
    TH1F *fHistBJet2_phi;   // Phi of 2nd leading b-jet
    TH1F *fHistBJet2_weight;// Weight of leading b-jet

    TH1F *fHistNonBJet_n;      // No. of non-b-jets
    TH1F *fHistNonBJet_Et;     // Et of all non-b-jets
    TH1F *fHistNonBJet_eta;    // Eta of all non-b-jets
    TH1F *fHistNonBJet_phi;    // Phi of all non-b-jets
    TH1F *fHistNonBJet1_Et;    // Pt of leading non-b-jet
    TH1F *fHistNonBJet1_eta;   // Eta of leading non-b-jet
    TH1F *fHistNonBJet1_phi;   // Phi of leading non-b-jet
    TH1F *fHistNonBJet2_Et;    // Pt of 2nd leading non-b-jet
    TH1F *fHistNonBJet2_eta;   // Eta of 2nd leading non-b-jet
    TH1F *fHistNonBJet2_phi;   // Phi of 2nd leading non-b-jet

    TH1F *fHistSignalLepton_pt_btag;
    TH1F *fHistSignalLepton_eta_btag;
    TH1F *fHistSignalLepton_eta_btag_cells;
    TH1F *fHistSignalLepton_phi_btag;

    TH1F *fHistSignalElectron_author_btag;
    TH1F *fHistSignalElectron_pt_btag;
    TH1F *fHistSignalElectron_eta_btag;
    TH1F *fHistSignalElectron_phi_btag;
    TH1F *fHistSignalEplus_pt_btag;
    TH1F *fHistSignalEplus_eta_btag;
    TH1F *fHistSignalEplus_phi_btag;
    TH1F *fHistSignalEminus_pt_btag;
    TH1F *fHistSignalEminus_eta_btag;
    TH1F *fHistSignalEminus_phi_btag;
    TH1F *fHistSignalMuon_pt_btag;
    TH1F *fHistSignalMuon_eta_btag;
    TH1F *fHistSignalMuon_phi_btag;
    TH1F *fHistSignalMuplus_pt_btag;
    TH1F *fHistSignalMuplus_eta_btag;
    TH1F *fHistSignalMuplus_phi_btag;
    TH1F *fHistSignalMuminus_pt_btag;
    TH1F *fHistSignalMuminus_eta_btag;
    TH1F *fHistSignalMuminus_phi_btag;
    TH1F *fHistJet_n_btag;
    TH1F *fHistJet_Et_btag;
    TH1F *fHistJet_eta_btag;
    TH1F *fHistJet_phi_btag;
    TH1F *fHistJet1_Et_btag;
    TH1F *fHistJet1_eta_btag;
    TH1F *fHistJet1_phi_btag;
    TH1F *fHistJet2_Et_btag;
    TH1F *fHistJet2_eta_btag;
    TH1F *fHistJet2_phi_btag;
    TH1F *fHistBJet_n_btag;
    TH1F *fHistBJet_Et_btag;
    TH1F *fHistBJet_eta_btag;
    TH1F *fHistBJet_phi_btag;
    TH1F *fHistBJet_weight_btag;
    TH1F *fHistBJet1_Et_btag;
    TH1F *fHistBJet1_eta_btag;
    TH1F *fHistBJet1_phi_btag;
    TH1F *fHistBJet1_weight_btag;
    TH1F *fHistBJet2_Et_btag;
    TH1F *fHistBJet2_eta_btag;
    TH1F *fHistBJet2_phi_btag;
    TH1F *fHistBJet2_weight_btag;
    TH1F *fHistNonBJet_n_btag;
    TH1F *fHistNonBJet_Et_btag;
    TH1F *fHistNonBJet_eta_btag;
    TH1F *fHistNonBJet_phi_btag;
    TH1F *fHistNonBJet1_Et_btag;
    TH1F *fHistNonBJet1_eta_btag;
    TH1F *fHistNonBJet1_phi_btag;
    TH1F *fHistNonBJet2_Et_btag;
    TH1F *fHistNonBJet2_eta_btag;
    TH1F *fHistNonBJet2_phi_btag;
    

    // ====================================
    // histograms for KinFit top candidates
    // ====================================

    // Signal lepton histogrmas
    TH1F *fHistKinFitCandidateSignalLepton_pt;    // Pt of leading signal lepton
    TH1F *fHistKinFitCandidateSignalLepton_eta;   // Eta of leading signal lepton  
    TH1F *fHistKinFitCandidateSignalLepton_phi;   // Phi of leading signal lepton  

    TH1F *fHistKinFitCandidateSignalElectron_author; // Author of signal electron
    TH1F *fHistKinFitCandidateSignalElectron_pt;  // Pt of leading signal electron
    TH1F *fHistKinFitCandidateSignalElectron_eta; // Eta of leading signal electron  
    TH1F *fHistKinFitCandidateSignalElectron_phi; // Phi of leading signal electron  
    TH1F *fHistKinFitCandidateSignalEplus_pt;     // Pt of leading signal e+
    TH1F *fHistKinFitCandidateSignalEplus_eta;    // Eta of leading signal e+  
    TH1F *fHistKinFitCandidateSignalEplus_phi;    // Phi of leading signal e+  
    TH1F *fHistKinFitCandidateSignalEminus_pt;    // Pt of leading signal e-
    TH1F *fHistKinFitCandidateSignalEminus_eta;   // Eta of leading signal e-  
    TH1F *fHistKinFitCandidateSignalEminus_phi;   // Phi of leading signal e-  

    TH1F *fHistKinFitCandidateSignalMuon_pt;      // Pt of leading signal muon
    TH1F *fHistKinFitCandidateSignalMuon_eta;     // Eta of leading signal muon  
    TH1F *fHistKinFitCandidateSignalMuon_phi;     // Phi of leading signal muon  
    TH1F *fHistKinFitCandidateSignalMuplus_pt;    // Pt of leading signal mu+
    TH1F *fHistKinFitCandidateSignalMuplus_eta;   // Eta of leading signal mu+  
    TH1F *fHistKinFitCandidateSignalMuplus_phi;   // Phi of leading signal mu+  
    TH1F *fHistKinFitCandidateSignalMuminus_pt;   // Pt of leading signal mu-
    TH1F *fHistKinFitCandidateSignalMuminus_eta;  // Eta of leading signal mu-  
    TH1F *fHistKinFitCandidateSignalMuminus_phi;  // Phi of leading signal mu-  

    TH1F *fHistKinFitCandidateSignalTau_pt;       // Pt of leading signal tau
    TH1F *fHistKinFitCandidateSignalTau_eta;      // Eta of leading signal tau  
    TH1F *fHistKinFitCandidateSignalTau_phi;      // Phi of leading signal tau  
    TH1F *fHistKinFitCandidateSignalTauplus_pt;   // Pt of leading signal tau+
    TH1F *fHistKinFitCandidateSignalTauplus_eta;  // Eta of leading signal tau+  
    TH1F *fHistKinFitCandidateSignalTauplus_phi;  // Phi of leading signal tau+  
    TH1F *fHistKinFitCandidateSignalTauminus_pt;  // Pt of leading signal tau-
    TH1F *fHistKinFitCandidateSignalTauminus_eta; // Eta of leading signal tau-  
    TH1F *fHistKinFitCandidateSignalTauminus_phi; // Phi of leading signal tau-

    // Jets
    TH1F *fHistKinFitCandidateJet_n;      // No. of jets
    TH1F *fHistKinFitCandidateJet_Et;     // Et of all jets
    TH1F *fHistKinFitCandidateJet_eta;    // Eta of all jets
    TH1F *fHistKinFitCandidateJet_phi;    // Phi of all jets
    TH1F *fHistKinFitCandidateJet1_Et;    // Pt of leading jet
    TH1F *fHistKinFitCandidateJet1_eta;   // Eta of leading jet
    TH1F *fHistKinFitCandidateJet1_phi;   // Phi of leading jet
    TH1F *fHistKinFitCandidateJet2_Et;    // Pt of 2nd leading jet
    TH1F *fHistKinFitCandidateJet2_eta;   // Eta of 2nd leading jet
    TH1F *fHistKinFitCandidateJet2_phi;   // Phi of 2nd leading jet
    
    TH1F *fHistKinFitCandidateBJet_n;      // No. of b-jets
    TH1F *fHistKinFitCandidateBJet_Et;     // Et of all b-jets
    TH1F *fHistKinFitCandidateBJet_eta;    // Eta of all b-jets
    TH1F *fHistKinFitCandidateBJet_phi;    // Phi of all b-jets
    TH1F *fHistKinFitCandidateBJet1_Et;    // Pt of leading b-jet
    TH1F *fHistKinFitCandidateBJet1_eta;   // Eta of leading b-jet
    TH1F *fHistKinFitCandidateBJet1_phi;   // Phi of leading b-jet
    TH1F *fHistKinFitCandidateBJet2_Et;    // Pt of 2nd leading b-jet
    TH1F *fHistKinFitCandidateBJet2_eta;   // Eta of 2nd leading b-jet
    TH1F *fHistKinFitCandidateBJet2_phi;   // Phi of 2nd leading b-jet

    TH1F *fHistKinFitCandidateNonBJet_n;      // No. of non-b-jets
    TH1F *fHistKinFitCandidateNonBJet_Et;     // Et of all non-b-jets
    TH1F *fHistKinFitCandidateNonBJet_eta;    // Eta of all non-b-jets
    TH1F *fHistKinFitCandidateNonBJet_phi;    // Phi of all non-b-jets
    TH1F *fHistKinFitCandidateNonBJet1_Et;    // Pt of leading non-b-jet
    TH1F *fHistKinFitCandidateNonBJet1_eta;   // Eta of leading non-b-jet
    TH1F *fHistKinFitCandidateNonBJet1_phi;   // Phi of leading non-b-jet
    TH1F *fHistKinFitCandidateNonBJet2_Et;    // Pt of 2nd leading non-b-jet
    TH1F *fHistKinFitCandidateNonBJet2_eta;   // Eta of 2nd leading non-b-jet
    TH1F *fHistKinFitCandidateNonBJet2_phi;   // Phi of 2nd leading non-b-jet
    
    // W reconstruction histograms
    // 
    // from top  ---    leptonic decays  
    TH1F *fHist_W_lept_top_reco_Mt;        // Reconstructed invariant transverse mass of the leptonic W
                                           // (all leptons), the W comes from a top decay
    TH1F *fHist_W_lept_top_reco_M;         // Reconstructed invariant mass of that W (all leptons)
    TH1F *fHist_W_lept_top_reco_phi;       // Reconstructed azimuth angle of that W (all leptons)
    TH1F *fHist_W_lept_top_reco_eta;       // Reconstructed Eta of that W (all leptons)
    TH1F *fHist_W_lept_top_reco_rap;       // Reconstructed y of that W (all leptons)
    TH1F *fHist_W_lept_top_reco_pt;        // Reconstructed Pt of that W (all leptons)
    // electron channel
    TH1F *fHist_W_lept_top_reco_Mt_e;      // Reconstructed invariant transverse mass of the leptonic W decaying
                                           // into electrons, the W comes from a top decay
    TH1F *fHist_W_lept_top_reco_M_e;       // Reconstructed invariant mass of taht W
    TH1F *fHist_W_lept_top_reco_phi_e;     // Reconstructed azimuth angle of that W
    TH1F *fHist_W_lept_top_reco_eta_e;     // Reconstructed Eta of that W
    TH1F *fHist_W_lept_top_reco_rap_e;     // Reconstructed y of that W
    TH1F *fHist_W_lept_top_reco_pt_e;      // Reconstructed Pt of that W
    // muon channel
    TH1F *fHist_W_lept_top_reco_Mt_mu;     // Reconstructed invariant transverse mass of the W
                                           // decaying into muons, the W comes from a top decay
    TH1F *fHist_W_lept_top_reco_M_mu;      // Reconstructed invariant mass of that W
    TH1F *fHist_W_lept_top_reco_phi_mu;    // Reconstructed azimuth angle of that W
    TH1F *fHist_W_lept_top_reco_eta_mu;    // Reconstructed Eta of that W
    TH1F *fHist_W_lept_top_reco_rap_mu;    // Reconstructed y of that W
    TH1F *fHist_W_lept_top_reco_pt_mu;     // Reconstructed Pt of that W  
    
    TH1F *fHist_W_lept_top_reco_Mt_minus;  // Reconstructed invariant transverse mass of the leptonic W
    TH1F *fHist_W_lept_top_reco_M_minus;   // Reconstructed invariant mass of the leptonic W
                                           // (all negative sign leptons)
    TH1F *fHist_W_lept_top_reco_phi_minus; // Reconstructed azimuth angle of the leptonic W (all negative sign leptons)
    TH1F *fHist_W_lept_top_reco_eta_minus; // Reconstructed Eta of the leptonic W (all negative sign leptons)
    TH1F *fHist_W_lept_top_reco_rap_minus; // Reconstructed y of the leptonic W (all negative sign leptons)
    TH1F *fHist_W_lept_top_reco_pt_minus;  // Reconstructed Pt of the leptonic W (all negative sign leptons)
    TH1F *fHist_W_lept_top_reco_Mt_plus;   // Reconstructed invariant transverse mass of the leptonic W
                                           // (all positive sign leptons)
    TH1F *fHist_W_lept_top_reco_M_plus;    // Reconstructed invariant mass of the leptonic W
                                           // (all positive sign leptons)
    TH1F *fHist_W_lept_top_reco_phi_plus;  // Reconstructed azimuth angle of the leptonic W (all positive sign leptons)
    TH1F *fHist_W_lept_top_reco_eta_plus;  // Reconstructed Eta of the leptonic W (all positive sign leptons)
    TH1F *fHist_W_lept_top_reco_rap_plus;  // Reconstructed y of the leptonic W (all positive sign leptons)
    TH1F *fHist_W_lept_top_reco_pt_plus;   // Reconstructed Pt of the leptonic W (all positive sign leptons)

    TH1F *fHist_W_lept_top_reco_Mt_e_minus;  // Reconstructed invariant transverse mass of the W decaying into e-
    TH1F *fHist_W_lept_top_reco_M_e_minus;   // Reconstructed invariant mass of the W decaying into e-
    TH1F *fHist_W_lept_top_reco_phi_e_minus; // Reconstructed azimuth angle of the (real) W decaying into e-
    TH1F *fHist_W_lept_top_reco_eta_e_minus; // Reconstructed Eta of the W decaying into e-
    TH1F *fHist_W_lept_top_reco_rap_e_minus; // Reconstructed y of the (real) W decaying into e-
    TH1F *fHist_W_lept_top_reco_pt_e_minus;  // Reconstructed Pt of the W decaying into e-
    TH1F *fHist_W_lept_top_reco_Mt_e_plus;   // Reconstructed invariant transverse mass of the W decaying into e+
    TH1F *fHist_W_lept_top_reco_M_e_plus;    // Reconstructed invariant mass of the W decaying into e+
    TH1F *fHist_W_lept_top_reco_phi_e_plus;  // Reconstructed azimuth angle of the (real) W decaying into e+
    TH1F *fHist_W_lept_top_reco_eta_e_plus;  // Reconstructed Eta of the W decaying into e+
    TH1F *fHist_W_lept_top_reco_rap_e_plus;  // Reconstructed y of the (real) W decaying into e+
    TH1F *fHist_W_lept_top_reco_pt_e_plus;   // Reconstructed Pt of the W decaying into e+

    TH1F *fHist_W_lept_top_reco_Mt_mu_minus;  // Reconstructed invariant transverse mass of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_M_mu_minus;   // Reconstructed invariant mass of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_phi_mu_minus; // Reconstructed azimuth angle of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_eta_mu_minus; // Reconstructed Eta of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_rap_mu_minus; // Reconstructed y of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_pt_mu_minus;  // Reconstructed Pt of the W decaying into mu-
    TH1F *fHist_W_lept_top_reco_Mt_mu_plus;   // Reconstructed invariant transverse mass of the W decaying into mu+
    TH1F *fHist_W_lept_top_reco_M_mu_plus;   // Reconstructed invariant mass of the W decaying into mu+
    TH1F *fHist_W_lept_top_reco_phi_mu_plus;  // Reconstructed azimuth angle of the W decaying into mu+
    TH1F *fHist_W_lept_top_reco_eta_mu_plus;  // Reconstructed Eta of the W decaying into mu+
    TH1F *fHist_W_lept_top_reco_rap_mu_plus;  // Reconstructed y of the W decaying into mu+
    TH1F *fHist_W_lept_top_reco_pt_mu_plus;   // Reconstructed Pt of the W decaying into mu+
    //    ---    hadronic decays  
    TH1F *fHist_W_hadr_top_reco_Mt;        // Reconstructed invariant transverse mass of the hadronic W
                                           // coming from a top quark
    TH1F *fHist_W_hadr_top_reco_M;         // Reconstructed invariant mass of the W (all leptons)
    TH1F *fHist_W_hadr_top_reco_pt;        // Reconstructed pt of the W (all leptons)
    TH1F *fHist_W_hadr_top_reco_eta;       // Reconstructed pseudorapidity of the W (all leptons)
    TH1F *fHist_W_hadr_top_reco_phi;       // Reconstructed azimuth angle of the W (all leptons)
    TH1F *fHist_W_hadr_top_reco_rap;       // Reconstructed y of the W (all leptons)
                                // electrons
    TH1F *fHist_W_hadr_top_reco_M_e;   // Reconstructed invariant mass of the hadronic W coming from the
                                           // top quark, the associated W decayed into an electron (or positron)
    TH1F *fHist_W_hadr_top_reco_Mt_e;  // Reconstructed invariant transverse mass of the hadronic W
    TH1F *fHist_W_hadr_top_reco_pt_e;  // Reconstructed transverse momentum of the hadronic W
    TH1F *fHist_W_hadr_top_reco_phi_e; // Reconstructed azimuth angle of the hadronic W
    TH1F *fHist_W_hadr_top_reco_eta_e; // Reconstructed eta of the hadronic W
    TH1F *fHist_W_hadr_top_reco_rap_e; // Reconstructed y of the hadronic W
                                // muons
    TH1F *fHist_W_hadr_top_reco_M_mu;    // Reconstructed invariant mass of the Wc oming from the
                                           // top quark, the associated W decayed into  a muons (or Antimuon)
    TH1F *fHist_W_hadr_top_reco_Mt_mu;   // Reconstructed invariant transverse mass of the hadronic W
    TH1F *fHist_W_hadr_top_reco_phi_mu;  // Reconstructed azimuth angle of the hadronic W
    TH1F *fHist_W_hadr_top_reco_eta_mu;  // Reconstructed eta of the hadronic W
    TH1F *fHist_W_hadr_top_reco_rap_mu;  // Reconstructed y of the hadronic W
    TH1F *fHist_W_hadr_top_reco_pt_mu;   // Reconstructed Pt of the hadronic W

    //
    // associate W -  reconstruction histograms
    // 
    //    ---    leptonic decays
    TH1F *fHist_W_lept_notop_reco_Mt;        // Reconstructed invariant transverse mass of the W (all leptons)
    TH1F *fHist_W_lept_notop_reco_phi;       // Reconstructed azimuth angle of the W (all leptons)
    TH1F *fHist_W_lept_notop_reco_pt;        // Reconstructed pt of the W (all leptons)
    //TH1F *fHist_W_lept_notop_reco_rap;       // Reconstructed y of the W (all leptons)
    TH1F *fHist_W_lept_notop_reco_Mt_minus;  // Reconstructed invariant transverse mass of the W
                                // (all negative sign leptons)
    TH1F *fHist_W_lept_notop_reco_phi_minus; // Reconstructed azimuth angle of the W (all negative sign leptons)
    TH1F *fHist_W_lept_notop_reco_pt_minus; // Reconstructed y of the W (all negative sign leptons)
    TH1F *fHist_W_lept_notop_reco_Mt_plus;   // Reconstructed invariant transverse mass of the W
                                // (all positive sign leptons)
    TH1F *fHist_W_lept_notop_reco_phi_plus;  // Reconstructed azimuth angle of the W (all positive sign leptons)
    TH1F *fHist_W_lept_notop_reco_pt_plus;   // Reconstructed Pt of the W (all positive sign leptons)

    TH1F *fHist_W_lept_notop_reco_Mt_e;        // Reconstructed invariant transverse mass of the W decaying
                                  // into electrons
    TH1F *fHist_W_lept_notop_reco_phi_e;       // Reconstructed azimuth angle of the (real) W decaying into electrons
    TH1F *fHist_W_lept_notop_reco_pt_e;        // Reconstructed Pt of the W decaying into electrons
    TH1F *fHist_W_lept_notop_reco_Mt_e_minus;  // Reconstructed invariant transverse mass of the W decaying into e-
    TH1F *fHist_W_lept_notop_reco_phi_e_minus; // Reconstructed azimuth angle of the (real) W decaying into e-
    TH1F *fHist_W_lept_notop_reco_pt_e_minus;  // Reconstructed Pt of the W decaying into e-
    TH1F *fHist_W_lept_notop_reco_Mt_e_plus;   // Reconstructed invariant transverse mass of the W decaying into e+
    TH1F *fHist_W_lept_notop_reco_phi_e_plus;  // Reconstructed azimuth angle of the (real) W decaying into e+
    TH1F *fHist_W_lept_notop_reco_pt_e_plus;   // Reconstructed Pt of the W decaying into e+
  
    TH1F *fHist_W_lept_notop_reco_Mt_mu;        // Reconstructed invariant transverse mass of the W decaying into muons
    TH1F *fHist_W_lept_notop_reco_phi_mu;       // Reconstructed azimuth angle of the W decaying into muons
    TH1F *fHist_W_lept_notop_reco_pt_mu;        // Reconstructed Pt of the W decaying into muons
    TH1F *fHist_W_lept_notop_reco_Mt_mu_minus;  // Reconstructed invariant transverse mass of the W decaying into mu-
    TH1F *fHist_W_lept_notop_reco_phi_mu_minus; // Reconstructed azimuth angle of the W decaying into mu-
    TH1F *fHist_W_lept_notop_reco_pt_mu_minus;  // Reconstructed Pt of the W decaying into mu-
    TH1F *fHist_W_lept_notop_reco_Mt_mu_plus;   // Reconstructed invariant transverse mass of the W decaying into mu+
    TH1F *fHist_W_lept_notop_reco_phi_mu_plus;  // Reconstructed azimuth angle of the W decaying into mu+
    TH1F *fHist_W_lept_notop_reco_pt_mu_plus;   // Reconstructed Pt of the W decaying into mu+

    // histograms for charged lepton in hadronic top decays
    TH1F *fHist_HadronicTop_ChargedLepton_pt;   // pt of Charged Lepton in hadronic top decays
    TH1F *fHist_HadronicTop_ChargedLepton_eta;  // eta of Charged Lepton in hadronic top decays
    TH1F *fHist_HadronicTop_ChargedLepton_phi;  // phi of Charged Lepton in hadronic top decays
    TH1F *fHist_HadronicTop_electron_pt;   // pt of electron in hadronic top decays
    TH1F *fHist_HadronicTop_electron_eta;  // eta of electron in hadronic top decays
    TH1F *fHist_HadronicTop_electron_phi;  // phi of electron in hadronic top decays
    TH1F *fHist_HadronicTop_muon_pt;   // pt of muon in hadronic top decays
    TH1F *fHist_HadronicTop_muon_eta;  // eta of muon in hadronic top decays
    TH1F *fHist_HadronicTop_muon_phi;  // phi of muon in hadronic top decays

    // histograms for EtMiss in hadronic top decays
    TH1F *fHist_HadronicTop_EtMiss_mag;   // EtMiss in hadronic top decays
    TH1F *fHist_HadronicTop_EtMiss_phi;   // phi of EtMiss in hadronic top decays
    
    //    ---    hadronic decays  
    TH1F *fHist_W_hadr_notop_reco_Mt;        // Reconstructed invariant transverse mass of the associated
                                             // hadronic W (all leptons)
    TH1F *fHist_W_hadr_notop_reco_M;         // Reconstructed invariant mass of that W (all leptons)
    TH1F *fHist_W_hadr_notop_reco_pt;        // Reconstructed pt of that W (all leptons)
    TH1F *fHist_W_hadr_notop_reco_eta;       // Reconstructed pseudorapidity of that W (all leptons)
    TH1F *fHist_W_hadr_notop_reco_phi;       // Reconstructed azimuth angle of that W (all leptons)
    TH1F *fHist_W_hadr_notop_reco_rap;       // Reconstructed y of  that W (all leptons)
    // electron channel
    TH1F *fHist_W_hadr_notop_reco_Mt_e;        // Reconstructed invariant transverse mass of the associated
                                               // hadronic W in the electron channel
    TH1F *fHist_W_hadr_notop_reco_M_e;         // Reconstructed invariant mass of that W
    TH1F *fHist_W_hadr_notop_reco_phi_e;       // Reconstructed azimuth angle of that W
    TH1F *fHist_W_hadr_notop_reco_pt_e;        // Reconstructed Pt of that W
    TH1F *fHist_W_hadr_notop_reco_rap_e;       // Reconstructed rapidity of that W
    // muon channel
    TH1F *fHist_W_hadr_notop_reco_Mt_mu;        // Reconstructed invariant transverse mass of the associated
                                                // hadronic W in the muon channel
    TH1F *fHist_W_hadr_notop_reco_M_mu;         // Reconstructed invariant mass of that W
    TH1F *fHist_W_hadr_notop_reco_phi_mu;       // Reconstructed azimuth angle of that W
    TH1F *fHist_W_hadr_notop_reco_pt_mu;        // Reconstructed Pt of that W
    TH1F *fHist_W_hadr_notop_reco_rap_mu;       // Reconstructed rapidity of that W
    
                                // (all negative sign leptons)
    TH1F *fHist_W_hadr_notop_reco_M_minus;  // Reconstructed invariant mass of the W
    TH1F *fHist_W_hadr_notop_reco_Mt_minus;  // Reconstructed invariant transverse mass of the W
    TH1F *fHist_W_hadr_notop_reco_pt_minus;  // Reconstructed transverse momentum of the W (all negative sign leptons)
    TH1F *fHist_W_hadr_notop_reco_phi_minus; // Reconstructed azimuth angle of the W (all negative sign leptons)
    TH1F *fHist_W_hadr_notop_reco_eta_minus; // Reconstructed eta of the W (all negative sign leptons)
    TH1F *fHist_W_hadr_notop_reco_rap_minus; // Reconstructed y of the W (all negative sign leptons)
                                // (all positive sign leptons)
    TH1F *fHist_W_hadr_notop_reco_M_plus;   // Reconstructed invariant mass of the W
    TH1F *fHist_W_hadr_notop_reco_Mt_plus;   // Reconstructed invariant transverse mass of the W
    TH1F *fHist_W_hadr_notop_reco_phi_plus;  // Reconstructed azimuth angle of the W (all positive sign leptons)
    TH1F *fHist_W_hadr_notop_reco_eta_plus;  // Reconstructed eta of the W (all positive sign leptons)
    TH1F *fHist_W_hadr_notop_reco_rap_plus;  // Reconstructed y of the W (all positive sign leptons)
    TH1F *fHist_W_hadr_notop_reco_pt_plus;   // Reconstructed Pt of the W (all positive sign leptons)

    TH1F *fHist_W_hadr_notop_reco_Mt_e_minus;  // Reconstructed invariant transverse mass of the W decaying into e-
    TH1F *fHist_W_hadr_notop_reco_phi_e_minus; // Reconstructed azimuth angle of the (real) W decaying into e-
    TH1F *fHist_W_hadr_notop_reco_pt_e_minus;  // Reconstructed Pt of the W decaying into e-
    TH1F *fHist_W_hadr_notop_reco_Mt_e_plus;   // Reconstructed invariant transverse mass of the W decaying into e+
    TH1F *fHist_W_hadr_notop_reco_phi_e_plus;  // Reconstructed azimuth angle of the (real) W decaying into e+
    TH1F *fHist_W_hadr_notop_reco_pt_e_plus;   // Reconstructed Pt of the W decaying into e+
  
    TH1F *fHist_W_hadr_notop_reco_Mt_mu_minus;  // Reconstructed invariant transverse mass of the W decaying into mu-
    TH1F *fHist_W_hadr_notop_reco_phi_mu_minus; // Reconstructed azimuth angle of the W decaying into mu-
    TH1F *fHist_W_hadr_notop_reco_pt_mu_minus;  // Reconstructed Pt of the W decaying into mu-
    TH1F *fHist_W_hadr_notop_reco_Mt_mu_plus;   // Reconstructed invariant transverse mass of the W decaying into mu+
    TH1F *fHist_W_hadr_notop_reco_phi_mu_plus;  // Reconstructed azimuth angle of the W decaying into mu+
    TH1F *fHist_W_hadr_notop_reco_pt_mu_plus;   // Reconstructed Pt of the W decaying into mu+

    // top quark reconstruction histograms
    // leptonic decay of the top
    TH1F *fHistLeptonicTop_Mt;        // Reconstructed invariant transverse mass of the single-top
                                  // (all leptons)
    TH1F *fHistLeptonicTop_M;        // Reconstructed invariant mass of the single-top
	                          // (all leptons)
    TH1F *fHistLeptonicTop_phi;       // Reconstructed azimuth angle of the single-top (all leptons)
    TH1F *fHistLeptonicTop_eta;       // Reconstructed Eta of the single-top (all leptons)
    TH1F *fHistLeptonicTop_rap;       // Reconstructed y of the single-top (all leptons)
    TH1F *fHistLeptonicTop_pt;        // Reconstructed Pt of the single-top (all leptons)
    TH1F *fHistLeptonicTop_Mt_plus;   // Reconstructed invariant transverse mass of the single-top
                                  // (all positive sign leptons)
    TH1F *fHistLeptonicTop_M_plus;   // Reconstructed invariant mass of the single-top
                                  // (all positive sign leptons)
    TH1F *fHistLeptonicTop_phi_plus;  // Reconstructed azimuth angle of the single-top
                                  // (all positive sign leptons)
    TH1F *fHistLeptonicTop_eta_plus;  // Reconstructed Eta of the single-top (all positive sign leptons)
    TH1F *fHistLeptonicTop_rap_plus;  // Reconstructed y of the single-top (all positive sign leptons)
    TH1F *fHistLeptonicTop_pt_plus;   // Reconstructed Pt of the single-top (all positive sign leptons)
    TH1F *fHistLeptonicTop_Mt_minus;  // Reconstructed invariant transverse mass of the single-top
                                  // (all negative sign leptons)
    TH1F *fHistLeptonicTop_M_minus;  // Reconstructed invariant mass of the single-top
	                          // (all negative sign leptons)
    TH1F *fHistLeptonicTop_phi_minus; // Reconstructed azimuth angle of the single-top
                                  // (all negative sign leptons)
    TH1F *fHistLeptonicTop_eta_minus; // Reconstructed Eta of the single-top (all negative sign leptons)
    TH1F *fHistLeptonicTop_rap_minus; // Reconstructed y of the single-top (all negative sign leptons)
    TH1F *fHistLeptonicTop_pt_minus;  // Reconstructed Pt of the single-top (all negative sign leptons)

    TH1F *fHistLeptonicTop_Mt_e;        // Reconstructed invariant transverse mass of the single-top (e channel)
    TH1F *fHistLeptonicTop_M_e;        // Reconstructed invariant mass of the single-top (e channel)
    TH1F *fHistLeptonicTop_phi_e;       // Reconstructed azimuth angle of the single-top (e channel)
    TH1F *fHistLeptonicTop_eta_e;       // Reconstructed Eta of the single-top (e channel)
    TH1F *fHistLeptonicTop_rap_e;       // Reconstructed y of the top (e channel)
    TH1F *fHistLeptonicTop_pt_e;        // Reconstructed Pt of the single-top (e channel)
    TH1F *fHistLeptonicTop_Mt_e_plus;   // Reconstructed invariant transverse mass of the single-top
                                    // (e+ channel)
    TH1F *fHistLeptonicTop_M_e_plus;   // Reconstructed invariant mass of the single-top
                                    // (e+ channel)
    TH1F *fHistLeptonicTop_phi_e_plus;  // Reconstructed azimuth angle of the single-top (e+ channel)
    TH1F *fHistLeptonicTop_eta_e_plus;  // Reconstructed Eta of the single-top (e+ channel)
    TH1F *fHistLeptonicTop_rap_e_plus;  // Reconstructed y of the single-top (e+ channel)
    TH1F *fHistLeptonicTop_pt_e_plus;   // Reconstructed Pt of the single-top (e+ channel)
    TH1F *fHistLeptonicTop_Mt_e_minus;  // Reconstructed invariant transverse mass of the single-top
                                    // (e- channel)
    TH1F *fHistLeptonicTop_M_e_minus;  // Reconstructed invariant mass of the single-top
                                    // (e- channel)
    TH1F *fHistLeptonicTop_phi_e_minus; // Reconstructed azimuth angle of the single-top (e- channel)
    TH1F *fHistLeptonicTop_eta_e_minus; // Reconstructed Eta of the single-top (e- channel)
    TH1F *fHistLeptonicTop_rap_e_minus; // Reconstructed y of the single-top (e- channel)
    TH1F *fHistLeptonicTop_pt_e_minus;  // Reconstructed Pt of the single-top (e- channel)
  
    TH1F *fHistLeptonicTop_Mt_mu;        // Reconstructed invariant transverse mass of the single-top
                                     // (mu channel)
    TH1F *fHistLeptonicTop_M_mu;        // Reconstructed invariant mass of the single-top
                                     // (mu channel)
    TH1F *fHistLeptonicTop_phi_mu;       // Reconstructed azimuth angle of the single-top (mu channel)
    TH1F *fHistLeptonicTop_eta_mu;       // Reconstructed Eta of the single-top (mu channel)
    TH1F *fHistLeptonicTop_rap_mu;       // Reconstructed y of the single-top (mu channel)
    TH1F *fHistLeptonicTop_pt_mu;        // Reconstructed Pt of the single-top (mu channel)
    TH1F *fHistLeptonicTop_Mt_mu_plus;   // Reconstructed invariant transverse mass of the single-top
                                     // (mu+ channel)
    TH1F *fHistLeptonicTop_M_mu_plus;   // Reconstructed invariant mass of the single-top
	                             // (mu+ channel)
    TH1F *fHistLeptonicTop_phi_mu_plus;  // Reconstructed azimuth angle of the single-top (mu+ channel)
    TH1F *fHistLeptonicTop_eta_mu_plus;  // Reconstructed Eta of the single-top (mu+ channel)
    TH1F *fHistLeptonicTop_rap_mu_plus;  // Reconstructed y of the single-top (mu+ channel)
    TH1F *fHistLeptonicTop_pt_mu_plus;   // Reconstructed Pt of the single-top (mu+ channel)
    TH1F *fHistLeptonicTop_Mt_mu_minus;  // Reconstructed invariant transverse mass of the single-top
                                     // (mu- channel)
    TH1F *fHistLeptonicTop_M_mu_minus;  // Reconstructed invariant mass of the single-top
                                     // (mu- channel)
    TH1F *fHistLeptonicTop_phi_mu_minus; // Reconstructed azimuth angle of the single-top (mu- channel)
    TH1F *fHistLeptonicTop_eta_mu_minus; // Reconstructed Eta of the single-top (mu- channel)
    TH1F *fHistLeptonicTop_rap_mu_minus; // Reconstructed y of the single-top (mu- channel)
    TH1F *fHistLeptonicTop_pt_mu_minus;  // Reconstructed Pt of the single-top (mu- channel)

    // hadronic decay of the top
    // all leptons
    TH1F *fHistHadronicTop_Mt;        // Reconstructed invariant transverse mass of the hadronic top
                                      // (all leptons)
    TH1F *fHistHadronicTop_M;         // Reconstructed invariant mass of the hadronic top
	                              // (all leptons)
    TH1F *fHistHadronicTop_phi;       // Reconstructed azimuth angle of the hadronic top (all leptons)
    TH1F *fHistHadronicTop_eta;       // Reconstructed Eta of the hadronic top (all leptons)
    TH1F *fHistHadronicTop_rap;       // Reconstructed y of the hadronic top (all leptons)
    TH1F *fHistHadronicTop_pt;        // Reconstructed Pt of the hadronic top (all leptons)
    // electrons
    TH1F *fHistHadronicTop_Mt_e;        // Reconstructed invariant transverse mass of the hadronic top,
                                      // electrons
    TH1F *fHistHadronicTop_M_e;         // Reconstructed invariant mass of the hadronic top,
	                              // electrons
    TH1F *fHistHadronicTop_phi_e;       // Reconstructed azimuth angle of the hadronic top, electrons
    TH1F *fHistHadronicTop_eta_e;       // Reconstructed Eta of the hadronic top, electrons
    TH1F *fHistHadronicTop_rap_e;       // Reconstructed y of the hadronic top, electrons
    TH1F *fHistHadronicTop_pt_e;        // Reconstructed Pt of the hadronic top, electrons
    // muons
    TH1F *fHistHadronicTop_Mt_mu;        // Reconstructed invariant transverse mass of the hadronic top,
                                         // muons
    TH1F *fHistHadronicTop_M_mu;         // Reconstructed invariant mass of the hadronic top,
	                                 // muons
    TH1F *fHistHadronicTop_phi_mu;       // Reconstructed azimuth angle of the hadronic top, muons
    TH1F *fHistHadronicTop_eta_mu;       // Reconstructed Eta of the hadronic top, muons
    TH1F *fHistHadronicTop_rap_mu;       // Reconstructed y of the hadronic top, muons
    TH1F *fHistHadronicTop_pt_mu;        // Reconstructed Pt of the hadronic top, muons
    
    TH1F *fHistHadronicTop_Mt_plus;   // Reconstructed invariant transverse mass of the hadronic top
                                  // (all positive sign leptons)
    TH1F *fHistHadronicTop_M_plus;   // Reconstructed invariant mass of the hadronic top
                                  // (all positive sign leptons)
    TH1F *fHistHadronicTop_phi_plus;  // Reconstructed azimuth angle of the hadronic top
                                  // (all positive sign leptons)
    TH1F *fHistHadronicTop_eta_plus;  // Reconstructed Eta of the hadronic top (all positive sign leptons)
    TH1F *fHistHadronicTop_rap_plus;  // Reconstructed y of the hadronic top (all positive sign leptons)
    TH1F *fHistHadronicTop_pt_plus;   // Reconstructed Pt of the hadronic top (all positive sign leptons)
    TH1F *fHistHadronicTop_Mt_minus;  // Reconstructed invariant transverse mass of the hadronic top
                                  // (all negative sign leptons)
    TH1F *fHistHadronicTop_M_minus;  // Reconstructed invariant mass of the hadronic top
	                          // (all negative sign leptons)
    TH1F *fHistHadronicTop_phi_minus; // Reconstructed azimuth angle of the hadronic top
                                  // (lal negative sign leptons)
    TH1F *fHistHadronicTop_eta_minus; // Reconstructed Eta of the hadronic top (all negative sign leptons)
    TH1F *fHistHadronicTop_rap_minus; // Reconstructed y of the hadronic top (all negative sign leptons)
    TH1F *fHistHadronicTop_pt_minus;  // Reconstructed Pt of the hadronic top (all negative sign leptons)
    
    // neutrino reconstruction histograms - leptonic top
    // all leptons
    TH1F *fHistLeptonicTopNuReco_phi;       // Reconstructed azimuth angle of the neutrino (all leptons)
    TH1F *fHistLeptonicTopNuReco_eta;       // Reconstructed Eta of the neutrino (all leptons)
    TH1F *fHistLeptonicTopNuReco_E;         // Reconstructed energy of the neutrino (all leptons)
    TH1F *fHistLeptonicTopNuReco_pt;        // Reconstructed Pt of the neutrino (all leptons)
    // electrons
    TH1F *fHistLeptonicTopNuReco_phi_e;       // Reconstructed azimuth angle of the neutrino (el channel)
    TH1F *fHistLeptonicTopNuReco_eta_e;       // Reconstructed Eta of the neutrino (el channel)
    TH1F *fHistLeptonicTopNuReco_E_e; // Reconstructed energy of the neutrino (el channel)
    TH1F *fHistLeptonicTopNuReco_pt_e;        // Reconstructed Pt of the neutrino (el channel)
    // muons
    TH1F *fHistLeptonicTopNuReco_phi_mu;       // Reconstructed azimuth angle of the neutrino (mu channel)
    TH1F *fHistLeptonicTopNuReco_eta_mu;       // Reconstructed Eta of the neutrino (mu channel)
    TH1F *fHistLeptonicTopNuReco_E_mu; // Reconstructed energy of the neutrino (mu channel)
    TH1F *fHistLeptonicTopNuReco_pt_mu;        // Reconstructed Pt of the neutrino (mu channel)

    TH1F *fHistLeptonicTopNuReco_phi_plus;  // Reconstructed azimuth angle of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_eta_plus;  // Reconstructed Eta of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_E_plus; // Reconstructed energy of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_pt_plus;   // Reconstructed Pt of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_phi_minus; // Reconstructed azimuth angle of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_eta_minus; // Reconstructed Eta of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_E_minus; // Reconstructed energy of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_pt_minus;  // Reconstructed Pt of the neutrino (e- channel)
    
    TH1F *fHistLeptonicTopNuReco_phi_e_plus;  // Reconstructed azimuth angle of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_eta_e_plus;  // Reconstructed Eta of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_E_e_plus; // Reconstructed energy of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_pt_e_plus;   // Reconstructed Pt of the neutrino (e+ channel)
    TH1F *fHistLeptonicTopNuReco_phi_e_minus; // Reconstructed azimuth angle of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_eta_e_minus; // Reconstructed Eta of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_E_e_minus; // Reconstructed energy of the neutrino (e- channel)
    TH1F *fHistLeptonicTopNuReco_pt_e_minus;  // Reconstructed Pt of the neutrino (e- channel)
    
    TH1F *fHistLeptonicTopNuReco_phi_mu_plus;  // Reconstructed azimuth angle of the neutrino (mu+ channel)
    TH1F *fHistLeptonicTopNuReco_eta_mu_plus;  // Reconstructed Eta of the neutrino (mu+ channel)
    TH1F *fHistLeptonicTopNuReco_E_mu_plus; // Reconstructed energy of the neutrino (mu+ channel)
    TH1F *fHistLeptonicTopNuReco_pt_mu_plus;   // Reconstructed Pt of the neutrino (mu+ channel)
    TH1F *fHistLeptonicTopNuReco_phi_mu_minus; // Reconstructed azimuth angle of the neutrino (mu- channel)
    TH1F *fHistLeptonicTopNuReco_eta_mu_minus; // Reconstructed Eta of the neutrino (mu- channel)
    TH1F *fHistLeptonicTopNuReco_E_mu_minus; // Reconstructed energy of the neutrino (mu- channel)
    TH1F *fHistLeptonicTopNuReco_pt_mu_minus;  // Reconstructed Pt of the neutrino (mu- channel)

    // chi-square and chi-square probability distributions for e, mu channels and both 
    //- from leptonic top decay
    TH1F * fHistChi2NDOF_both;
    TH1F * fHistChi2Prob_both_after;
    TH1F * fHistChi2_both_after;
    TH1F * fHistChi2NDOF_both_after;
    TH1F * fHistLeptonicTopChi2NDOF_both;
    TH1F * fHistLeptonicTopChi2_both_after;
    TH1F * fHistLeptonicTopChi2Prob_both_after;
    TH1F * fHistLeptonicTopChi2NDOF_both_after;
    TH1F * fHistHadronicTopChi2NDOF_both;
    TH1F * fHistHadronicTopChi2_both_after;
    TH1F * fHistHadronicTopChi2Prob_both_after;
    TH1F * fHistHadronicTopChi2NDOF_both_after;




    
    TH1F *fHistLeptonicTopChi2_both;          // chi-square of both W decays
    TH1F *fHistLeptonicTopChi2Prob_both;      // chi-square probability of both W decays
    TH1F *fHistLeptonicTopChi2ProbTTBarVeto;  // chi-square probability for TTBar Veto and Wt reconstruction
                                              // with a leptonic top decay
    TH2F *fHistLeptonicTopChi2ProbWtAndTTBar; // histogram for chi-square probability of Wt reconstruction
                                              // (with leptonic top decay) and of TTBar veto reconstruction
    TH1F *fHistLeptonicTopChi2_e;             // chi-square of e channel
    TH1F *fHistLeptonicTopChi2Prob_e;         // chi-square probability of e channel
    TH1F *fHistLeptonicTopChi2_mu;            // chi-square of mu channel
    TH1F *fHistLeptonicTopChi2Prob_mu;        // chi-square probability of mu channel
    TH2F *fHist_LeptonicTopChi2Prob_vs_M_invar_W;   // 2D: chi-square probability vs invariant mass of W-boson
    TH2F *fHist_LeptonicTopChi2Prob_vs_M_invar_top; // 2D: chi-square probability vs invariant mass of top-quark
    // chi-square and chi-square probability distributions
    // - from hadronic top decay
    TH1F *fHistHadronicTopChi2_both;          // chi-square of both W decays
    TH1F *fHistHadronicTopChi2Prob_both;      // chi-square probability of both W decays
    TH1F *fHistHadronicTopChi2ProbTTBarVeto;  // chi-square probability for TTBar Veto and Wt reconstruction
                                              // with a hadronic top decay
    TH2F *fHistHadronicTopChi2ProbWtAndTTBar; // histogram for chi-square probability of Wt reconstruction
                                              // (with hadronic top decay) and of TTBar veto reconstruction
    TH1F *fHistHadronicTopChi2_e;             // chi-square of electronic W decays
    TH1F *fHistHadronicTopChi2Prob_e;         // chi-square probability of electronic W decays
    TH1F *fHistHadronicTopChi2_mu;            // chi-square of muonic W decays
    TH1F *fHistHadronicTopChi2Prob_mu;        // chi-square probability of muonic W decays
    TH2F *fHist_HadronicTopChi2Prob_vs_M_invar_W; // 2D: chi-square probability vs invariant mass of W-boson
    TH2F *fHist_HadronicTopChi2Prob_vs_M_invar_top; // 2D: chi-square probability vs invariant mass of top-quark

    TH1F *fHistChi2Prob_both;      // chi-square probability for leptonic and hadronic top
                                   // decays. This is the sum of the corresponding histograms
                                   // for the two semileptonic decay modes.
    TH1F *fHistChi2_both;          // corresponding chi-square histogram
    TH1F *fHistChi2Red_both;
    // After ProbChi2 cut ///////////////////////////////////////////////////////////////////////////////////////

    // chi-square and chi-square probability distributions for e, mu channels and both 
    //- from leptonic top decay
    TH1F *fHistLeptonicTopChi2_both_cut;          // chi-square of both W decays
    TH1F *fHistLeptonicTopChi2Prob_both_cut;      // chi-square probability of both W decays
    TH1F *fHistLeptonicTopChi2ProbTTBarVeto_cut;  // chi-square probability for TTBar Veto and Wt reconstruction
                                              // with a leptonic top decay
    TH2F *fHistLeptonicTopChi2ProbWtAndTTBar_cut; // histogram for chi-square probability of Wt reconstruction
                                              // (with leptonic top decay) and of TTBar veto reconstruction
    TH1F *fHistLeptonicTopChi2_e_cut;             // chi-square of e channel
    TH1F *fHistLeptonicTopChi2Prob_e_cut;         // chi-square probability of e channel
    TH1F *fHistLeptonicTopChi2_mu_cut;            // chi-square of mu channel
    TH1F *fHistLeptonicTopChi2Prob_mu_cut;        // chi-square probability of mu channel
    TH2F *fHist_LeptonicTopChi2Prob_vs_M_invar_W_cut;   // 2D: chi-square probability vs invariant mass of W-boson
    TH2F *fHist_LeptonicTopChi2Prob_vs_M_invar_top_cut; // 2D: chi-square probability vs invariant mass of top-quark
    // chi-square and chi-square probability distributions
    // - from hadronic top decay
    TH1F *fHistHadronicTopChi2_both_cut;          // chi-square of both W decays
    TH1F *fHistHadronicTopChi2Prob_both_cut;      // chi-square probability of both W decays
    TH1F *fHistHadronicTopChi2ProbTTBarVeto_cut;  // chi-square probability for TTBar Veto and Wt reconstruction
                                              // with a hadronic top decay
    TH2F *fHistHadronicTopChi2ProbWtAndTTBar_cut; // histogram for chi-square probability of Wt reconstruction
                                              // (with hadronic top decay) and of TTBar veto reconstruction
    TH1F *fHistHadronicTopChi2_e_cut;             // chi-square of electronic W decays
    TH1F *fHistHadronicTopChi2Prob_e_cut;         // chi-square probability of electronic W decays
    TH1F *fHistHadronicTopChi2_mu_cut;            // chi-square of muonic W decays
    TH1F *fHistHadronicTopChi2Prob_mu_cut;        // chi-square probability of muonic W decays
    TH2F *fHist_HadronicTopChi2Prob_vs_M_invar_W_cut; // 2D: chi-square probability vs invariant mass of W-boson
    TH2F *fHist_HadronicTopChi2Prob_vs_M_invar_top_cut; // 2D: chi-square probability vs invariant mass of top-quark

    TH1F *fHistChi2Prob_both_cut;      // chi-square probability for leptonic and hadronic top
                                   // decays. This is the sum of the corresponding histograms
                                   // for the two semileptonic decay modes.
    TH1F *fHistChi2_both_cut;          // corresponding chi-square histogram

    // end ///////////////////////////////////////////////////////////////////////////////////////////////////////
    
    // Truth Matching histograms
    // all histograms show the reconstructed value (e.g. pt) minus
    // the true value over the true value

    TH1I *fHistLeptonicTopRecoTrueChannel; // histograms to compare reconstructed channel
                                           // with true channel in case of reconstructed
                                           // leptonic top decay
    TH1I *fHistHadronicTopRecoTrueChannel; // histograms to compare reconstructed channel
                                           // with true channel in case of reconstructed
                                           // leptonic top decay
    
    // charged lepton
    // truth matching with DeltaR and DeltaPtFraction
    TH1F *fHistLeptonicTopElecTruthMatch_pt;     // pt of Electron, leptonic top decay
    TH1F *fHistLeptonicTopElecTruthMatch_eta;    // eta of Electron, leptonic top decay
    TH1F *fHistLeptonicTopElecTruthMatch_phi;    // phi of Electron, leptonic top decay
    TH1F *fHistLeptonicTopMuTruthMatch_pt;       // pt of Muon, leptonic top decay
    TH1F *fHistLeptonicTopMuTruthMatch_eta;      // eta of Muon, leptonic top decay
    TH1F *fHistLeptonicTopMuTruthMatch_phi;      // phi of Muon, leptonic top decay
    
    // Neutrino
    TH1F *fHistLeptonicTopNuTruthMatch_pt;       // pt of Neutrino, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopNuTruthMatch_theta;    // theta of Neutrino, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopNuTruthMatch_eta;      // eta of Neutrino, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopNuTruthMatch_phi;      // phi of Neutrino, electron- and muon-channel,
                                                 // leptonic top decay
    
    // b-quark
    // matching of the jet done w.r.t. the MC b-quark
    TH1F *fHistLeptonicTopBottomTruthMatch_pt;   // pt of b-quark, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopBottomTruthMatch_eta;  // eta of b-quark, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopBottomTruthMatch_phi;  // phi of b-quark, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistHadronicTopBottomTruthMatch_pt;   // pt of b-quark, electron- and muon-channel,
                                                 // hadronic top decay
    TH1F *fHistHadronicTopBottomTruthMatch_eta;  // eta of b-quark, electron- and muon-channel,
                                                 // hadronic top decay
    TH1F *fHistHadronicTopBottomTruthMatch_phi;  // phi of b-quark, electron- and muon-channel,
                                                 // hadronic top decay

    // matching of the jet w.r.t. the hadron level jet
    // which matches the true b quark best
    TH1F *fHistLeptonicTopBHJetTruthMatch_pt;    // pt of b-jet, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopBHJetTruthMatch_eta;   // eta of b-jet, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistLeptonicTopBHJetTruthMatch_phi;   // phi of b-jet, electron- and muon-channel,
                                                 // leptonic top decay
    TH1F *fHistHadronicTopBHJetTruthMatch_pt;    // pt of b-jet, electron- and muon-channel,
                                                 // hadronic top decay
    TH1F *fHistHadronicTopBHJetTruthMatch_eta;   // eta of b-jet, electron- and muon-channel,
                                                 // hadronic top decay
    TH1F *fHistHadronicTopBHJetTruthMatch_phi;   // phi of b-jet, electron- and muon-channel,
                                                 // hadronic top decay

    // matching of jets from hadronic W decay
    // w.r.t. original quarks from W boson decay
    // and w.r.t. hadron level jets matching those
    // quarks best
    TH1F *fHistLeptonicTopWQuarkTruthMatch_pt;  // pt of jets from W decay, electron- and muon-channel,
                                                // leptonic top decay, comparing with quarks
    TH1F *fHistLeptonicTopWQuarkTruthMatch_eta; // eta of jets from W decay, electron- and muon-channel,
                                                // leptonic top decay, comparing with quarks
    TH1F *fHistLeptonicTopWQuarkTruthMatch_phi; // phi of jets from W decay, electron- and muon-channel,
                                                //  top decay, comparing with quarks
    TH1F *fHistHadronicTopWQuarkTruthMatch_pt;  // pt of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with quarks
    TH1F *fHistHadronicTopWQuarkTruthMatch_eta; // eta of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with quarks
    TH1F *fHistHadronicTopWQuarkTruthMatch_phi; // phi of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with quarks
    TH1F *fHistLeptonicTopWHLJetTruthMatch_pt;  // pt of jets from W decay, electron- and muon-channel,
                                                // leptonic top decay, comparing with hadron level jets
    TH1F *fHistLeptonicTopWHLJetTruthMatch_eta; // eta of jets from W decay, electron- and muon-channel,
                                                // leptonic top decay, comparing with hadron level jets
    TH1F *fHistLeptonicTopWHLJetTruthMatch_phi; // phi of jets from W decay, electron- and muon-channel,
                                                // leptonic top decay, comparing with hadron level jets
    TH1F *fHistHadronicTopWHLJetTruthMatch_pt;  // pt of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with hadron level jets
    TH1F *fHistHadronicTopWHLJetTruthMatch_eta; // eta of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with hadron level jets
    TH1F *fHistHadronicTopWHLJetTruthMatch_phi; // phi of jets from W decay, electron- and muon-channel,
                                                // hadronic top decay, comparing with hadron level jets
    TH1F *fHistPullElecPt;
    TH1F *fHistPullElecEta;
    TH1F *fHistPullElecPhi;
    TH1F *fHistPullMuonPt;
    TH1F *fHistPullMuonEta;
    TH1F *fHistPullMuonPhi;
    TH1F *fHistPullEtMissMag;
    TH1F *fHistPullEtMissPhi;
    TH1F *fHistPullBJetPt;
    TH1F *fHistPullBJetEta;
    TH1F *fHistPullBJetPhi;
    TH1F *fHistPullJet1Pt;
    TH1F *fHistPullJet1Eta;
    TH1F *fHistPullJet1Phi;
    TH1F *fHistPullJet2Pt;
    TH1F *fHistPullJet2Eta;
    TH1F *fHistPullJet2Phi;

    TH1F *fHistPullElecPt_had;
    TH1F *fHistPullElecEta_had;
    TH1F *fHistPullElecPhi_had;
    TH1F *fHistPullMuonPt_had;
    TH1F *fHistPullMuonEta_had;
    TH1F *fHistPullMuonPhi_had;
    TH1F *fHistPullEtMissMag_had;
    TH1F *fHistPullEtMissPhi_had;
    TH1F *fHistPullBJetPt_had;
    TH1F *fHistPullBJetEta_had;
    TH1F *fHistPullBJetPhi_had;
    TH1F *fHistPullJet1Pt_had;
    TH1F *fHistPullJet1Eta_had;
    TH1F *fHistPullJet1Phi_had;
    TH1F *fHistPullJet2Pt_had;
    TH1F *fHistPullJet2Eta_had;
    TH1F *fHistPullJet2Phi_had;

    TH1F *fHistResidualElecPt;
    TH1F *fHistResidualElecEta;
    TH1F *fHistResidualElecPhi;
    TH1F *fHistResidualMuonPt;
    TH1F *fHistResidualMuonEta;
    TH1F *fHistResidualMuonPhi;
    TH1F *fHistResidualEtMissMag;
    TH1F *fHistResidualEtMissPhi;
    TH1F *fHistResidualBJetPt;
    TH1F *fHistResidualBJetEta;
    TH1F *fHistResidualBJetPhi;
    TH1F *fHistResidualJet1Pt;
    TH1F *fHistResidualJet1Eta;
    TH1F *fHistResidualJet1Phi;
    TH1F *fHistResidualJet2Pt;
    TH1F *fHistResidualJet2Eta;
    TH1F *fHistResidualJet2Phi;

    TH1F *fHistResidualBJetPt_had;
    TH1F *fHistResidualBJetEta_had;
    TH1F *fHistResidualBJetPhi_had;
    TH1F *fHistResidualJet1Pt_had;
    TH1F *fHistResidualJet1Eta_had;
    TH1F *fHistResidualJet1Phi_had;
    TH1F *fHistResidualJet2Pt_had;
    TH1F *fHistResidualJet2Eta_had;
    TH1F *fHistResidualJet2Phi_had;

    // Jet bin counts
    TH1F *fHistJetBins_pretag;
    TH1F *fHistJetBins_tag;
    TH1F *fHistJetBins_fit;

    // theta and phi histograms for ntuple
    TH1F *fhist_fCosPhiAngleWTop;
    TH1F *fhist_fCosPhiAngleAssociateWTop;
    TH1F *fhist_fCosPhiAngleAssociateWW;
    TH1F *fhist_fWFrameCosThetaStar_DeltaWtop_bW;
    TH1F *fhist_fTopFrameCosThetaStar_DeltaWtop_btop;
    TH1F *fhist_fCosThetaStarLeptNeutrino_LeptTop;
    TH1F *fhist_fTopFrameCosThetaStarWb_LeptTop;
    TH1F *fhist_fCosThetaStar1_LeptTop;
    TH1F *fhist_fCosThetaStar2_LeptTop;
    TH1F *fhist_fLogBest;
    TH1F *fhist_fLogBest1;
    TH1F *fhist_fLogBest2;
    TH1F *fhist_fLogBest3;
    TH1F *fhist_fLogBestlast;
    TH1F *fhist_fLogLept;
    TH1F *fhist_fLogHadr;
    TH1F *fhist_fPWtRatio;
    TH1F *fhist_fPWtSum;
    TH1F *fhist_fPWtDiff;
    TH1F *fhist_fPWtAsymmetry;
    TH1F *fhist_fLogPWtRatio;
    TH1F *fhist_fLogPWtSum;
    TH1F *fhist_fLogPWtDiff;
    TH1F *fhist_fLogPWtAsymmetry;
    TH1F *fhist_fLogBest_logscale;
    TH1F *fhist_fLogLept_logscale;
    TH1F *fhist_fLogHadr_logscale;
    TH1F *fhist_fPWtRatio_logscale;
    TH1F *fhist_fPWtSum_logscale;
    TH1F *fhist_fPWtDiff_logscale;
    TH1F *fhist_fPWtAsymmetry_logscale;
    TH1F *fhist_fLogPWtRatio_logscale;
    TH1F *fhist_fLogPWtSum_logscale;
    TH1F *fhist_fLogPWtDiff_logscale;
    TH1F *fhist_fLogPWtAsymmetry_logscale;



    
    TVector2 p_System;
    Float_t  pT_System;
    TH1F *fHist_WtSystem_Pt_nocut;        // Reconstructed transverse momentum of the W+top system
    TH1F *fHist_WtSystem_Pt;        // Reconstructed transverse momentum of the W+top system
    TH1F *fHist_EtaTop_nocut;
    TH1F *fHist_PtTop_nocut;
    TAxis *axis;
    
  public:
    Bool_t    fUseLeptonCovRand; // Use randomly generated lepton covariance matrices?
    Bool_t fIsFwdElectronMode; // Use only forward electrons when analyzing jet-electrons? If set to kFALSE, only central electrons will be analyzed.
    Float_t   fBJetWeightMin;     // Minimum b-tag weight for b-jets to be accepted

    // ntuple production
    Bool_t fProduceCommonTree; // Produce common tree for combined NN analysis?
    // variables in ntuple for common analysis
    Double_t fCosPhiAngleWTop;
    Double_t fCosPhiAngleAssociateWTop;
    Double_t fCosPhiAngleAssociateWW;
    Double_t fTopFrame_DThetaStarAssociateWTop;
    Double_t fWFrameCosThetaStar_DeltaWtop_bW;
    Double_t fTopFrameCosThetaStar_DeltaWtop_btop;

    Int_t fRunNumber;
    Int_t fLumiBlock;
    Int_t fEventNumber;
    Float_t fmc_channel_number;
    Float_t ftop_hfor_type;
    Float_t fRapTop;
    Float_t fEtaTop;
    Float_t fEtaWTop;
    Float_t fEtaNeutrino;
    
    Float_t  fEtaW_LeptTop;
    Double_t fCosThetaStarLeptNeutrino_LeptTop;
    Double_t fTopFrameCosThetaStarWb_LeptTop;
    Double_t fCosThetaStar1_LeptTop;
    Double_t fCosThetaStar2_LeptTop;
    Double_t fLogPWtBest;
    Double_t fLogPWtWorst;
    Double_t fLogPWtHadronic;
    Double_t fLogPWtLeptonic;
    Double_t fPWtRatio;
    Double_t fPWtSum;
    Double_t fPWtDiff;
    Double_t fPWtAsymmetry;
    Double_t fLogPWtRatio;
    Double_t fLogPWtSum;
    Double_t fLogPWtDiff;
    Double_t fLogPWtAsymmetry;
    
    
    Bool_t fSignalSampleMode; // Running over signal MC?
    
    Int_t fMaxNbIter;         // maximum number of iterations
    
    // Scale Factor systematics mode
    enum EScaleFactorSystematics {
	kNone,
	kElectronUp,
	kElectronDown,
	kMuonUp,
	kMuonDown,
	kJetBTagsUp,
	kJetBTagsDown,
	kJetCTagsUp,
	kJetCTagsDown,
	kJetMisTagsUp,
	kJetMisTagsDown,
	kJVFWeightUp,
	kJVFWeightDown,
	kNumSystModes
    };
    
    static const Int_t fgNSystNames;
    static const char* fgSystNames[];
    
    EScaleFactorSystematics fSFSystMode;// Scale Factor systematics mode

    Bool_t fIsAcceptanceChallenge; // Doing acceptance challenge (then write out event list!)?

    Double_t fChi2ProbMin;    // Minimum chi2-probability. Can be used later to apply
                              // the corresponding cut.
                              // So far it is only used in the cut-flow plot
    Bool_t fGuessNeutrinoEtaE;// Use routine to estimate good starting value of neutrino Eta?
    Bool_t fTruthMatch;       // Run truth-matching at all?
  
    ELeptonMode fLeptonMode;  // Indicate the lepton channel mode (e/mu/tau)

    EModeMass  fModeMass;        // Indicate the mode of mass constraint (Gauss or BW mass constraint)
    EMode      fMode;            // Indicate the mode of run (KinFit or CutBased)

    Int_t fDecayChannel;         // decay channel of Wt event for which the analysis is performed
                                 // 1: leptonic top, hadronic W decay
                                 // 2: hadronic top, leptonic W decay
                                 // 3: always perform analysis
                                 // 0: fully hadronic Wt, dileptonic Wt and Background
                                 // can be set so that the analysis is made only for
                                 // the events in the corresponding channel
    Int_t fTrueDecayChannel;     // corresponding channel of true event in MC
                                 // perform analysis only for equality or if
                                 // fDecayChannel == 3
    
    // True W and top masses for the fit
    Double_t fW_Mass;     // Pole mass of the W used in  the fit
    Double_t fW_Width;    // Width of the W used in the fit
    Double_t fTop_Mass;   // Pole mass of the t-quark used in the fit
    Double_t fTop_Width;  // Width of the t-quark used in the fit


    // chi^2 values and No. of degrees of freedom for different fits
    Double_t fchi2LeptonicTop;    // chi^2 value for leptonic top decay from KinFitter
    Double_t fchi2HadronicTop;    // chi^2 value for hadronic top decay from KinFitter
    Double_t fchi2WTop;           // chi^2 value for chosen (final) top decay from KinFitter
    Double_t fchi2ttbarBkg;       // chi^2 value for ttbar hypothesis (bkg)
    Int_t fNDoFLeptonicTop;       //  NDoF for leptonic top decay from KinFitter
    Int_t fNDoFHadronicTop;       //  NDoF for hadronic top decay from KinFitter
    Int_t fNDoFWTop;       //  NDoF for chosen top decay from KinFitter
    Int_t fNDoFttbarBkg;          //  NDoF for ttbar hypothesis (bkg)
    Double_t fchi2ProbLeptonicTop;    // chi^2 p-value for leptonic top decay from KinFitter
    Double_t fchi2ProbHadronicTop;    // chi^2 p-value for hadronic top decay from KinFitter
    Double_t fchi2ProbWTop;             // chi^2 p-value for chosen (final) top decay from KinFitter
    Double_t fchi2RedWTop;             // chi^2 p-value for chosen (final) top decay from KinFitter

    Double_t fchi2RedLeptonicTop;
    Double_t fchi2RedHadronicTop;
    Int_t    fNDoFttbarBkg_debug_LNu;
    Double_t fchi2ttbarBkg_debug_LNu;
    Double_t fChi2ProbTTBarBkg;   // chi^2 p-value of the top decays appended by the toppairfinder tool

    // Etmiss cut
    Float_t              fMET_Mag_min; // Minimum magnitude of Etmiss
    
    // Lepton selection cuts
    Float_t fElPt_Min;        // Minimum signal electron pt
    Float_t fMuPt_Min;        // Minimum signal electron pt

    
    // Jet selection cuts
    Int_t                fNJetsMin;       // minimal number of jets
    Int_t                fNJetsMax;       // maximum number of jets
    Int_t                fNJetsExcl;       // jets multiplicity bin
    Float_t              fJets_Et_min;      // Min. Et of signal jets
    Float_t              fJets_Eta_min;     // Min. eta of signal jets
    Float_t              fJets_Eta_max;     // Max. eta of signal jets

    // Selection cuts for jets used in hadronic W reconstruction
    Float_t              fWhadJets_Et_min;      // Min. Et of jets from Whad
    Float_t              fWhadJets_Eta_min;     // Min. eta of jets from Whad
    Float_t              fWhadJets_Eta_max;     // Max. eta of jets from Whad
    AtlBTag::ETagger     fWhadJetTagger;        // Tagger used for signal fwd jets
    Float_t              fWhadJetWeightMax;    // Maximum b-tag weight for jets to be accepted as a light fwd jet    
    // BJet selection cuts
    AtlBTag::ETagger     fBJetTagger;        // Tagger used for b-jet selection

    Float_t              fBJets_Et_min;      // Min. Pt of signal b-jets
    Float_t              fBJets_Eta_min;     // Min. eta of signal b-jets
    Float_t              fBJets_Eta_max;     // Max. eta of signal b-jets
    
    // ttbar selection cuts
    Float_t  fVetoTTbarProbMin; // p(chi2) ttbar cut point -------> Not used since ttbar veto is done by p(chi2) comparison

    // Triangular Cut Quantities
    Float_t  fWmassT_min;
    // Transverse W mass
    Double_t fWmassT;
    HepParticle *fRecoTriangularW;        // reconstructed W-boson

  public:
    AtlSgTop_WtChannelFinder(const char* name, const char* title);
    virtual ~AtlSgTop_WtChannelFinder();
    virtual void SetBranchStatus();
    virtual void BookHistograms();
    void CommonHistograms( );
    void LeptonicTopHistograms();
    void HadronicTopHistograms();
    virtual void FillHistograms();
    virtual void SetCutDefaults();
    virtual Bool_t AnalyzeEvent();
    virtual void Terminate();
    virtual void Print() const;
    inline void SetLeptons (TList* list)   { fLeptons = list; }            
    inline void SetJets   (TList* list)    { fJets = list; }           
    inline void SetEtmiss (TVector2 met)   { fMET = met; }
    void ReconstructW();


  private:

    // Event selection histograms
    void BookLeptonHistograms();
    void BookJetHistograms();
    
    void FillLeptonHistograms();
    void FillJetHistograms();
    void FillBJetHistograms();
    void FillNonBJetHistograms();

    // Performance study histograms
    void BookComparisonHistogramsLeptTopFit();
    void BookComparisonHistogramsHadrTopFit();
    void FillComparisonHistograms();

    void BookLeptonHistograms_BTag();
    void BookJetHistograms_BTag();
    void FillLeptonHistograms_BTag();
    void FillJetHistograms_BTag();
    void FillBJetHistograms_BTag();
    void FillNonBJetHistograms_BTag();
    //void FillPreAfterBTagHistograms();    
    void InitEvent();
    void SetNeutrinoStartingValues();
    void ReconstructionKinFit();
    void ReconstructionCutBased();
    void LeptonicTopKinFitReco();
    void HadronicTopKinFitReco();
    void DoLeptonicTopFit();
    void DoHadronicTopFit();
    Bool_t ApplyTTbarVeto(Double_t chi2probMin, AtlJet* BestBJet);    
    Int_t GetDecayChannel();
    Int_t GetTrueDecayChannel();
    
    ClassDef(AtlSgTop_WtChannelFinder,0)  // ATLAS single top Wt-channel finder
};
#endif
 AtlSgTop_WtChannelFinder.h:1
 AtlSgTop_WtChannelFinder.h:2
 AtlSgTop_WtChannelFinder.h:3
 AtlSgTop_WtChannelFinder.h:4
 AtlSgTop_WtChannelFinder.h:5
 AtlSgTop_WtChannelFinder.h:6
 AtlSgTop_WtChannelFinder.h:7
 AtlSgTop_WtChannelFinder.h:8
 AtlSgTop_WtChannelFinder.h:9
 AtlSgTop_WtChannelFinder.h:10
 AtlSgTop_WtChannelFinder.h:11
 AtlSgTop_WtChannelFinder.h:12
 AtlSgTop_WtChannelFinder.h:13
 AtlSgTop_WtChannelFinder.h:14
 AtlSgTop_WtChannelFinder.h:15
 AtlSgTop_WtChannelFinder.h:16
 AtlSgTop_WtChannelFinder.h:17
 AtlSgTop_WtChannelFinder.h:18
 AtlSgTop_WtChannelFinder.h:19
 AtlSgTop_WtChannelFinder.h:20
 AtlSgTop_WtChannelFinder.h:21
 AtlSgTop_WtChannelFinder.h:22
 AtlSgTop_WtChannelFinder.h:23
 AtlSgTop_WtChannelFinder.h:24
 AtlSgTop_WtChannelFinder.h:25
 AtlSgTop_WtChannelFinder.h:26
 AtlSgTop_WtChannelFinder.h:27
 AtlSgTop_WtChannelFinder.h:28
 AtlSgTop_WtChannelFinder.h:29
 AtlSgTop_WtChannelFinder.h:30
 AtlSgTop_WtChannelFinder.h:31
 AtlSgTop_WtChannelFinder.h:32
 AtlSgTop_WtChannelFinder.h:33
 AtlSgTop_WtChannelFinder.h:34
 AtlSgTop_WtChannelFinder.h:35
 AtlSgTop_WtChannelFinder.h:36
 AtlSgTop_WtChannelFinder.h:37
 AtlSgTop_WtChannelFinder.h:38
 AtlSgTop_WtChannelFinder.h:39
 AtlSgTop_WtChannelFinder.h:40
 AtlSgTop_WtChannelFinder.h:41
 AtlSgTop_WtChannelFinder.h:42
 AtlSgTop_WtChannelFinder.h:43
 AtlSgTop_WtChannelFinder.h:44
 AtlSgTop_WtChannelFinder.h:45
 AtlSgTop_WtChannelFinder.h:46
 AtlSgTop_WtChannelFinder.h:47
 AtlSgTop_WtChannelFinder.h:48
 AtlSgTop_WtChannelFinder.h:49
 AtlSgTop_WtChannelFinder.h:50
 AtlSgTop_WtChannelFinder.h:51
 AtlSgTop_WtChannelFinder.h:52
 AtlSgTop_WtChannelFinder.h:53
 AtlSgTop_WtChannelFinder.h:54
 AtlSgTop_WtChannelFinder.h:55
 AtlSgTop_WtChannelFinder.h:56
 AtlSgTop_WtChannelFinder.h:57
 AtlSgTop_WtChannelFinder.h:58
 AtlSgTop_WtChannelFinder.h:59
 AtlSgTop_WtChannelFinder.h:60
 AtlSgTop_WtChannelFinder.h:61
 AtlSgTop_WtChannelFinder.h:62
 AtlSgTop_WtChannelFinder.h:63
 AtlSgTop_WtChannelFinder.h:64
 AtlSgTop_WtChannelFinder.h:65
 AtlSgTop_WtChannelFinder.h:66
 AtlSgTop_WtChannelFinder.h:67
 AtlSgTop_WtChannelFinder.h:68
 AtlSgTop_WtChannelFinder.h:69
 AtlSgTop_WtChannelFinder.h:70
 AtlSgTop_WtChannelFinder.h:71
 AtlSgTop_WtChannelFinder.h:72
 AtlSgTop_WtChannelFinder.h:73
 AtlSgTop_WtChannelFinder.h:74
 AtlSgTop_WtChannelFinder.h:75
 AtlSgTop_WtChannelFinder.h:76
 AtlSgTop_WtChannelFinder.h:77
 AtlSgTop_WtChannelFinder.h:78
 AtlSgTop_WtChannelFinder.h:79
 AtlSgTop_WtChannelFinder.h:80
 AtlSgTop_WtChannelFinder.h:81
 AtlSgTop_WtChannelFinder.h:82
 AtlSgTop_WtChannelFinder.h:83
 AtlSgTop_WtChannelFinder.h:84
 AtlSgTop_WtChannelFinder.h:85
 AtlSgTop_WtChannelFinder.h:86
 AtlSgTop_WtChannelFinder.h:87
 AtlSgTop_WtChannelFinder.h:88
 AtlSgTop_WtChannelFinder.h:89
 AtlSgTop_WtChannelFinder.h:90
 AtlSgTop_WtChannelFinder.h:91
 AtlSgTop_WtChannelFinder.h:92
 AtlSgTop_WtChannelFinder.h:93
 AtlSgTop_WtChannelFinder.h:94
 AtlSgTop_WtChannelFinder.h:95
 AtlSgTop_WtChannelFinder.h:96
 AtlSgTop_WtChannelFinder.h:97
 AtlSgTop_WtChannelFinder.h:98
 AtlSgTop_WtChannelFinder.h:99
 AtlSgTop_WtChannelFinder.h:100
 AtlSgTop_WtChannelFinder.h:101
 AtlSgTop_WtChannelFinder.h:102
 AtlSgTop_WtChannelFinder.h:103
 AtlSgTop_WtChannelFinder.h:104
 AtlSgTop_WtChannelFinder.h:105
 AtlSgTop_WtChannelFinder.h:106
 AtlSgTop_WtChannelFinder.h:107
 AtlSgTop_WtChannelFinder.h:108
 AtlSgTop_WtChannelFinder.h:109
 AtlSgTop_WtChannelFinder.h:110
 AtlSgTop_WtChannelFinder.h:111
 AtlSgTop_WtChannelFinder.h:112
 AtlSgTop_WtChannelFinder.h:113
 AtlSgTop_WtChannelFinder.h:114
 AtlSgTop_WtChannelFinder.h:115
 AtlSgTop_WtChannelFinder.h:116
 AtlSgTop_WtChannelFinder.h:117
 AtlSgTop_WtChannelFinder.h:118
 AtlSgTop_WtChannelFinder.h:119
 AtlSgTop_WtChannelFinder.h:120
 AtlSgTop_WtChannelFinder.h:121
 AtlSgTop_WtChannelFinder.h:122
 AtlSgTop_WtChannelFinder.h:123
 AtlSgTop_WtChannelFinder.h:124
 AtlSgTop_WtChannelFinder.h:125
 AtlSgTop_WtChannelFinder.h:126
 AtlSgTop_WtChannelFinder.h:127
 AtlSgTop_WtChannelFinder.h:128
 AtlSgTop_WtChannelFinder.h:129
 AtlSgTop_WtChannelFinder.h:130
 AtlSgTop_WtChannelFinder.h:131
 AtlSgTop_WtChannelFinder.h:132
 AtlSgTop_WtChannelFinder.h:133
 AtlSgTop_WtChannelFinder.h:134
 AtlSgTop_WtChannelFinder.h:135
 AtlSgTop_WtChannelFinder.h:136
 AtlSgTop_WtChannelFinder.h:137
 AtlSgTop_WtChannelFinder.h:138
 AtlSgTop_WtChannelFinder.h:139
 AtlSgTop_WtChannelFinder.h:140
 AtlSgTop_WtChannelFinder.h:141
 AtlSgTop_WtChannelFinder.h:142
 AtlSgTop_WtChannelFinder.h:143
 AtlSgTop_WtChannelFinder.h:144
 AtlSgTop_WtChannelFinder.h:145
 AtlSgTop_WtChannelFinder.h:146
 AtlSgTop_WtChannelFinder.h:147
 AtlSgTop_WtChannelFinder.h:148
 AtlSgTop_WtChannelFinder.h:149
 AtlSgTop_WtChannelFinder.h:150
 AtlSgTop_WtChannelFinder.h:151
 AtlSgTop_WtChannelFinder.h:152
 AtlSgTop_WtChannelFinder.h:153
 AtlSgTop_WtChannelFinder.h:154
 AtlSgTop_WtChannelFinder.h:155
 AtlSgTop_WtChannelFinder.h:156
 AtlSgTop_WtChannelFinder.h:157
 AtlSgTop_WtChannelFinder.h:158
 AtlSgTop_WtChannelFinder.h:159
 AtlSgTop_WtChannelFinder.h:160
 AtlSgTop_WtChannelFinder.h:161
 AtlSgTop_WtChannelFinder.h:162
 AtlSgTop_WtChannelFinder.h:163
 AtlSgTop_WtChannelFinder.h:164
 AtlSgTop_WtChannelFinder.h:165
 AtlSgTop_WtChannelFinder.h:166
 AtlSgTop_WtChannelFinder.h:167
 AtlSgTop_WtChannelFinder.h:168
 AtlSgTop_WtChannelFinder.h:169
 AtlSgTop_WtChannelFinder.h:170
 AtlSgTop_WtChannelFinder.h:171
 AtlSgTop_WtChannelFinder.h:172
 AtlSgTop_WtChannelFinder.h:173
 AtlSgTop_WtChannelFinder.h:174
 AtlSgTop_WtChannelFinder.h:175
 AtlSgTop_WtChannelFinder.h:176
 AtlSgTop_WtChannelFinder.h:177
 AtlSgTop_WtChannelFinder.h:178
 AtlSgTop_WtChannelFinder.h:179
 AtlSgTop_WtChannelFinder.h:180
 AtlSgTop_WtChannelFinder.h:181
 AtlSgTop_WtChannelFinder.h:182
 AtlSgTop_WtChannelFinder.h:183
 AtlSgTop_WtChannelFinder.h:184
 AtlSgTop_WtChannelFinder.h:185
 AtlSgTop_WtChannelFinder.h:186
 AtlSgTop_WtChannelFinder.h:187
 AtlSgTop_WtChannelFinder.h:188
 AtlSgTop_WtChannelFinder.h:189
 AtlSgTop_WtChannelFinder.h:190
 AtlSgTop_WtChannelFinder.h:191
 AtlSgTop_WtChannelFinder.h:192
 AtlSgTop_WtChannelFinder.h:193
 AtlSgTop_WtChannelFinder.h:194
 AtlSgTop_WtChannelFinder.h:195
 AtlSgTop_WtChannelFinder.h:196
 AtlSgTop_WtChannelFinder.h:197
 AtlSgTop_WtChannelFinder.h:198
 AtlSgTop_WtChannelFinder.h:199
 AtlSgTop_WtChannelFinder.h:200
 AtlSgTop_WtChannelFinder.h:201
 AtlSgTop_WtChannelFinder.h:202
 AtlSgTop_WtChannelFinder.h:203
 AtlSgTop_WtChannelFinder.h:204
 AtlSgTop_WtChannelFinder.h:205
 AtlSgTop_WtChannelFinder.h:206
 AtlSgTop_WtChannelFinder.h:207
 AtlSgTop_WtChannelFinder.h:208
 AtlSgTop_WtChannelFinder.h:209
 AtlSgTop_WtChannelFinder.h:210
 AtlSgTop_WtChannelFinder.h:211
 AtlSgTop_WtChannelFinder.h:212
 AtlSgTop_WtChannelFinder.h:213
 AtlSgTop_WtChannelFinder.h:214
 AtlSgTop_WtChannelFinder.h:215
 AtlSgTop_WtChannelFinder.h:216
 AtlSgTop_WtChannelFinder.h:217
 AtlSgTop_WtChannelFinder.h:218
 AtlSgTop_WtChannelFinder.h:219
 AtlSgTop_WtChannelFinder.h:220
 AtlSgTop_WtChannelFinder.h:221
 AtlSgTop_WtChannelFinder.h:222
 AtlSgTop_WtChannelFinder.h:223
 AtlSgTop_WtChannelFinder.h:224
 AtlSgTop_WtChannelFinder.h:225
 AtlSgTop_WtChannelFinder.h:226
 AtlSgTop_WtChannelFinder.h:227
 AtlSgTop_WtChannelFinder.h:228
 AtlSgTop_WtChannelFinder.h:229
 AtlSgTop_WtChannelFinder.h:230
 AtlSgTop_WtChannelFinder.h:231
 AtlSgTop_WtChannelFinder.h:232
 AtlSgTop_WtChannelFinder.h:233
 AtlSgTop_WtChannelFinder.h:234
 AtlSgTop_WtChannelFinder.h:235
 AtlSgTop_WtChannelFinder.h:236
 AtlSgTop_WtChannelFinder.h:237
 AtlSgTop_WtChannelFinder.h:238
 AtlSgTop_WtChannelFinder.h:239
 AtlSgTop_WtChannelFinder.h:240
 AtlSgTop_WtChannelFinder.h:241
 AtlSgTop_WtChannelFinder.h:242
 AtlSgTop_WtChannelFinder.h:243
 AtlSgTop_WtChannelFinder.h:244
 AtlSgTop_WtChannelFinder.h:245
 AtlSgTop_WtChannelFinder.h:246
 AtlSgTop_WtChannelFinder.h:247
 AtlSgTop_WtChannelFinder.h:248
 AtlSgTop_WtChannelFinder.h:249
 AtlSgTop_WtChannelFinder.h:250
 AtlSgTop_WtChannelFinder.h:251
 AtlSgTop_WtChannelFinder.h:252
 AtlSgTop_WtChannelFinder.h:253
 AtlSgTop_WtChannelFinder.h:254
 AtlSgTop_WtChannelFinder.h:255
 AtlSgTop_WtChannelFinder.h:256
 AtlSgTop_WtChannelFinder.h:257
 AtlSgTop_WtChannelFinder.h:258
 AtlSgTop_WtChannelFinder.h:259
 AtlSgTop_WtChannelFinder.h:260
 AtlSgTop_WtChannelFinder.h:261
 AtlSgTop_WtChannelFinder.h:262
 AtlSgTop_WtChannelFinder.h:263
 AtlSgTop_WtChannelFinder.h:264
 AtlSgTop_WtChannelFinder.h:265
 AtlSgTop_WtChannelFinder.h:266
 AtlSgTop_WtChannelFinder.h:267
 AtlSgTop_WtChannelFinder.h:268
 AtlSgTop_WtChannelFinder.h:269
 AtlSgTop_WtChannelFinder.h:270
 AtlSgTop_WtChannelFinder.h:271
 AtlSgTop_WtChannelFinder.h:272
 AtlSgTop_WtChannelFinder.h:273
 AtlSgTop_WtChannelFinder.h:274
 AtlSgTop_WtChannelFinder.h:275
 AtlSgTop_WtChannelFinder.h:276
 AtlSgTop_WtChannelFinder.h:277
 AtlSgTop_WtChannelFinder.h:278
 AtlSgTop_WtChannelFinder.h:279
 AtlSgTop_WtChannelFinder.h:280
 AtlSgTop_WtChannelFinder.h:281
 AtlSgTop_WtChannelFinder.h:282
 AtlSgTop_WtChannelFinder.h:283
 AtlSgTop_WtChannelFinder.h:284
 AtlSgTop_WtChannelFinder.h:285
 AtlSgTop_WtChannelFinder.h:286
 AtlSgTop_WtChannelFinder.h:287
 AtlSgTop_WtChannelFinder.h:288
 AtlSgTop_WtChannelFinder.h:289
 AtlSgTop_WtChannelFinder.h:290
 AtlSgTop_WtChannelFinder.h:291
 AtlSgTop_WtChannelFinder.h:292
 AtlSgTop_WtChannelFinder.h:293
 AtlSgTop_WtChannelFinder.h:294
 AtlSgTop_WtChannelFinder.h:295
 AtlSgTop_WtChannelFinder.h:296
 AtlSgTop_WtChannelFinder.h:297
 AtlSgTop_WtChannelFinder.h:298
 AtlSgTop_WtChannelFinder.h:299
 AtlSgTop_WtChannelFinder.h:300
 AtlSgTop_WtChannelFinder.h:301
 AtlSgTop_WtChannelFinder.h:302
 AtlSgTop_WtChannelFinder.h:303
 AtlSgTop_WtChannelFinder.h:304
 AtlSgTop_WtChannelFinder.h:305
 AtlSgTop_WtChannelFinder.h:306
 AtlSgTop_WtChannelFinder.h:307
 AtlSgTop_WtChannelFinder.h:308
 AtlSgTop_WtChannelFinder.h:309
 AtlSgTop_WtChannelFinder.h:310
 AtlSgTop_WtChannelFinder.h:311
 AtlSgTop_WtChannelFinder.h:312
 AtlSgTop_WtChannelFinder.h:313
 AtlSgTop_WtChannelFinder.h:314
 AtlSgTop_WtChannelFinder.h:315
 AtlSgTop_WtChannelFinder.h:316
 AtlSgTop_WtChannelFinder.h:317
 AtlSgTop_WtChannelFinder.h:318
 AtlSgTop_WtChannelFinder.h:319
 AtlSgTop_WtChannelFinder.h:320
 AtlSgTop_WtChannelFinder.h:321
 AtlSgTop_WtChannelFinder.h:322
 AtlSgTop_WtChannelFinder.h:323
 AtlSgTop_WtChannelFinder.h:324
 AtlSgTop_WtChannelFinder.h:325
 AtlSgTop_WtChannelFinder.h:326
 AtlSgTop_WtChannelFinder.h:327
 AtlSgTop_WtChannelFinder.h:328
 AtlSgTop_WtChannelFinder.h:329
 AtlSgTop_WtChannelFinder.h:330
 AtlSgTop_WtChannelFinder.h:331
 AtlSgTop_WtChannelFinder.h:332
 AtlSgTop_WtChannelFinder.h:333
 AtlSgTop_WtChannelFinder.h:334
 AtlSgTop_WtChannelFinder.h:335
 AtlSgTop_WtChannelFinder.h:336
 AtlSgTop_WtChannelFinder.h:337
 AtlSgTop_WtChannelFinder.h:338
 AtlSgTop_WtChannelFinder.h:339
 AtlSgTop_WtChannelFinder.h:340
 AtlSgTop_WtChannelFinder.h:341
 AtlSgTop_WtChannelFinder.h:342
 AtlSgTop_WtChannelFinder.h:343
 AtlSgTop_WtChannelFinder.h:344
 AtlSgTop_WtChannelFinder.h:345
 AtlSgTop_WtChannelFinder.h:346
 AtlSgTop_WtChannelFinder.h:347
 AtlSgTop_WtChannelFinder.h:348
 AtlSgTop_WtChannelFinder.h:349
 AtlSgTop_WtChannelFinder.h:350
 AtlSgTop_WtChannelFinder.h:351
 AtlSgTop_WtChannelFinder.h:352
 AtlSgTop_WtChannelFinder.h:353
 AtlSgTop_WtChannelFinder.h:354
 AtlSgTop_WtChannelFinder.h:355
 AtlSgTop_WtChannelFinder.h:356
 AtlSgTop_WtChannelFinder.h:357
 AtlSgTop_WtChannelFinder.h:358
 AtlSgTop_WtChannelFinder.h:359
 AtlSgTop_WtChannelFinder.h:360
 AtlSgTop_WtChannelFinder.h:361
 AtlSgTop_WtChannelFinder.h:362
 AtlSgTop_WtChannelFinder.h:363
 AtlSgTop_WtChannelFinder.h:364
 AtlSgTop_WtChannelFinder.h:365
 AtlSgTop_WtChannelFinder.h:366
 AtlSgTop_WtChannelFinder.h:367
 AtlSgTop_WtChannelFinder.h:368
 AtlSgTop_WtChannelFinder.h:369
 AtlSgTop_WtChannelFinder.h:370
 AtlSgTop_WtChannelFinder.h:371
 AtlSgTop_WtChannelFinder.h:372
 AtlSgTop_WtChannelFinder.h:373
 AtlSgTop_WtChannelFinder.h:374
 AtlSgTop_WtChannelFinder.h:375
 AtlSgTop_WtChannelFinder.h:376
 AtlSgTop_WtChannelFinder.h:377
 AtlSgTop_WtChannelFinder.h:378
 AtlSgTop_WtChannelFinder.h:379
 AtlSgTop_WtChannelFinder.h:380
 AtlSgTop_WtChannelFinder.h:381
 AtlSgTop_WtChannelFinder.h:382
 AtlSgTop_WtChannelFinder.h:383
 AtlSgTop_WtChannelFinder.h:384
 AtlSgTop_WtChannelFinder.h:385
 AtlSgTop_WtChannelFinder.h:386
 AtlSgTop_WtChannelFinder.h:387
 AtlSgTop_WtChannelFinder.h:388
 AtlSgTop_WtChannelFinder.h:389
 AtlSgTop_WtChannelFinder.h:390
 AtlSgTop_WtChannelFinder.h:391
 AtlSgTop_WtChannelFinder.h:392
 AtlSgTop_WtChannelFinder.h:393
 AtlSgTop_WtChannelFinder.h:394
 AtlSgTop_WtChannelFinder.h:395
 AtlSgTop_WtChannelFinder.h:396
 AtlSgTop_WtChannelFinder.h:397
 AtlSgTop_WtChannelFinder.h:398
 AtlSgTop_WtChannelFinder.h:399
 AtlSgTop_WtChannelFinder.h:400
 AtlSgTop_WtChannelFinder.h:401
 AtlSgTop_WtChannelFinder.h:402
 AtlSgTop_WtChannelFinder.h:403
 AtlSgTop_WtChannelFinder.h:404
 AtlSgTop_WtChannelFinder.h:405
 AtlSgTop_WtChannelFinder.h:406
 AtlSgTop_WtChannelFinder.h:407
 AtlSgTop_WtChannelFinder.h:408
 AtlSgTop_WtChannelFinder.h:409
 AtlSgTop_WtChannelFinder.h:410
 AtlSgTop_WtChannelFinder.h:411
 AtlSgTop_WtChannelFinder.h:412
 AtlSgTop_WtChannelFinder.h:413
 AtlSgTop_WtChannelFinder.h:414
 AtlSgTop_WtChannelFinder.h:415
 AtlSgTop_WtChannelFinder.h:416
 AtlSgTop_WtChannelFinder.h:417
 AtlSgTop_WtChannelFinder.h:418
 AtlSgTop_WtChannelFinder.h:419
 AtlSgTop_WtChannelFinder.h:420
 AtlSgTop_WtChannelFinder.h:421
 AtlSgTop_WtChannelFinder.h:422
 AtlSgTop_WtChannelFinder.h:423
 AtlSgTop_WtChannelFinder.h:424
 AtlSgTop_WtChannelFinder.h:425
 AtlSgTop_WtChannelFinder.h:426
 AtlSgTop_WtChannelFinder.h:427
 AtlSgTop_WtChannelFinder.h:428
 AtlSgTop_WtChannelFinder.h:429
 AtlSgTop_WtChannelFinder.h:430
 AtlSgTop_WtChannelFinder.h:431
 AtlSgTop_WtChannelFinder.h:432
 AtlSgTop_WtChannelFinder.h:433
 AtlSgTop_WtChannelFinder.h:434
 AtlSgTop_WtChannelFinder.h:435
 AtlSgTop_WtChannelFinder.h:436
 AtlSgTop_WtChannelFinder.h:437
 AtlSgTop_WtChannelFinder.h:438
 AtlSgTop_WtChannelFinder.h:439
 AtlSgTop_WtChannelFinder.h:440
 AtlSgTop_WtChannelFinder.h:441
 AtlSgTop_WtChannelFinder.h:442
 AtlSgTop_WtChannelFinder.h:443
 AtlSgTop_WtChannelFinder.h:444
 AtlSgTop_WtChannelFinder.h:445
 AtlSgTop_WtChannelFinder.h:446
 AtlSgTop_WtChannelFinder.h:447
 AtlSgTop_WtChannelFinder.h:448
 AtlSgTop_WtChannelFinder.h:449
 AtlSgTop_WtChannelFinder.h:450
 AtlSgTop_WtChannelFinder.h:451
 AtlSgTop_WtChannelFinder.h:452
 AtlSgTop_WtChannelFinder.h:453
 AtlSgTop_WtChannelFinder.h:454
 AtlSgTop_WtChannelFinder.h:455
 AtlSgTop_WtChannelFinder.h:456
 AtlSgTop_WtChannelFinder.h:457
 AtlSgTop_WtChannelFinder.h:458
 AtlSgTop_WtChannelFinder.h:459
 AtlSgTop_WtChannelFinder.h:460
 AtlSgTop_WtChannelFinder.h:461
 AtlSgTop_WtChannelFinder.h:462
 AtlSgTop_WtChannelFinder.h:463
 AtlSgTop_WtChannelFinder.h:464
 AtlSgTop_WtChannelFinder.h:465
 AtlSgTop_WtChannelFinder.h:466
 AtlSgTop_WtChannelFinder.h:467
 AtlSgTop_WtChannelFinder.h:468
 AtlSgTop_WtChannelFinder.h:469
 AtlSgTop_WtChannelFinder.h:470
 AtlSgTop_WtChannelFinder.h:471
 AtlSgTop_WtChannelFinder.h:472
 AtlSgTop_WtChannelFinder.h:473
 AtlSgTop_WtChannelFinder.h:474
 AtlSgTop_WtChannelFinder.h:475
 AtlSgTop_WtChannelFinder.h:476
 AtlSgTop_WtChannelFinder.h:477
 AtlSgTop_WtChannelFinder.h:478
 AtlSgTop_WtChannelFinder.h:479
 AtlSgTop_WtChannelFinder.h:480
 AtlSgTop_WtChannelFinder.h:481
 AtlSgTop_WtChannelFinder.h:482
 AtlSgTop_WtChannelFinder.h:483
 AtlSgTop_WtChannelFinder.h:484
 AtlSgTop_WtChannelFinder.h:485
 AtlSgTop_WtChannelFinder.h:486
 AtlSgTop_WtChannelFinder.h:487
 AtlSgTop_WtChannelFinder.h:488
 AtlSgTop_WtChannelFinder.h:489
 AtlSgTop_WtChannelFinder.h:490
 AtlSgTop_WtChannelFinder.h:491
 AtlSgTop_WtChannelFinder.h:492
 AtlSgTop_WtChannelFinder.h:493
 AtlSgTop_WtChannelFinder.h:494
 AtlSgTop_WtChannelFinder.h:495
 AtlSgTop_WtChannelFinder.h:496
 AtlSgTop_WtChannelFinder.h:497
 AtlSgTop_WtChannelFinder.h:498
 AtlSgTop_WtChannelFinder.h:499
 AtlSgTop_WtChannelFinder.h:500
 AtlSgTop_WtChannelFinder.h:501
 AtlSgTop_WtChannelFinder.h:502
 AtlSgTop_WtChannelFinder.h:503
 AtlSgTop_WtChannelFinder.h:504
 AtlSgTop_WtChannelFinder.h:505
 AtlSgTop_WtChannelFinder.h:506
 AtlSgTop_WtChannelFinder.h:507
 AtlSgTop_WtChannelFinder.h:508
 AtlSgTop_WtChannelFinder.h:509
 AtlSgTop_WtChannelFinder.h:510
 AtlSgTop_WtChannelFinder.h:511
 AtlSgTop_WtChannelFinder.h:512
 AtlSgTop_WtChannelFinder.h:513
 AtlSgTop_WtChannelFinder.h:514
 AtlSgTop_WtChannelFinder.h:515
 AtlSgTop_WtChannelFinder.h:516
 AtlSgTop_WtChannelFinder.h:517
 AtlSgTop_WtChannelFinder.h:518
 AtlSgTop_WtChannelFinder.h:519
 AtlSgTop_WtChannelFinder.h:520
 AtlSgTop_WtChannelFinder.h:521
 AtlSgTop_WtChannelFinder.h:522
 AtlSgTop_WtChannelFinder.h:523
 AtlSgTop_WtChannelFinder.h:524
 AtlSgTop_WtChannelFinder.h:525
 AtlSgTop_WtChannelFinder.h:526
 AtlSgTop_WtChannelFinder.h:527
 AtlSgTop_WtChannelFinder.h:528
 AtlSgTop_WtChannelFinder.h:529
 AtlSgTop_WtChannelFinder.h:530
 AtlSgTop_WtChannelFinder.h:531
 AtlSgTop_WtChannelFinder.h:532
 AtlSgTop_WtChannelFinder.h:533
 AtlSgTop_WtChannelFinder.h:534
 AtlSgTop_WtChannelFinder.h:535
 AtlSgTop_WtChannelFinder.h:536
 AtlSgTop_WtChannelFinder.h:537
 AtlSgTop_WtChannelFinder.h:538
 AtlSgTop_WtChannelFinder.h:539
 AtlSgTop_WtChannelFinder.h:540
 AtlSgTop_WtChannelFinder.h:541
 AtlSgTop_WtChannelFinder.h:542
 AtlSgTop_WtChannelFinder.h:543
 AtlSgTop_WtChannelFinder.h:544
 AtlSgTop_WtChannelFinder.h:545
 AtlSgTop_WtChannelFinder.h:546
 AtlSgTop_WtChannelFinder.h:547
 AtlSgTop_WtChannelFinder.h:548
 AtlSgTop_WtChannelFinder.h:549
 AtlSgTop_WtChannelFinder.h:550
 AtlSgTop_WtChannelFinder.h:551
 AtlSgTop_WtChannelFinder.h:552
 AtlSgTop_WtChannelFinder.h:553
 AtlSgTop_WtChannelFinder.h:554
 AtlSgTop_WtChannelFinder.h:555
 AtlSgTop_WtChannelFinder.h:556
 AtlSgTop_WtChannelFinder.h:557
 AtlSgTop_WtChannelFinder.h:558
 AtlSgTop_WtChannelFinder.h:559
 AtlSgTop_WtChannelFinder.h:560
 AtlSgTop_WtChannelFinder.h:561
 AtlSgTop_WtChannelFinder.h:562
 AtlSgTop_WtChannelFinder.h:563
 AtlSgTop_WtChannelFinder.h:564
 AtlSgTop_WtChannelFinder.h:565
 AtlSgTop_WtChannelFinder.h:566
 AtlSgTop_WtChannelFinder.h:567
 AtlSgTop_WtChannelFinder.h:568
 AtlSgTop_WtChannelFinder.h:569
 AtlSgTop_WtChannelFinder.h:570
 AtlSgTop_WtChannelFinder.h:571
 AtlSgTop_WtChannelFinder.h:572
 AtlSgTop_WtChannelFinder.h:573
 AtlSgTop_WtChannelFinder.h:574
 AtlSgTop_WtChannelFinder.h:575
 AtlSgTop_WtChannelFinder.h:576
 AtlSgTop_WtChannelFinder.h:577
 AtlSgTop_WtChannelFinder.h:578
 AtlSgTop_WtChannelFinder.h:579
 AtlSgTop_WtChannelFinder.h:580
 AtlSgTop_WtChannelFinder.h:581
 AtlSgTop_WtChannelFinder.h:582
 AtlSgTop_WtChannelFinder.h:583
 AtlSgTop_WtChannelFinder.h:584
 AtlSgTop_WtChannelFinder.h:585
 AtlSgTop_WtChannelFinder.h:586
 AtlSgTop_WtChannelFinder.h:587
 AtlSgTop_WtChannelFinder.h:588
 AtlSgTop_WtChannelFinder.h:589
 AtlSgTop_WtChannelFinder.h:590
 AtlSgTop_WtChannelFinder.h:591
 AtlSgTop_WtChannelFinder.h:592
 AtlSgTop_WtChannelFinder.h:593
 AtlSgTop_WtChannelFinder.h:594
 AtlSgTop_WtChannelFinder.h:595
 AtlSgTop_WtChannelFinder.h:596
 AtlSgTop_WtChannelFinder.h:597
 AtlSgTop_WtChannelFinder.h:598
 AtlSgTop_WtChannelFinder.h:599
 AtlSgTop_WtChannelFinder.h:600
 AtlSgTop_WtChannelFinder.h:601
 AtlSgTop_WtChannelFinder.h:602
 AtlSgTop_WtChannelFinder.h:603
 AtlSgTop_WtChannelFinder.h:604
 AtlSgTop_WtChannelFinder.h:605
 AtlSgTop_WtChannelFinder.h:606
 AtlSgTop_WtChannelFinder.h:607
 AtlSgTop_WtChannelFinder.h:608
 AtlSgTop_WtChannelFinder.h:609
 AtlSgTop_WtChannelFinder.h:610
 AtlSgTop_WtChannelFinder.h:611
 AtlSgTop_WtChannelFinder.h:612
 AtlSgTop_WtChannelFinder.h:613
 AtlSgTop_WtChannelFinder.h:614
 AtlSgTop_WtChannelFinder.h:615
 AtlSgTop_WtChannelFinder.h:616
 AtlSgTop_WtChannelFinder.h:617
 AtlSgTop_WtChannelFinder.h:618
 AtlSgTop_WtChannelFinder.h:619
 AtlSgTop_WtChannelFinder.h:620
 AtlSgTop_WtChannelFinder.h:621
 AtlSgTop_WtChannelFinder.h:622
 AtlSgTop_WtChannelFinder.h:623
 AtlSgTop_WtChannelFinder.h:624
 AtlSgTop_WtChannelFinder.h:625
 AtlSgTop_WtChannelFinder.h:626
 AtlSgTop_WtChannelFinder.h:627
 AtlSgTop_WtChannelFinder.h:628
 AtlSgTop_WtChannelFinder.h:629
 AtlSgTop_WtChannelFinder.h:630
 AtlSgTop_WtChannelFinder.h:631
 AtlSgTop_WtChannelFinder.h:632
 AtlSgTop_WtChannelFinder.h:633
 AtlSgTop_WtChannelFinder.h:634
 AtlSgTop_WtChannelFinder.h:635
 AtlSgTop_WtChannelFinder.h:636
 AtlSgTop_WtChannelFinder.h:637
 AtlSgTop_WtChannelFinder.h:638
 AtlSgTop_WtChannelFinder.h:639
 AtlSgTop_WtChannelFinder.h:640
 AtlSgTop_WtChannelFinder.h:641
 AtlSgTop_WtChannelFinder.h:642
 AtlSgTop_WtChannelFinder.h:643
 AtlSgTop_WtChannelFinder.h:644
 AtlSgTop_WtChannelFinder.h:645
 AtlSgTop_WtChannelFinder.h:646
 AtlSgTop_WtChannelFinder.h:647
 AtlSgTop_WtChannelFinder.h:648
 AtlSgTop_WtChannelFinder.h:649
 AtlSgTop_WtChannelFinder.h:650
 AtlSgTop_WtChannelFinder.h:651
 AtlSgTop_WtChannelFinder.h:652
 AtlSgTop_WtChannelFinder.h:653
 AtlSgTop_WtChannelFinder.h:654
 AtlSgTop_WtChannelFinder.h:655
 AtlSgTop_WtChannelFinder.h:656
 AtlSgTop_WtChannelFinder.h:657
 AtlSgTop_WtChannelFinder.h:658
 AtlSgTop_WtChannelFinder.h:659
 AtlSgTop_WtChannelFinder.h:660
 AtlSgTop_WtChannelFinder.h:661
 AtlSgTop_WtChannelFinder.h:662
 AtlSgTop_WtChannelFinder.h:663
 AtlSgTop_WtChannelFinder.h:664
 AtlSgTop_WtChannelFinder.h:665
 AtlSgTop_WtChannelFinder.h:666
 AtlSgTop_WtChannelFinder.h:667
 AtlSgTop_WtChannelFinder.h:668
 AtlSgTop_WtChannelFinder.h:669
 AtlSgTop_WtChannelFinder.h:670
 AtlSgTop_WtChannelFinder.h:671
 AtlSgTop_WtChannelFinder.h:672
 AtlSgTop_WtChannelFinder.h:673
 AtlSgTop_WtChannelFinder.h:674
 AtlSgTop_WtChannelFinder.h:675
 AtlSgTop_WtChannelFinder.h:676
 AtlSgTop_WtChannelFinder.h:677
 AtlSgTop_WtChannelFinder.h:678
 AtlSgTop_WtChannelFinder.h:679
 AtlSgTop_WtChannelFinder.h:680
 AtlSgTop_WtChannelFinder.h:681
 AtlSgTop_WtChannelFinder.h:682
 AtlSgTop_WtChannelFinder.h:683
 AtlSgTop_WtChannelFinder.h:684
 AtlSgTop_WtChannelFinder.h:685
 AtlSgTop_WtChannelFinder.h:686
 AtlSgTop_WtChannelFinder.h:687
 AtlSgTop_WtChannelFinder.h:688
 AtlSgTop_WtChannelFinder.h:689
 AtlSgTop_WtChannelFinder.h:690
 AtlSgTop_WtChannelFinder.h:691
 AtlSgTop_WtChannelFinder.h:692
 AtlSgTop_WtChannelFinder.h:693
 AtlSgTop_WtChannelFinder.h:694
 AtlSgTop_WtChannelFinder.h:695
 AtlSgTop_WtChannelFinder.h:696
 AtlSgTop_WtChannelFinder.h:697
 AtlSgTop_WtChannelFinder.h:698
 AtlSgTop_WtChannelFinder.h:699
 AtlSgTop_WtChannelFinder.h:700
 AtlSgTop_WtChannelFinder.h:701
 AtlSgTop_WtChannelFinder.h:702
 AtlSgTop_WtChannelFinder.h:703
 AtlSgTop_WtChannelFinder.h:704
 AtlSgTop_WtChannelFinder.h:705
 AtlSgTop_WtChannelFinder.h:706
 AtlSgTop_WtChannelFinder.h:707
 AtlSgTop_WtChannelFinder.h:708
 AtlSgTop_WtChannelFinder.h:709
 AtlSgTop_WtChannelFinder.h:710
 AtlSgTop_WtChannelFinder.h:711
 AtlSgTop_WtChannelFinder.h:712
 AtlSgTop_WtChannelFinder.h:713
 AtlSgTop_WtChannelFinder.h:714
 AtlSgTop_WtChannelFinder.h:715
 AtlSgTop_WtChannelFinder.h:716
 AtlSgTop_WtChannelFinder.h:717
 AtlSgTop_WtChannelFinder.h:718
 AtlSgTop_WtChannelFinder.h:719
 AtlSgTop_WtChannelFinder.h:720
 AtlSgTop_WtChannelFinder.h:721
 AtlSgTop_WtChannelFinder.h:722
 AtlSgTop_WtChannelFinder.h:723
 AtlSgTop_WtChannelFinder.h:724
 AtlSgTop_WtChannelFinder.h:725
 AtlSgTop_WtChannelFinder.h:726
 AtlSgTop_WtChannelFinder.h:727
 AtlSgTop_WtChannelFinder.h:728
 AtlSgTop_WtChannelFinder.h:729
 AtlSgTop_WtChannelFinder.h:730
 AtlSgTop_WtChannelFinder.h:731
 AtlSgTop_WtChannelFinder.h:732
 AtlSgTop_WtChannelFinder.h:733
 AtlSgTop_WtChannelFinder.h:734
 AtlSgTop_WtChannelFinder.h:735
 AtlSgTop_WtChannelFinder.h:736
 AtlSgTop_WtChannelFinder.h:737
 AtlSgTop_WtChannelFinder.h:738
 AtlSgTop_WtChannelFinder.h:739
 AtlSgTop_WtChannelFinder.h:740
 AtlSgTop_WtChannelFinder.h:741
 AtlSgTop_WtChannelFinder.h:742
 AtlSgTop_WtChannelFinder.h:743
 AtlSgTop_WtChannelFinder.h:744
 AtlSgTop_WtChannelFinder.h:745
 AtlSgTop_WtChannelFinder.h:746
 AtlSgTop_WtChannelFinder.h:747
 AtlSgTop_WtChannelFinder.h:748
 AtlSgTop_WtChannelFinder.h:749
 AtlSgTop_WtChannelFinder.h:750
 AtlSgTop_WtChannelFinder.h:751
 AtlSgTop_WtChannelFinder.h:752
 AtlSgTop_WtChannelFinder.h:753
 AtlSgTop_WtChannelFinder.h:754
 AtlSgTop_WtChannelFinder.h:755
 AtlSgTop_WtChannelFinder.h:756
 AtlSgTop_WtChannelFinder.h:757
 AtlSgTop_WtChannelFinder.h:758
 AtlSgTop_WtChannelFinder.h:759
 AtlSgTop_WtChannelFinder.h:760
 AtlSgTop_WtChannelFinder.h:761
 AtlSgTop_WtChannelFinder.h:762
 AtlSgTop_WtChannelFinder.h:763
 AtlSgTop_WtChannelFinder.h:764
 AtlSgTop_WtChannelFinder.h:765
 AtlSgTop_WtChannelFinder.h:766
 AtlSgTop_WtChannelFinder.h:767
 AtlSgTop_WtChannelFinder.h:768
 AtlSgTop_WtChannelFinder.h:769
 AtlSgTop_WtChannelFinder.h:770
 AtlSgTop_WtChannelFinder.h:771
 AtlSgTop_WtChannelFinder.h:772
 AtlSgTop_WtChannelFinder.h:773
 AtlSgTop_WtChannelFinder.h:774
 AtlSgTop_WtChannelFinder.h:775
 AtlSgTop_WtChannelFinder.h:776
 AtlSgTop_WtChannelFinder.h:777
 AtlSgTop_WtChannelFinder.h:778
 AtlSgTop_WtChannelFinder.h:779
 AtlSgTop_WtChannelFinder.h:780
 AtlSgTop_WtChannelFinder.h:781
 AtlSgTop_WtChannelFinder.h:782
 AtlSgTop_WtChannelFinder.h:783
 AtlSgTop_WtChannelFinder.h:784
 AtlSgTop_WtChannelFinder.h:785
 AtlSgTop_WtChannelFinder.h:786
 AtlSgTop_WtChannelFinder.h:787
 AtlSgTop_WtChannelFinder.h:788
 AtlSgTop_WtChannelFinder.h:789
 AtlSgTop_WtChannelFinder.h:790
 AtlSgTop_WtChannelFinder.h:791
 AtlSgTop_WtChannelFinder.h:792
 AtlSgTop_WtChannelFinder.h:793
 AtlSgTop_WtChannelFinder.h:794
 AtlSgTop_WtChannelFinder.h:795
 AtlSgTop_WtChannelFinder.h:796
 AtlSgTop_WtChannelFinder.h:797
 AtlSgTop_WtChannelFinder.h:798
 AtlSgTop_WtChannelFinder.h:799
 AtlSgTop_WtChannelFinder.h:800
 AtlSgTop_WtChannelFinder.h:801
 AtlSgTop_WtChannelFinder.h:802
 AtlSgTop_WtChannelFinder.h:803
 AtlSgTop_WtChannelFinder.h:804
 AtlSgTop_WtChannelFinder.h:805
 AtlSgTop_WtChannelFinder.h:806
 AtlSgTop_WtChannelFinder.h:807
 AtlSgTop_WtChannelFinder.h:808
 AtlSgTop_WtChannelFinder.h:809
 AtlSgTop_WtChannelFinder.h:810
 AtlSgTop_WtChannelFinder.h:811
 AtlSgTop_WtChannelFinder.h:812
 AtlSgTop_WtChannelFinder.h:813
 AtlSgTop_WtChannelFinder.h:814
 AtlSgTop_WtChannelFinder.h:815
 AtlSgTop_WtChannelFinder.h:816
 AtlSgTop_WtChannelFinder.h:817
 AtlSgTop_WtChannelFinder.h:818
 AtlSgTop_WtChannelFinder.h:819
 AtlSgTop_WtChannelFinder.h:820
 AtlSgTop_WtChannelFinder.h:821
 AtlSgTop_WtChannelFinder.h:822
 AtlSgTop_WtChannelFinder.h:823
 AtlSgTop_WtChannelFinder.h:824
 AtlSgTop_WtChannelFinder.h:825
 AtlSgTop_WtChannelFinder.h:826
 AtlSgTop_WtChannelFinder.h:827
 AtlSgTop_WtChannelFinder.h:828
 AtlSgTop_WtChannelFinder.h:829
 AtlSgTop_WtChannelFinder.h:830
 AtlSgTop_WtChannelFinder.h:831
 AtlSgTop_WtChannelFinder.h:832
 AtlSgTop_WtChannelFinder.h:833
 AtlSgTop_WtChannelFinder.h:834
 AtlSgTop_WtChannelFinder.h:835
 AtlSgTop_WtChannelFinder.h:836
 AtlSgTop_WtChannelFinder.h:837
 AtlSgTop_WtChannelFinder.h:838
 AtlSgTop_WtChannelFinder.h:839
 AtlSgTop_WtChannelFinder.h:840
 AtlSgTop_WtChannelFinder.h:841
 AtlSgTop_WtChannelFinder.h:842
 AtlSgTop_WtChannelFinder.h:843
 AtlSgTop_WtChannelFinder.h:844
 AtlSgTop_WtChannelFinder.h:845
 AtlSgTop_WtChannelFinder.h:846
 AtlSgTop_WtChannelFinder.h:847
 AtlSgTop_WtChannelFinder.h:848
 AtlSgTop_WtChannelFinder.h:849
 AtlSgTop_WtChannelFinder.h:850
 AtlSgTop_WtChannelFinder.h:851
 AtlSgTop_WtChannelFinder.h:852
 AtlSgTop_WtChannelFinder.h:853
 AtlSgTop_WtChannelFinder.h:854
 AtlSgTop_WtChannelFinder.h:855
 AtlSgTop_WtChannelFinder.h:856
 AtlSgTop_WtChannelFinder.h:857
 AtlSgTop_WtChannelFinder.h:858
 AtlSgTop_WtChannelFinder.h:859
 AtlSgTop_WtChannelFinder.h:860
 AtlSgTop_WtChannelFinder.h:861
 AtlSgTop_WtChannelFinder.h:862
 AtlSgTop_WtChannelFinder.h:863
 AtlSgTop_WtChannelFinder.h:864
 AtlSgTop_WtChannelFinder.h:865
 AtlSgTop_WtChannelFinder.h:866
 AtlSgTop_WtChannelFinder.h:867
 AtlSgTop_WtChannelFinder.h:868
 AtlSgTop_WtChannelFinder.h:869
 AtlSgTop_WtChannelFinder.h:870
 AtlSgTop_WtChannelFinder.h:871
 AtlSgTop_WtChannelFinder.h:872
 AtlSgTop_WtChannelFinder.h:873
 AtlSgTop_WtChannelFinder.h:874
 AtlSgTop_WtChannelFinder.h:875
 AtlSgTop_WtChannelFinder.h:876
 AtlSgTop_WtChannelFinder.h:877
 AtlSgTop_WtChannelFinder.h:878
 AtlSgTop_WtChannelFinder.h:879
 AtlSgTop_WtChannelFinder.h:880
 AtlSgTop_WtChannelFinder.h:881
 AtlSgTop_WtChannelFinder.h:882
 AtlSgTop_WtChannelFinder.h:883
 AtlSgTop_WtChannelFinder.h:884
 AtlSgTop_WtChannelFinder.h:885
 AtlSgTop_WtChannelFinder.h:886
 AtlSgTop_WtChannelFinder.h:887
 AtlSgTop_WtChannelFinder.h:888
 AtlSgTop_WtChannelFinder.h:889
 AtlSgTop_WtChannelFinder.h:890
 AtlSgTop_WtChannelFinder.h:891
 AtlSgTop_WtChannelFinder.h:892
 AtlSgTop_WtChannelFinder.h:893
 AtlSgTop_WtChannelFinder.h:894
 AtlSgTop_WtChannelFinder.h:895
 AtlSgTop_WtChannelFinder.h:896
 AtlSgTop_WtChannelFinder.h:897
 AtlSgTop_WtChannelFinder.h:898
 AtlSgTop_WtChannelFinder.h:899
 AtlSgTop_WtChannelFinder.h:900
 AtlSgTop_WtChannelFinder.h:901
 AtlSgTop_WtChannelFinder.h:902
 AtlSgTop_WtChannelFinder.h:903
 AtlSgTop_WtChannelFinder.h:904
 AtlSgTop_WtChannelFinder.h:905
 AtlSgTop_WtChannelFinder.h:906
 AtlSgTop_WtChannelFinder.h:907
 AtlSgTop_WtChannelFinder.h:908
 AtlSgTop_WtChannelFinder.h:909
 AtlSgTop_WtChannelFinder.h:910
 AtlSgTop_WtChannelFinder.h:911
 AtlSgTop_WtChannelFinder.h:912
 AtlSgTop_WtChannelFinder.h:913
 AtlSgTop_WtChannelFinder.h:914
 AtlSgTop_WtChannelFinder.h:915
 AtlSgTop_WtChannelFinder.h:916
 AtlSgTop_WtChannelFinder.h:917
 AtlSgTop_WtChannelFinder.h:918
 AtlSgTop_WtChannelFinder.h:919
 AtlSgTop_WtChannelFinder.h:920
 AtlSgTop_WtChannelFinder.h:921
 AtlSgTop_WtChannelFinder.h:922
 AtlSgTop_WtChannelFinder.h:923
 AtlSgTop_WtChannelFinder.h:924
 AtlSgTop_WtChannelFinder.h:925
 AtlSgTop_WtChannelFinder.h:926
 AtlSgTop_WtChannelFinder.h:927
 AtlSgTop_WtChannelFinder.h:928
 AtlSgTop_WtChannelFinder.h:929
 AtlSgTop_WtChannelFinder.h:930
 AtlSgTop_WtChannelFinder.h:931
 AtlSgTop_WtChannelFinder.h:932
 AtlSgTop_WtChannelFinder.h:933
 AtlSgTop_WtChannelFinder.h:934
 AtlSgTop_WtChannelFinder.h:935
 AtlSgTop_WtChannelFinder.h:936
 AtlSgTop_WtChannelFinder.h:937
 AtlSgTop_WtChannelFinder.h:938
 AtlSgTop_WtChannelFinder.h:939
 AtlSgTop_WtChannelFinder.h:940
 AtlSgTop_WtChannelFinder.h:941
 AtlSgTop_WtChannelFinder.h:942
 AtlSgTop_WtChannelFinder.h:943
 AtlSgTop_WtChannelFinder.h:944
 AtlSgTop_WtChannelFinder.h:945
 AtlSgTop_WtChannelFinder.h:946
 AtlSgTop_WtChannelFinder.h:947
 AtlSgTop_WtChannelFinder.h:948
 AtlSgTop_WtChannelFinder.h:949
 AtlSgTop_WtChannelFinder.h:950
 AtlSgTop_WtChannelFinder.h:951
 AtlSgTop_WtChannelFinder.h:952
 AtlSgTop_WtChannelFinder.h:953
 AtlSgTop_WtChannelFinder.h:954
 AtlSgTop_WtChannelFinder.h:955
 AtlSgTop_WtChannelFinder.h:956
 AtlSgTop_WtChannelFinder.h:957
 AtlSgTop_WtChannelFinder.h:958
 AtlSgTop_WtChannelFinder.h:959
 AtlSgTop_WtChannelFinder.h:960
 AtlSgTop_WtChannelFinder.h:961
 AtlSgTop_WtChannelFinder.h:962
 AtlSgTop_WtChannelFinder.h:963
 AtlSgTop_WtChannelFinder.h:964
 AtlSgTop_WtChannelFinder.h:965
 AtlSgTop_WtChannelFinder.h:966
 AtlSgTop_WtChannelFinder.h:967
 AtlSgTop_WtChannelFinder.h:968
 AtlSgTop_WtChannelFinder.h:969
 AtlSgTop_WtChannelFinder.h:970
 AtlSgTop_WtChannelFinder.h:971
 AtlSgTop_WtChannelFinder.h:972
 AtlSgTop_WtChannelFinder.h:973
 AtlSgTop_WtChannelFinder.h:974
 AtlSgTop_WtChannelFinder.h:975
 AtlSgTop_WtChannelFinder.h:976
 AtlSgTop_WtChannelFinder.h:977
 AtlSgTop_WtChannelFinder.h:978
 AtlSgTop_WtChannelFinder.h:979
 AtlSgTop_WtChannelFinder.h:980
 AtlSgTop_WtChannelFinder.h:981
 AtlSgTop_WtChannelFinder.h:982
 AtlSgTop_WtChannelFinder.h:983
 AtlSgTop_WtChannelFinder.h:984
 AtlSgTop_WtChannelFinder.h:985
 AtlSgTop_WtChannelFinder.h:986
 AtlSgTop_WtChannelFinder.h:987
 AtlSgTop_WtChannelFinder.h:988
 AtlSgTop_WtChannelFinder.h:989
 AtlSgTop_WtChannelFinder.h:990
 AtlSgTop_WtChannelFinder.h:991
 AtlSgTop_WtChannelFinder.h:992
 AtlSgTop_WtChannelFinder.h:993
 AtlSgTop_WtChannelFinder.h:994
 AtlSgTop_WtChannelFinder.h:995
 AtlSgTop_WtChannelFinder.h:996
 AtlSgTop_WtChannelFinder.h:997
 AtlSgTop_WtChannelFinder.h:998
 AtlSgTop_WtChannelFinder.h:999
 AtlSgTop_WtChannelFinder.h:1000
 AtlSgTop_WtChannelFinder.h:1001
 AtlSgTop_WtChannelFinder.h:1002
 AtlSgTop_WtChannelFinder.h:1003
 AtlSgTop_WtChannelFinder.h:1004
 AtlSgTop_WtChannelFinder.h:1005
 AtlSgTop_WtChannelFinder.h:1006
 AtlSgTop_WtChannelFinder.h:1007
 AtlSgTop_WtChannelFinder.h:1008
 AtlSgTop_WtChannelFinder.h:1009
 AtlSgTop_WtChannelFinder.h:1010
 AtlSgTop_WtChannelFinder.h:1011
 AtlSgTop_WtChannelFinder.h:1012
 AtlSgTop_WtChannelFinder.h:1013
 AtlSgTop_WtChannelFinder.h:1014
 AtlSgTop_WtChannelFinder.h:1015
 AtlSgTop_WtChannelFinder.h:1016
 AtlSgTop_WtChannelFinder.h:1017
 AtlSgTop_WtChannelFinder.h:1018
 AtlSgTop_WtChannelFinder.h:1019
 AtlSgTop_WtChannelFinder.h:1020
 AtlSgTop_WtChannelFinder.h:1021
 AtlSgTop_WtChannelFinder.h:1022
 AtlSgTop_WtChannelFinder.h:1023
 AtlSgTop_WtChannelFinder.h:1024
 AtlSgTop_WtChannelFinder.h:1025
 AtlSgTop_WtChannelFinder.h:1026
 AtlSgTop_WtChannelFinder.h:1027
 AtlSgTop_WtChannelFinder.h:1028
 AtlSgTop_WtChannelFinder.h:1029
 AtlSgTop_WtChannelFinder.h:1030
 AtlSgTop_WtChannelFinder.h:1031
 AtlSgTop_WtChannelFinder.h:1032
 AtlSgTop_WtChannelFinder.h:1033
 AtlSgTop_WtChannelFinder.h:1034
 AtlSgTop_WtChannelFinder.h:1035
 AtlSgTop_WtChannelFinder.h:1036
 AtlSgTop_WtChannelFinder.h:1037
 AtlSgTop_WtChannelFinder.h:1038
 AtlSgTop_WtChannelFinder.h:1039
 AtlSgTop_WtChannelFinder.h:1040
 AtlSgTop_WtChannelFinder.h:1041
 AtlSgTop_WtChannelFinder.h:1042
 AtlSgTop_WtChannelFinder.h:1043
 AtlSgTop_WtChannelFinder.h:1044
 AtlSgTop_WtChannelFinder.h:1045
 AtlSgTop_WtChannelFinder.h:1046
 AtlSgTop_WtChannelFinder.h:1047
 AtlSgTop_WtChannelFinder.h:1048
 AtlSgTop_WtChannelFinder.h:1049
 AtlSgTop_WtChannelFinder.h:1050
 AtlSgTop_WtChannelFinder.h:1051
 AtlSgTop_WtChannelFinder.h:1052
 AtlSgTop_WtChannelFinder.h:1053
 AtlSgTop_WtChannelFinder.h:1054
 AtlSgTop_WtChannelFinder.h:1055
 AtlSgTop_WtChannelFinder.h:1056
 AtlSgTop_WtChannelFinder.h:1057
 AtlSgTop_WtChannelFinder.h:1058
 AtlSgTop_WtChannelFinder.h:1059
 AtlSgTop_WtChannelFinder.h:1060
 AtlSgTop_WtChannelFinder.h:1061
 AtlSgTop_WtChannelFinder.h:1062
 AtlSgTop_WtChannelFinder.h:1063
 AtlSgTop_WtChannelFinder.h:1064
 AtlSgTop_WtChannelFinder.h:1065
 AtlSgTop_WtChannelFinder.h:1066
 AtlSgTop_WtChannelFinder.h:1067
 AtlSgTop_WtChannelFinder.h:1068
 AtlSgTop_WtChannelFinder.h:1069
 AtlSgTop_WtChannelFinder.h:1070
 AtlSgTop_WtChannelFinder.h:1071
 AtlSgTop_WtChannelFinder.h:1072
 AtlSgTop_WtChannelFinder.h:1073
 AtlSgTop_WtChannelFinder.h:1074
 AtlSgTop_WtChannelFinder.h:1075
 AtlSgTop_WtChannelFinder.h:1076
 AtlSgTop_WtChannelFinder.h:1077
 AtlSgTop_WtChannelFinder.h:1078
 AtlSgTop_WtChannelFinder.h:1079
 AtlSgTop_WtChannelFinder.h:1080
 AtlSgTop_WtChannelFinder.h:1081
 AtlSgTop_WtChannelFinder.h:1082
 AtlSgTop_WtChannelFinder.h:1083
 AtlSgTop_WtChannelFinder.h:1084
 AtlSgTop_WtChannelFinder.h:1085
 AtlSgTop_WtChannelFinder.h:1086
 AtlSgTop_WtChannelFinder.h:1087
 AtlSgTop_WtChannelFinder.h:1088
 AtlSgTop_WtChannelFinder.h:1089
 AtlSgTop_WtChannelFinder.h:1090
 AtlSgTop_WtChannelFinder.h:1091
 AtlSgTop_WtChannelFinder.h:1092
 AtlSgTop_WtChannelFinder.h:1093
 AtlSgTop_WtChannelFinder.h:1094
 AtlSgTop_WtChannelFinder.h:1095
 AtlSgTop_WtChannelFinder.h:1096
 AtlSgTop_WtChannelFinder.h:1097
 AtlSgTop_WtChannelFinder.h:1098
 AtlSgTop_WtChannelFinder.h:1099
 AtlSgTop_WtChannelFinder.h:1100
 AtlSgTop_WtChannelFinder.h:1101
 AtlSgTop_WtChannelFinder.h:1102
 AtlSgTop_WtChannelFinder.h:1103
 AtlSgTop_WtChannelFinder.h:1104
 AtlSgTop_WtChannelFinder.h:1105
 AtlSgTop_WtChannelFinder.h:1106
 AtlSgTop_WtChannelFinder.h:1107
 AtlSgTop_WtChannelFinder.h:1108
 AtlSgTop_WtChannelFinder.h:1109
 AtlSgTop_WtChannelFinder.h:1110
 AtlSgTop_WtChannelFinder.h:1111
 AtlSgTop_WtChannelFinder.h:1112
 AtlSgTop_WtChannelFinder.h:1113
 AtlSgTop_WtChannelFinder.h:1114
 AtlSgTop_WtChannelFinder.h:1115
 AtlSgTop_WtChannelFinder.h:1116
 AtlSgTop_WtChannelFinder.h:1117
 AtlSgTop_WtChannelFinder.h:1118
 AtlSgTop_WtChannelFinder.h:1119
 AtlSgTop_WtChannelFinder.h:1120
 AtlSgTop_WtChannelFinder.h:1121
 AtlSgTop_WtChannelFinder.h:1122
 AtlSgTop_WtChannelFinder.h:1123
 AtlSgTop_WtChannelFinder.h:1124
 AtlSgTop_WtChannelFinder.h:1125
 AtlSgTop_WtChannelFinder.h:1126
 AtlSgTop_WtChannelFinder.h:1127
 AtlSgTop_WtChannelFinder.h:1128
 AtlSgTop_WtChannelFinder.h:1129
 AtlSgTop_WtChannelFinder.h:1130
 AtlSgTop_WtChannelFinder.h:1131
 AtlSgTop_WtChannelFinder.h:1132
 AtlSgTop_WtChannelFinder.h:1133
 AtlSgTop_WtChannelFinder.h:1134
 AtlSgTop_WtChannelFinder.h:1135
 AtlSgTop_WtChannelFinder.h:1136
 AtlSgTop_WtChannelFinder.h:1137
 AtlSgTop_WtChannelFinder.h:1138
 AtlSgTop_WtChannelFinder.h:1139
 AtlSgTop_WtChannelFinder.h:1140
 AtlSgTop_WtChannelFinder.h:1141
 AtlSgTop_WtChannelFinder.h:1142
 AtlSgTop_WtChannelFinder.h:1143
 AtlSgTop_WtChannelFinder.h:1144
 AtlSgTop_WtChannelFinder.h:1145
 AtlSgTop_WtChannelFinder.h:1146
 AtlSgTop_WtChannelFinder.h:1147
 AtlSgTop_WtChannelFinder.h:1148
 AtlSgTop_WtChannelFinder.h:1149
 AtlSgTop_WtChannelFinder.h:1150
 AtlSgTop_WtChannelFinder.h:1151
 AtlSgTop_WtChannelFinder.h:1152
 AtlSgTop_WtChannelFinder.h:1153
 AtlSgTop_WtChannelFinder.h:1154
 AtlSgTop_WtChannelFinder.h:1155
 AtlSgTop_WtChannelFinder.h:1156
 AtlSgTop_WtChannelFinder.h:1157
 AtlSgTop_WtChannelFinder.h:1158
 AtlSgTop_WtChannelFinder.h:1159
 AtlSgTop_WtChannelFinder.h:1160
 AtlSgTop_WtChannelFinder.h:1161
 AtlSgTop_WtChannelFinder.h:1162
 AtlSgTop_WtChannelFinder.h:1163
 AtlSgTop_WtChannelFinder.h:1164
 AtlSgTop_WtChannelFinder.h:1165
 AtlSgTop_WtChannelFinder.h:1166
 AtlSgTop_WtChannelFinder.h:1167
 AtlSgTop_WtChannelFinder.h:1168
 AtlSgTop_WtChannelFinder.h:1169
 AtlSgTop_WtChannelFinder.h:1170
 AtlSgTop_WtChannelFinder.h:1171
 AtlSgTop_WtChannelFinder.h:1172
 AtlSgTop_WtChannelFinder.h:1173
 AtlSgTop_WtChannelFinder.h:1174
 AtlSgTop_WtChannelFinder.h:1175
 AtlSgTop_WtChannelFinder.h:1176
 AtlSgTop_WtChannelFinder.h:1177
 AtlSgTop_WtChannelFinder.h:1178
 AtlSgTop_WtChannelFinder.h:1179
 AtlSgTop_WtChannelFinder.h:1180
 AtlSgTop_WtChannelFinder.h:1181
 AtlSgTop_WtChannelFinder.h:1182
 AtlSgTop_WtChannelFinder.h:1183
 AtlSgTop_WtChannelFinder.h:1184
 AtlSgTop_WtChannelFinder.h:1185
 AtlSgTop_WtChannelFinder.h:1186
 AtlSgTop_WtChannelFinder.h:1187
 AtlSgTop_WtChannelFinder.h:1188
 AtlSgTop_WtChannelFinder.h:1189
 AtlSgTop_WtChannelFinder.h:1190
 AtlSgTop_WtChannelFinder.h:1191
 AtlSgTop_WtChannelFinder.h:1192
 AtlSgTop_WtChannelFinder.h:1193
 AtlSgTop_WtChannelFinder.h:1194
 AtlSgTop_WtChannelFinder.h:1195
 AtlSgTop_WtChannelFinder.h:1196
 AtlSgTop_WtChannelFinder.h:1197
 AtlSgTop_WtChannelFinder.h:1198
 AtlSgTop_WtChannelFinder.h:1199
 AtlSgTop_WtChannelFinder.h:1200
 AtlSgTop_WtChannelFinder.h:1201
 AtlSgTop_WtChannelFinder.h:1202
 AtlSgTop_WtChannelFinder.h:1203
 AtlSgTop_WtChannelFinder.h:1204
 AtlSgTop_WtChannelFinder.h:1205
 AtlSgTop_WtChannelFinder.h:1206
 AtlSgTop_WtChannelFinder.h:1207
 AtlSgTop_WtChannelFinder.h:1208
 AtlSgTop_WtChannelFinder.h:1209
 AtlSgTop_WtChannelFinder.h:1210
 AtlSgTop_WtChannelFinder.h:1211
 AtlSgTop_WtChannelFinder.h:1212
 AtlSgTop_WtChannelFinder.h:1213
 AtlSgTop_WtChannelFinder.h:1214
 AtlSgTop_WtChannelFinder.h:1215
 AtlSgTop_WtChannelFinder.h:1216
 AtlSgTop_WtChannelFinder.h:1217
 AtlSgTop_WtChannelFinder.h:1218
 AtlSgTop_WtChannelFinder.h:1219
 AtlSgTop_WtChannelFinder.h:1220
 AtlSgTop_WtChannelFinder.h:1221
 AtlSgTop_WtChannelFinder.h:1222
 AtlSgTop_WtChannelFinder.h:1223
 AtlSgTop_WtChannelFinder.h:1224
 AtlSgTop_WtChannelFinder.h:1225
 AtlSgTop_WtChannelFinder.h:1226
 AtlSgTop_WtChannelFinder.h:1227
 AtlSgTop_WtChannelFinder.h:1228
 AtlSgTop_WtChannelFinder.h:1229
 AtlSgTop_WtChannelFinder.h:1230
 AtlSgTop_WtChannelFinder.h:1231
 AtlSgTop_WtChannelFinder.h:1232
 AtlSgTop_WtChannelFinder.h:1233
 AtlSgTop_WtChannelFinder.h:1234
 AtlSgTop_WtChannelFinder.h:1235
 AtlSgTop_WtChannelFinder.h:1236
 AtlSgTop_WtChannelFinder.h:1237
 AtlSgTop_WtChannelFinder.h:1238
 AtlSgTop_WtChannelFinder.h:1239
 AtlSgTop_WtChannelFinder.h:1240
 AtlSgTop_WtChannelFinder.h:1241
 AtlSgTop_WtChannelFinder.h:1242
 AtlSgTop_WtChannelFinder.h:1243
 AtlSgTop_WtChannelFinder.h:1244
 AtlSgTop_WtChannelFinder.h:1245
 AtlSgTop_WtChannelFinder.h:1246
 AtlSgTop_WtChannelFinder.h:1247
 AtlSgTop_WtChannelFinder.h:1248
 AtlSgTop_WtChannelFinder.h:1249
 AtlSgTop_WtChannelFinder.h:1250
 AtlSgTop_WtChannelFinder.h:1251
 AtlSgTop_WtChannelFinder.h:1252
 AtlSgTop_WtChannelFinder.h:1253
 AtlSgTop_WtChannelFinder.h:1254
 AtlSgTop_WtChannelFinder.h:1255
 AtlSgTop_WtChannelFinder.h:1256
 AtlSgTop_WtChannelFinder.h:1257
 AtlSgTop_WtChannelFinder.h:1258
 AtlSgTop_WtChannelFinder.h:1259
 AtlSgTop_WtChannelFinder.h:1260
 AtlSgTop_WtChannelFinder.h:1261
 AtlSgTop_WtChannelFinder.h:1262
 AtlSgTop_WtChannelFinder.h:1263
 AtlSgTop_WtChannelFinder.h:1264
 AtlSgTop_WtChannelFinder.h:1265
 AtlSgTop_WtChannelFinder.h:1266
 AtlSgTop_WtChannelFinder.h:1267
 AtlSgTop_WtChannelFinder.h:1268
 AtlSgTop_WtChannelFinder.h:1269
 AtlSgTop_WtChannelFinder.h:1270
 AtlSgTop_WtChannelFinder.h:1271
 AtlSgTop_WtChannelFinder.h:1272
 AtlSgTop_WtChannelFinder.h:1273
 AtlSgTop_WtChannelFinder.h:1274
 AtlSgTop_WtChannelFinder.h:1275
 AtlSgTop_WtChannelFinder.h:1276
 AtlSgTop_WtChannelFinder.h:1277
 AtlSgTop_WtChannelFinder.h:1278
 AtlSgTop_WtChannelFinder.h:1279
 AtlSgTop_WtChannelFinder.h:1280
 AtlSgTop_WtChannelFinder.h:1281
 AtlSgTop_WtChannelFinder.h:1282
 AtlSgTop_WtChannelFinder.h:1283
 AtlSgTop_WtChannelFinder.h:1284
 AtlSgTop_WtChannelFinder.h:1285
 AtlSgTop_WtChannelFinder.h:1286
 AtlSgTop_WtChannelFinder.h:1287
 AtlSgTop_WtChannelFinder.h:1288
 AtlSgTop_WtChannelFinder.h:1289
 AtlSgTop_WtChannelFinder.h:1290
 AtlSgTop_WtChannelFinder.h:1291
 AtlSgTop_WtChannelFinder.h:1292
 AtlSgTop_WtChannelFinder.h:1293
 AtlSgTop_WtChannelFinder.h:1294
 AtlSgTop_WtChannelFinder.h:1295
 AtlSgTop_WtChannelFinder.h:1296
 AtlSgTop_WtChannelFinder.h:1297
 AtlSgTop_WtChannelFinder.h:1298
 AtlSgTop_WtChannelFinder.h:1299
 AtlSgTop_WtChannelFinder.h:1300
 AtlSgTop_WtChannelFinder.h:1301
 AtlSgTop_WtChannelFinder.h:1302
 AtlSgTop_WtChannelFinder.h:1303
 AtlSgTop_WtChannelFinder.h:1304
 AtlSgTop_WtChannelFinder.h:1305
 AtlSgTop_WtChannelFinder.h:1306
 AtlSgTop_WtChannelFinder.h:1307
 AtlSgTop_WtChannelFinder.h:1308
 AtlSgTop_WtChannelFinder.h:1309
 AtlSgTop_WtChannelFinder.h:1310
 AtlSgTop_WtChannelFinder.h:1311
 AtlSgTop_WtChannelFinder.h:1312
 AtlSgTop_WtChannelFinder.h:1313
 AtlSgTop_WtChannelFinder.h:1314
 AtlSgTop_WtChannelFinder.h:1315
 AtlSgTop_WtChannelFinder.h:1316
 AtlSgTop_WtChannelFinder.h:1317
 AtlSgTop_WtChannelFinder.h:1318
 AtlSgTop_WtChannelFinder.h:1319
 AtlSgTop_WtChannelFinder.h:1320
 AtlSgTop_WtChannelFinder.h:1321
 AtlSgTop_WtChannelFinder.h:1322
 AtlSgTop_WtChannelFinder.h:1323
 AtlSgTop_WtChannelFinder.h:1324
 AtlSgTop_WtChannelFinder.h:1325
 AtlSgTop_WtChannelFinder.h:1326
 AtlSgTop_WtChannelFinder.h:1327
 AtlSgTop_WtChannelFinder.h:1328
 AtlSgTop_WtChannelFinder.h:1329
 AtlSgTop_WtChannelFinder.h:1330
 AtlSgTop_WtChannelFinder.h:1331
 AtlSgTop_WtChannelFinder.h:1332
 AtlSgTop_WtChannelFinder.h:1333
 AtlSgTop_WtChannelFinder.h:1334
 AtlSgTop_WtChannelFinder.h:1335
 AtlSgTop_WtChannelFinder.h:1336
 AtlSgTop_WtChannelFinder.h:1337
 AtlSgTop_WtChannelFinder.h:1338
 AtlSgTop_WtChannelFinder.h:1339
 AtlSgTop_WtChannelFinder.h:1340
 AtlSgTop_WtChannelFinder.h:1341
 AtlSgTop_WtChannelFinder.h:1342
 AtlSgTop_WtChannelFinder.h:1343
 AtlSgTop_WtChannelFinder.h:1344
 AtlSgTop_WtChannelFinder.h:1345
 AtlSgTop_WtChannelFinder.h:1346
 AtlSgTop_WtChannelFinder.h:1347
 AtlSgTop_WtChannelFinder.h:1348
 AtlSgTop_WtChannelFinder.h:1349
 AtlSgTop_WtChannelFinder.h:1350
 AtlSgTop_WtChannelFinder.h:1351
 AtlSgTop_WtChannelFinder.h:1352
 AtlSgTop_WtChannelFinder.h:1353
 AtlSgTop_WtChannelFinder.h:1354
 AtlSgTop_WtChannelFinder.h:1355
 AtlSgTop_WtChannelFinder.h:1356
 AtlSgTop_WtChannelFinder.h:1357
 AtlSgTop_WtChannelFinder.h:1358
 AtlSgTop_WtChannelFinder.h:1359
 AtlSgTop_WtChannelFinder.h:1360
 AtlSgTop_WtChannelFinder.h:1361
 AtlSgTop_WtChannelFinder.h:1362
 AtlSgTop_WtChannelFinder.h:1363
 AtlSgTop_WtChannelFinder.h:1364
 AtlSgTop_WtChannelFinder.h:1365
 AtlSgTop_WtChannelFinder.h:1366
 AtlSgTop_WtChannelFinder.h:1367
 AtlSgTop_WtChannelFinder.h:1368
 AtlSgTop_WtChannelFinder.h:1369
 AtlSgTop_WtChannelFinder.h:1370
 AtlSgTop_WtChannelFinder.h:1371
 AtlSgTop_WtChannelFinder.h:1372
 AtlSgTop_WtChannelFinder.h:1373
 AtlSgTop_WtChannelFinder.h:1374
 AtlSgTop_WtChannelFinder.h:1375
 AtlSgTop_WtChannelFinder.h:1376
 AtlSgTop_WtChannelFinder.h:1377
 AtlSgTop_WtChannelFinder.h:1378
 AtlSgTop_WtChannelFinder.h:1379
 AtlSgTop_WtChannelFinder.h:1380
 AtlSgTop_WtChannelFinder.h:1381
 AtlSgTop_WtChannelFinder.h:1382
 AtlSgTop_WtChannelFinder.h:1383
 AtlSgTop_WtChannelFinder.h:1384
 AtlSgTop_WtChannelFinder.h:1385
 AtlSgTop_WtChannelFinder.h:1386
 AtlSgTop_WtChannelFinder.h:1387
 AtlSgTop_WtChannelFinder.h:1388
 AtlSgTop_WtChannelFinder.h:1389
 AtlSgTop_WtChannelFinder.h:1390
 AtlSgTop_WtChannelFinder.h:1391
 AtlSgTop_WtChannelFinder.h:1392
 AtlSgTop_WtChannelFinder.h:1393
 AtlSgTop_WtChannelFinder.h:1394
 AtlSgTop_WtChannelFinder.h:1395
 AtlSgTop_WtChannelFinder.h:1396
 AtlSgTop_WtChannelFinder.h:1397
 AtlSgTop_WtChannelFinder.h:1398
 AtlSgTop_WtChannelFinder.h:1399
 AtlSgTop_WtChannelFinder.h:1400
 AtlSgTop_WtChannelFinder.h:1401
 AtlSgTop_WtChannelFinder.h:1402
 AtlSgTop_WtChannelFinder.h:1403
 AtlSgTop_WtChannelFinder.h:1404
 AtlSgTop_WtChannelFinder.h:1405
 AtlSgTop_WtChannelFinder.h:1406
 AtlSgTop_WtChannelFinder.h:1407
 AtlSgTop_WtChannelFinder.h:1408
 AtlSgTop_WtChannelFinder.h:1409
 AtlSgTop_WtChannelFinder.h:1410
 AtlSgTop_WtChannelFinder.h:1411
 AtlSgTop_WtChannelFinder.h:1412
 AtlSgTop_WtChannelFinder.h:1413
 AtlSgTop_WtChannelFinder.h:1414
 AtlSgTop_WtChannelFinder.h:1415
 AtlSgTop_WtChannelFinder.h:1416
 AtlSgTop_WtChannelFinder.h:1417
 AtlSgTop_WtChannelFinder.h:1418
 AtlSgTop_WtChannelFinder.h:1419
 AtlSgTop_WtChannelFinder.h:1420
 AtlSgTop_WtChannelFinder.h:1421
 AtlSgTop_WtChannelFinder.h:1422
 AtlSgTop_WtChannelFinder.h:1423
 AtlSgTop_WtChannelFinder.h:1424
 AtlSgTop_WtChannelFinder.h:1425
 AtlSgTop_WtChannelFinder.h:1426
 AtlSgTop_WtChannelFinder.h:1427
 AtlSgTop_WtChannelFinder.h:1428
 AtlSgTop_WtChannelFinder.h:1429
 AtlSgTop_WtChannelFinder.h:1430
 AtlSgTop_WtChannelFinder.h:1431
 AtlSgTop_WtChannelFinder.h:1432
 AtlSgTop_WtChannelFinder.h:1433
 AtlSgTop_WtChannelFinder.h:1434
 AtlSgTop_WtChannelFinder.h:1435
 AtlSgTop_WtChannelFinder.h:1436
 AtlSgTop_WtChannelFinder.h:1437
 AtlSgTop_WtChannelFinder.h:1438
 AtlSgTop_WtChannelFinder.h:1439
 AtlSgTop_WtChannelFinder.h:1440
 AtlSgTop_WtChannelFinder.h:1441
 AtlSgTop_WtChannelFinder.h:1442
 AtlSgTop_WtChannelFinder.h:1443
 AtlSgTop_WtChannelFinder.h:1444
 AtlSgTop_WtChannelFinder.h:1445
 AtlSgTop_WtChannelFinder.h:1446
 AtlSgTop_WtChannelFinder.h:1447
 AtlSgTop_WtChannelFinder.h:1448
 AtlSgTop_WtChannelFinder.h:1449
 AtlSgTop_WtChannelFinder.h:1450
 AtlSgTop_WtChannelFinder.h:1451
 AtlSgTop_WtChannelFinder.h:1452
 AtlSgTop_WtChannelFinder.h:1453
 AtlSgTop_WtChannelFinder.h:1454
 AtlSgTop_WtChannelFinder.h:1455
 AtlSgTop_WtChannelFinder.h:1456
 AtlSgTop_WtChannelFinder.h:1457
 AtlSgTop_WtChannelFinder.h:1458
 AtlSgTop_WtChannelFinder.h:1459
 AtlSgTop_WtChannelFinder.h:1460
 AtlSgTop_WtChannelFinder.h:1461
 AtlSgTop_WtChannelFinder.h:1462
 AtlSgTop_WtChannelFinder.h:1463
 AtlSgTop_WtChannelFinder.h:1464
 AtlSgTop_WtChannelFinder.h:1465
 AtlSgTop_WtChannelFinder.h:1466
 AtlSgTop_WtChannelFinder.h:1467
 AtlSgTop_WtChannelFinder.h:1468
 AtlSgTop_WtChannelFinder.h:1469
 AtlSgTop_WtChannelFinder.h:1470
 AtlSgTop_WtChannelFinder.h:1471
 AtlSgTop_WtChannelFinder.h:1472
 AtlSgTop_WtChannelFinder.h:1473
 AtlSgTop_WtChannelFinder.h:1474
 AtlSgTop_WtChannelFinder.h:1475
 AtlSgTop_WtChannelFinder.h:1476
 AtlSgTop_WtChannelFinder.h:1477
 AtlSgTop_WtChannelFinder.h:1478
 AtlSgTop_WtChannelFinder.h:1479
 AtlSgTop_WtChannelFinder.h:1480
 AtlSgTop_WtChannelFinder.h:1481
 AtlSgTop_WtChannelFinder.h:1482
 AtlSgTop_WtChannelFinder.h:1483
 AtlSgTop_WtChannelFinder.h:1484
 AtlSgTop_WtChannelFinder.h:1485
 AtlSgTop_WtChannelFinder.h:1486
 AtlSgTop_WtChannelFinder.h:1487
 AtlSgTop_WtChannelFinder.h:1488
 AtlSgTop_WtChannelFinder.h:1489
 AtlSgTop_WtChannelFinder.h:1490
 AtlSgTop_WtChannelFinder.h:1491
 AtlSgTop_WtChannelFinder.h:1492
 AtlSgTop_WtChannelFinder.h:1493
 AtlSgTop_WtChannelFinder.h:1494
 AtlSgTop_WtChannelFinder.h:1495
 AtlSgTop_WtChannelFinder.h:1496
 AtlSgTop_WtChannelFinder.h:1497
 AtlSgTop_WtChannelFinder.h:1498
 AtlSgTop_WtChannelFinder.h:1499
 AtlSgTop_WtChannelFinder.h:1500
 AtlSgTop_WtChannelFinder.h:1501
 AtlSgTop_WtChannelFinder.h:1502
 AtlSgTop_WtChannelFinder.h:1503
 AtlSgTop_WtChannelFinder.h:1504
 AtlSgTop_WtChannelFinder.h:1505
 AtlSgTop_WtChannelFinder.h:1506
 AtlSgTop_WtChannelFinder.h:1507
 AtlSgTop_WtChannelFinder.h:1508
 AtlSgTop_WtChannelFinder.h:1509
 AtlSgTop_WtChannelFinder.h:1510
 AtlSgTop_WtChannelFinder.h:1511
 AtlSgTop_WtChannelFinder.h:1512
 AtlSgTop_WtChannelFinder.h:1513
 AtlSgTop_WtChannelFinder.h:1514
 AtlSgTop_WtChannelFinder.h:1515
 AtlSgTop_WtChannelFinder.h:1516
 AtlSgTop_WtChannelFinder.h:1517
 AtlSgTop_WtChannelFinder.h:1518
 AtlSgTop_WtChannelFinder.h:1519
 AtlSgTop_WtChannelFinder.h:1520
 AtlSgTop_WtChannelFinder.h:1521
 AtlSgTop_WtChannelFinder.h:1522
 AtlSgTop_WtChannelFinder.h:1523
 AtlSgTop_WtChannelFinder.h:1524
 AtlSgTop_WtChannelFinder.h:1525
 AtlSgTop_WtChannelFinder.h:1526
 AtlSgTop_WtChannelFinder.h:1527
 AtlSgTop_WtChannelFinder.h:1528
 AtlSgTop_WtChannelFinder.h:1529
 AtlSgTop_WtChannelFinder.h:1530
 AtlSgTop_WtChannelFinder.h:1531
 AtlSgTop_WtChannelFinder.h:1532
 AtlSgTop_WtChannelFinder.h:1533
 AtlSgTop_WtChannelFinder.h:1534
 AtlSgTop_WtChannelFinder.h:1535
 AtlSgTop_WtChannelFinder.h:1536
 AtlSgTop_WtChannelFinder.h:1537
 AtlSgTop_WtChannelFinder.h:1538
 AtlSgTop_WtChannelFinder.h:1539
 AtlSgTop_WtChannelFinder.h:1540
 AtlSgTop_WtChannelFinder.h:1541
 AtlSgTop_WtChannelFinder.h:1542
 AtlSgTop_WtChannelFinder.h:1543