Fork me on GitHub

Changeset 258 in svn for trunk


Ignore:
Timestamp:
Feb 9, 2009, 11:31:56 AM (15 years ago)
Author:
severine ovyn
Message:

resolution from delphes output

Location:
trunk
Files:
3 edited

Legend:

Unmodified
Added
Removed
  • trunk/Delphes.cpp

    r251 r258  
    192192  cout <<"**        ####### Start reading DETECTOR parameters #######        **"<< endl;
    193193  cout << left  << setw(40) <<"**        Opening configuration card: "<<""
    194        << left  << setw(20) << DetDatacard                            <<""
    195        << right << setw(9) <<" **"<<""<<endl;
     194       << left  << setw(27) << DetDatacard                            <<""
     195       << right << setw(2) <<"**"<<""<<endl;
    196196  DET->ReadDataCard(DetDatacard);
    197197  DET->Logfile(LogName);
    198198  cout << left  << setw(42) <<"**        Parameters summarised in file: "<<""
    199        << left  << setw(20) << LogName                            <<""
    200        << right << setw(7) <<"**"<<""<<endl;
     199       << left  << setw(27) << LogName                            <<""
     200       << right << setw(2) <<"**"<<""<<endl;
    201201  cout <<"**                                                                 **"<< endl;
    202202
     
    214214    {
    215215      cout << left  << setw(40) <<"**        Opening configuration card: "<<""
    216            << left  << setw(20) << TrigDatacard                            <<""
    217            << right << setw(9) <<" **"<<""<<endl;
     216           << left  << setw(27) << TrigDatacard                            <<""
     217           << right << setw(2) <<"**"<<""<<endl;
    218218      cout <<"**                                                                 **"<< endl;
    219219    }
     
    331331      treeWriter->Clear();
    332332      if((entry % 100) == 0 && entry > 0 ) {
    333          cout << left  << setw(52) <<"**              Processing element # "<<""
    334               << left  << setw(15) << entry <<""
    335               << right << setw(2) <<"**"<<endl;
     333  //       cout << left  << setw(52) <<"**              Processing element # "<<""
     334    //          << left  << setw(15) << entry <<""
     335    //          << right << setw(2) <<"**"<<endl;
    336336      }
    337337     
  • trunk/Resolutions.cpp

    r227 r258  
    6060       if(abs(gen1->PID)==15)
    6161         {
     62cout<<"au moins on a un tau "<<endl;
    6263            int d1=gen1->D1;
    6364            int d2=gen1->D2;
    64 
     65cout<<"il a des filles? "<<endl;
    6566            if((d1 < array.GetEntries()) && (d1 > 0) && (d2 < array.GetEntries()) && (d2 > 0))
    6667               {
    6768                 tauhad=true;
    6869                 for(int d=d1; d < d2+1; d++)
    69                     {
     70                    {cout<<abs(array[d]->PID)<<"  "<<endl;
    7071                      if(abs(array[d]->PID)== pE || abs(array[d]->PID)== pMU)tauhad=false;
    7172                    }
     
    7778 }
    7879
    79 
    80 
    81 void PairingJet(TLorentzVector &JETSm, const TLorentzVector &JET,  vector<fastjet::PseudoJet> sorted_jetsS)
     80double EnergySmallCone(const vector<TLorentzVector> &towers, const float eta, const float phi,float energy_scone,float JET_seed) {
     81  double Energie=0;
     82  for(unsigned int i=0; i < towers.size(); i++) {
     83      if(towers[i].Pt() < JET_seed) continue;
     84      if((DeltaR(phi,eta,towers[i].Phi(),towers[i].Eta()) < energy_scone)) {
     85          Energie += towers[i].E();
     86      }
     87  }
     88  return Energie;
     89}
     90
     91
     92void PairingJet(TLorentzVector &JETSm, const TLorentzVector &JET, const TClonesArray *branchJet)
    8293{
    8394  JETSm.SetPxPyPzE(0,0,0,0);
    8495  float deltaRtest=5000;
    85   for (unsigned int i = 0; i < sorted_jetsS.size(); i++) {
     96  TIter itJet((TCollection*)branchJet);
     97  TRootJet *jet;
     98  itJet.Reset();
     99  while( (jet = (TRootJet*) itJet.Next()) )
     100   {
    86101      TLorentzVector Att;
    87       Att.SetPxPyPzE(sorted_jetsS[i].px(),sorted_jetsS[i].py(),sorted_jetsS[i].pz(),sorted_jetsS[i].E());
     102      Att.SetPxPyPzE(jet->Px,jet->Py,jet->Pz,jet->E);
    88103      if(DeltaR(JET.Phi(),JET.Eta(),Att.Phi(),Att.Eta()) < deltaRtest)
    89104        {
     
    97112}
    98113
     114void PairingElec(TLorentzVector &ELECSm, const TLorentzVector &ELEC, const TClonesArray *branchElec)
     115{
     116  ELECSm.SetPxPyPzE(0,0,0,0);
     117  float deltaRtest=5000;
     118  TIter itElec((TCollection*)branchElec);
     119  TRootElectron *elec;
     120  itElec.Reset();
     121  while( (elec = (TRootElectron*) itElec.Next()) )
     122   {
     123      TLorentzVector Att;
     124      Att.SetPxPyPzE(elec->Px,elec->Py,elec->Pz,elec->E);
     125      if(DeltaR(ELEC.Phi(),ELEC.Eta(),Att.Phi(),Att.Eta()) < deltaRtest)
     126        {
     127          deltaRtest = DeltaR(ELEC.Phi(),ELEC.Eta(),Att.Phi(),Att.Eta());
     128          if(deltaRtest < 0.025)
     129             {
     130               ELECSm = Att;
     131             }
     132        }
     133    }
     134}
     135
     136void PairingMuon(TLorentzVector &MUONSm, const TLorentzVector &MUON, const TClonesArray *branchMuon)
     137{
     138  MUONSm.SetPxPyPzE(0,0,0,0);
     139  float deltaRtest=5000;
     140  TIter itMuon((TCollection*)branchMuon);
     141  TRootMuon *muon;
     142  itMuon.Reset();
     143  while( (muon = (TRootMuon*) itMuon.Next()) )
     144   {
     145      TLorentzVector Att;
     146      Att.SetPxPyPzE(muon->Px,muon->Py,muon->Pz,muon->E);
     147      if(DeltaR(MUON.Phi(),MUON.Eta(),Att.Phi(),Att.Eta()) < deltaRtest)
     148        {
     149          deltaRtest = DeltaR(MUON.Phi(),MUON.Eta(),Att.Phi(),Att.Eta());
     150          if(deltaRtest < 0.025)
     151             {
     152               MUONSm = Att;
     153             }
     154        }
     155    }
     156}
     157
     158unsigned int NumTracks(const TClonesArray *branchTracks, const float pt_track, const float eta, const float phi,float track_scone) {
     159  unsigned int numtrack=0;
     160  TIter itTrack((TCollection*)branchTracks);
     161  TRootTracks *track;
     162  itTrack.Reset();
     163  while( (track = (TRootTracks*) itTrack.Next()) )
     164   {
     165      if((track->PT < pt_track )||
     166         (DeltaR(phi,eta,track->Phi,track->Eta) > track_scone)
     167        )continue;
     168      numtrack++;
     169  }
     170  return numtrack;
     171}
     172
     173
     174
    99175int main(int argc, char *argv[])
    100176{
    101177  int appargc = 2;
    102   char *appName = "Smearing";
     178  char *appName = "Resolution";
    103179  char *appargv[] = {appName, "-b"};
    104180  TApplication app(appName, &appargc, appargv);
    105181 
    106   if(argc != 4 && argc != 3) {
    107       cout << " Usage: " << argv[0] << " input_file" << " output_file" << " data_card " << endl;
    108       cout << " input_list - list of files in Ntpl, StdHep of LHEF format," << endl;
     182  if(argc != 3) {
     183      cout << " Usage: " << argv[0] << " input_file" << " output_file" << endl;
     184      cout << " input_list - list of files in root format," << endl;
    109185      cout << " output_file - output file." << endl;
    110       cout << " data_card - Datacard containing resolution variables for the detector simulation (optional) "<<endl;
    111186      exit(1);
    112187  }
     
    115190 
    116191  //read the input TROOT file
    117   string inputFileList(argv[1]), outputfilename(argv[2]);
     192  string inputfilename(argv[1]), outputfilename(argv[2]);
     193
    118194  if(outputfilename.find(".root") > outputfilename.length() ) {
    119195    cout << "output_file should be a .root file!\n";
     
    121197  }
    122198
     199
     200
    123201  TFile *outputFile = TFile::Open(outputfilename.c_str(), "RECREATE"); // Creates the file, but should be closed just after
    124202  outputFile->Close();
    125203 
    126   string line;
    127   ifstream infile(inputFileList.c_str());
    128   infile >> line; // the first line determines the type of input files
    129  
    130   DataConverter *converter=0;
    131  
    132   if(strstr(line.c_str(),".hep"))
    133     {                           
    134       cout<<"*************************************************************************"<<endl;
    135       cout<<"************         StdHEP file format detected           **************"<<endl;
    136       cout<<"************     Starting convertion to TRoot format       **************"<<endl;
    137       cout<<"*************************************************************************"<<endl;
    138       converter = new STDHEPConverter(inputFileList,outputfilename);//case ntpl file in input list
    139     }
    140   else if(strstr(line.c_str(),".lhe"))
    141     {
    142       cout<<"*************************************************************************"<<endl;
    143       cout<<"************          LHEF file format detected            **************"<<endl;
    144       cout<<"************     Starting convertion to TRoot format       **************"<<endl;
    145       cout<<"*************************************************************************"<<endl;
    146       converter = new LHEFConverter(inputFileList,outputfilename);//case ntpl file in input list
    147     }
    148   else if(strstr(line.c_str(),".root"))
    149     {
    150       cout<<"*************************************************************************"<<endl;
    151       cout<<"************         h2root file format detected           **************"<<endl;
    152       cout<<"************     Starting convertion to TRoot format       **************"<<endl;
    153       cout<<"*************************************************************************"<<endl;
    154       converter = new HEPEVTConverter(inputFileList,outputfilename);//case ntpl file in input list
    155     }
    156   else { cout << "***  " << line.c_str() << "\n***  file format not identified\n***  Exiting\n"; return -1;};
    157  
    158   TChain chain("GEN");
    159   chain.Add(outputfilename.c_str());
     204  TChain chainGEN("GEN");
     205  chainGEN.Add(inputfilename.c_str());
     206  ExRootTreeReader *treeReaderGEN = new ExRootTreeReader(&chainGEN);
     207  TChain chain("Analysis");
     208  chain.Add(inputfilename.c_str());
    160209  ExRootTreeReader *treeReader = new ExRootTreeReader(&chain);
    161   const TClonesArray *branchGen = treeReader->UseBranch("Particle");
     210  const TClonesArray *branchJet = treeReader->UseBranch("Jet");
     211  const TClonesArray *branchElec = treeReader->UseBranch("Electron");
     212  const TClonesArray *branchMuon = treeReader->UseBranch("Muon");
     213  const TClonesArray *branchTracks = treeReader->UseBranch("Tracks");
     214  const TClonesArray *branchTowers = treeReader->UseBranch("CaloTower");
     215  const TClonesArray *branchGen = treeReaderGEN->UseBranch("Particle");
    162216  TIter itGen((TCollection*)branchGen);
    163217 
     
    178232  ETMIS *elementEtmis;
    179233 
    180 int numTau=0;
    181 int numTauRec=0;
    182  
    183   //read the datacard input file
    184   string DetDatacard("data/DataCardDet.dat");
    185   if(argc==4)  DetDatacard =argv[3];
    186   RESOLution *DET = new RESOLution();   
    187   DET->ReadDataCard(DetDatacard);
     234  int numTau=0;
     235  int numTauRec=0;
     236 
     237  RESOLution *DET = new RESOLution();
     238  DET->ReadDataCard("data/Datacard_CMS.dat");
     239
    188240
    189241  //Jet information
    190   JetsUtil *JETRUN = new JetsUtil(DetDatacard);
    191 
    192   //Propagation of tracks in the B field
    193   //TrackPropagation *TRACP = new TrackPropagation(DetDatacard);
    194    
     242  JetsUtil *JETRUN = new JetsUtil("data/Datacard_CMS.dat");
     243
    195244  TLorentzVector genMomentum(0,0,0,0);//TLorentzVector containing generator level information
    196   TLorentzVector recoMomentumCalo(0,0,0,0);
    197   TLorentzVector recoMomentum(0,0,0,0);//TLorentzVector containing Reco level information
     245  TLorentzVector recoMomentum(0,0,0,0);//TLorentzVector containing generator level information
    198246  LorentzVector jetMomentum;
    199   vector<TLorentzVector> TrackCentral;
    200247 
    201248  vector<fastjet::PseudoJet> input_particlesGEN;//for FastJet algorithm
    202249  vector<fastjet::PseudoJet> sorted_jetsGEN;
    203250 
    204   vector<fastjet::PseudoJet> input_particlesReco;//for FastJet algorithm
    205   vector<fastjet::PseudoJet> sorted_jetsReco;
    206 
    207   vector<PhysicsTower> towers;
    208  
    209  float iPhi=0,iEta=0;
     251  vector<TLorentzVector> towers;
    210252 
    211253  // Loop over all events
     
    217259      TLorentzVector PTmisGEN(0,0,0,0);
    218260      treeReader->ReadEntry(entry);
     261      treeReaderGEN->ReadEntry(entry);
    219262      treeWriter->Clear();
    220263      if((entry % 100) == 0 && entry > 0 )  cout << "** Processing element # " << entry << endl;
     
    222265      TSimpleArray<TRootGenParticle> bGen;
    223266      itGen.Reset();
    224       TrackCentral.clear();
    225267      TSimpleArray<TRootGenParticle> NFCentralQ;
    226268     
    227       input_particlesReco.clear();
    228269      input_particlesGEN.clear();
    229270      towers.clear();
     
    245286          //Calculate ETMIS from generated particles
    246287          if((pid == pNU1) || (pid == pNU2) || (pid == pNU3))PTmisGEN = PTmisGEN + genMomentum;
    247           
    248           if( (particle->Status == 1)    &&
    249               ((pid != pNU1) && (pid != pNU2) && (pid != pNU3)) &&
    250               (fabs(particle->Eta) < DET->CEN_max_calo_fwd)
    251               )
     288         
     289          if( (particle->Status == 1)    &&
     290            ((pid != pNU1) && (pid != pNU2) && (pid != pNU3)) &&
     291             (fabs(particle->Eta) < DET->CEN_max_calo_fwd)
     292            )
    252293            {
    253               recoMomentum = genMomentum;         
    254               //use of the magnetic field propagation
    255               //TRACP->Propagation(particle,recoMomentum);
    256               //              cout<<"eta "<<eta<<endl;
    257               eta=fabs(recoMomentum.Eta());
    258               //            cout<<"eta apres"<<eta<<endl;
    259              
    260               switch(pid) {
    261                
    262               case pE: // all electrons with eta < DET->MAX_CALO_FWD
    263                 DET->SmearElectron(recoMomentum);
    264                 if(recoMomentum.E() !=0 && eta < DET->CEN_max_tracker){
    265                   elementElec=(RESOLELEC*) branchelec->NewEntry();
    266                   elementElec->E = genMomentum.E();
    267                   elementElec->SmearedE = recoMomentum.E();}
    268                 break; // case pE
    269               case pGAMMA: // all photons with eta < DET->MAX_CALO_FWD
    270                 DET->SmearElectron(recoMomentum);
    271                 break; // case pGAMMA
    272               case pMU: // all muons with eta < DET->MAX_MU
    273                 DET->SmearMu(recoMomentum);
    274                 if(recoMomentum.E() !=0){
    275                 elementMuon = (RESOLMUON*) branchmuon->NewEntry();
    276                 elementMuon->OverPT = (1/genMomentum.Pt());
    277                 elementMuon->OverSmearedPT = (1/recoMomentum.Pt());}
    278                 break; // case pMU
    279               case pLAMBDA: // all lambdas with eta < DET->MAX_CALO_FWD
    280               case pK0S:    // all K0s with eta < DET->MAX_CALO_FWD
    281                 DET->SmearHadron(recoMomentum, 0.7);
    282                 break; // case hadron
    283               default:   // all other final particles with eta < DET->MAX_CALO_FWD
    284                 DET->SmearHadron(recoMomentum, 1.0);
    285                 break;
    286               } // switch (pid)
    287              
    288               //information to reconstruct jets from reconstructed towers
    289                int charge=Charge(pid);
    290                 if(recoMomentum.E() !=0 && pid != pMU) {
    291                         // in case the Bfield is not simulated, checks that charged particles have enough pt to reach the calos
    292                   if ( !DET->FLAG_bfield && charge!=0 && genMomentum.Pt() <= DET->TRACK_ptmin ) { /* particules do not reach calos */ }
    293                   else { // particles reach calos
    294                   DET->BinEtaPhi(recoMomentum.Phi(), recoMomentum.Eta(), iPhi, iEta);
    295                   if(iEta != -100 && iPhi != -100)
    296                     {
    297                       recoMomentumCalo.SetPtEtaPhiE(recoMomentum.Pt(),iEta,iPhi,recoMomentum.E());
    298 
    299                       PhysicsTower Tower(LorentzVector(recoMomentumCalo.Px(),recoMomentumCalo.Py(),recoMomentumCalo.Pz(), recoMomentumCalo.E()));
    300                       towers.push_back(Tower);
    301                     }
    302                 }
    303               }
    304              
    305               // all final charged particles
    306               if(
    307                  (recoMomentum.E()!=0) &&
    308                  (fabs(recoMomentum.Eta()) < DET->CEN_max_tracker) &&
    309                  (DET->FLAG_bfield || ( !DET->FLAG_bfield && genMomentum.Pt() > DET->TRACK_ptmin )) &&
    310                         // if bfield not simulated, pt should be high enough to be taken into account
    311                  ((rand()%100) < DET->TRACK_eff)  &&
    312                  (charge!=0)
    313                  )
    314                 {TrackCentral.push_back(recoMomentum);}
    315              
    316             } // switch
     294              eta=fabs(genMomentum.Eta());
     295
     296              switch(pid) {
     297
     298                 case pE: // all electrons with eta < DET->MAX_CALO_FWD
     299                    PairingElec(recoMomentum,genMomentum,branchElec);
     300                    if(recoMomentum.Pt()>1){
     301                     elementElec=(RESOLELEC*) branchelec->NewEntry();
     302                     elementElec->E = genMomentum.E();
     303                     elementElec->SmearedE = recoMomentum.E();}
     304                   break; // case pE
     305                 case pMU: // all muons with eta < DET->MAX_MU
     306                    PairingMuon(recoMomentum,genMomentum,branchMuon);
     307                    if(recoMomentum.E() !=0){
     308                     elementMuon = (RESOLMUON*) branchmuon->NewEntry();
     309                     elementMuon->OverPT = (1/genMomentum.Pt());
     310                     elementMuon->OverSmearedPT = (1/recoMomentum.Pt());}
     311                   break; // case pMU
     312                 default:
     313                   break;
     314              } // switch (pid)
     315           }
     316
    317317        } // while
    318318     
    319319      //compute missing transverse energy from calo towers   
     320      TIter itCalo((TCollection*)branchTowers);
     321      TRootCalo *calo;
     322      itCalo.Reset();
    320323      TLorentzVector Att(0.,0.,0.,0.);
    321324      float ScalarEt=0;
    322       for(unsigned int i=0; i < towers.size(); i++)
    323         {
    324           Att.SetPxPyPzE(towers[i].fourVector.px, towers[i].fourVector.py, towers[i].fourVector.pz, towers[i].fourVector.E);
     325      while( (calo = (TRootCalo*) itCalo.Next()) )
     326           {
     327          //Att.SetPxPyPzE(towers[i].fourVector.px, towers[i].fourVector.py, towers[i].fourVector.pz, towers[i].fourVector.E);
     328          Att.SetPtEtaPhiE(calo->PT,calo->Eta,calo->Phi,calo->E);
     329          towers.push_back(Att);
    325330          if(fabs(Att.Eta()) < DET->CEN_max_calo_fwd)
    326331            {
    327332               ScalarEt = ScalarEt + Att.Et();
    328333               PTmisReco = PTmisReco + Att;
    329                // create a fastjet::PseudoJet with these components and put it onto
    330                // back of the input_particles vector
    331                input_particlesReco.push_back(fastjet::PseudoJet(towers[i].fourVector.px,towers[i].fourVector.py,towers[i].fourVector.pz,towers[i].fourVector.E));
    332334            }
    333335        }
     
    344346     
    345347      sorted_jetsGEN=JETRUN->RunJets(input_particlesGEN);
    346       sorted_jetsReco=JETRUN->RunJets(input_particlesReco);
    347348
    348349      TSimpleArray<TRootGenParticle> TausHadr = TauHadr(branchGen);
     350cout<<"nombre de tau-jets "<<TausHadr.GetEntries()<<endl;
    349351
    350352      TLorentzVector JETreco(0,0,0,0);
     
    352354        TLorentzVector JETgen(0,0,0,0);
    353355        JETgen.SetPxPyPzE(sorted_jetsGEN[i].px(),sorted_jetsGEN[i].py(),sorted_jetsGEN[i].pz(),sorted_jetsGEN[i].E());
    354         PairingJet(JETreco,JETgen,sorted_jetsReco);
     356        PairingJet(JETreco,JETgen,branchJet);
    355357        if(JETreco.Pt()>1)
    356358          {
     
    361363      }
    362364      numTau = numTau+TausHadr.GetEntries();
    363       for (unsigned int i = 0; i < sorted_jetsReco.size(); i++) {
    364         TLorentzVector JETT(0,0,0,0);
    365         JETT.SetPxPyPzE(sorted_jetsReco[i].px(),sorted_jetsReco[i].py(),sorted_jetsReco[i].pz(),sorted_jetsReco[i].E());
    366         if(fabs(JETT.Eta()) < (DET->CEN_max_tracker - DET->TAU_track_scone))
     365
     366      TIter itJet((TCollection*)branchJet);
     367      TRootJet *jet;
     368      itJet.Reset();
     369//cout<<"a"<<endl;
     370      while( (jet = (TRootJet*) itJet.Next()) )
     371        {
     372//cout<<"b"<<endl;
     373          TLorentzVector JETT(0,0,0,0);
     374          JETT.SetPxPyPzE(jet->Px,jet->Py,jet->Pz,jet->E);
     375          if(fabs(JETT.Eta()) < (DET->CEN_max_tracker - DET->TAU_track_scone))
    367376           {
     377//cout<<"c"<<endl;
    368378            for(Int_t i=0; i<TausHadr.GetEntries();i++)
    369379              {
     380//cout<<"d"<<endl;
    370381                if(DeltaR(TausHadr[i]->Phi,TausHadr[i]->Eta,JETT.Phi(),JETT.Eta())<0.1)
    371382                  {
     383//cout<<"e"<<endl;
    372384                    elementTaujet= (TAUHAD*) branchtaujet->NewEntry();
    373                     elementTaujet->EnergieCen = (DET->EnergySmallCone(towers,JETT.Eta(),JETT.Phi())/JETT.E());
    374                     elementTaujet->NumTrack = DET->NumTracks(TrackCentral,DET->TAU_track_pt,JETT.Eta(),JETT.Phi());
    375                     if( (DET->EnergySmallCone(towers,JETT.Eta(),JETT.Phi())/JETT.E()) > 0.95
    376                      &&  (DET->NumTracks(TrackCentral,DET->TAU_track_pt,JETT.Eta(),JETT.Phi()))==1)numTauRec++;
     385                    elementTaujet->EnergieCen = (EnergySmallCone(towers,JETT.Eta(),JETT.Phi(),DET->TAU_energy_scone,DET->JET_seed)/JETT.E());
     386                    elementTaujet->NumTrack = NumTracks(branchTracks,DET->TAU_track_pt,JETT.Eta(),JETT.Phi(),DET->TAU_track_scone);
     387                    if( (EnergySmallCone(towers,JETT.Eta(),JETT.Phi(),DET->TAU_energy_scone,DET->JET_seed)/JETT.E()) > 0.95
     388                     &&  (NumTracks(branchTracks,DET->TAU_track_pt,JETT.Eta(),JETT.Phi(),DET->TAU_track_scone))==1)numTauRec++;
     389//cout<<"f"<<endl;
    377390                   
    378391                 }
     392//cout<<"g"<<endl;
    379393              }
    380394           }
     395//cout<<"h"<<endl;
    381396         
    382397       
    383398      } // for itJet : loop on all jets
     399//cout<<"i"<<endl;
    384400     
    385401      treeWriter->Fill();
     
    397413  delete treeReader;
    398414  delete DET;
    399   if(converter) delete converter;
    400 }
    401 
     415}
     416
  • trunk/routines/resolutions.C

    r153 r258  
    1515  gROOT->Reset();
    1616 
    17   TFile *f1 = new TFile("JET.root","read");
     17  TFile *f1 = new TFile("JET2.root","read");
    1818  TTree *Analyze = (TTree*)f1->Get("Analysis");
    1919 
     
    206206  gROOT->Reset();
    207207 
    208   TFile *f1 = new TFile("ETMIS2.root","read");
     208  TFile *f1 = new TFile("TAUJET2.root","read");
    209209  TTree *Analyze = (TTree*)f1->Get("Analysis");
    210210 
     
    250250  gROOT->Reset();
    251251 
    252   TFile *f1 = new TFile("JET.root","read");
     252  TFile *f1 = new TFile("JET2.root","read");
    253253  TTree *Analyze = (TTree*)f1->Get("Analysis");
    254254 
     
    328328void General()
    329329{
    330   JetResol();
    331 //  ElecResol();
    332 //  ETmisResol();
    333 //  TauJetInfo();
    334  
    335 }
    336 
    337 
     330  //JetResol();
     331  //ElecResol();
     332  //ETmisResol();
     333  TauJetInfo();
     334 
     335}
     336
     337
Note: See TracChangeset for help on using the changeset viewer.