114 #include <CLHEP/Vector/LorentzVector.h> 146 #include "HepPDT/defs.h" 147 #include "HepPDT/TableBuilder.hh" 148 #include "HepPDT/ParticleDataTable.hh" 150 #include "HepMC/GenParticle.h" 151 #include "HepMC/GenEvent.h" 170 #include "valgrind/callgrind.h" 195 void beginOfJobInConstructor();
198 void endOfJob()
override;
200 void startingNewLoop(
unsigned int iLoop)
override;
203 virtual void endOfFastLoop(
const unsigned int iLoop);
210 virtual void duringFastLoop();
212 template <
typename T>
213 std::vector<MuScleFitMuon> fillMuonCollection(
const std::vector<T>&
tracks);
230 template <
typename T>
231 void takeSelectedMuonType(
const T&
muon, std::vector<reco::Track>& tracks);
233 bool selGlobalMuon(
const pat::Muon* aMuon);
234 bool selTrackerMuon(
const pat::Muon* aMuon);
253 void checkParameters();
269 double minResMass_hwindow[6];
270 double maxResMass_hwindow[6];
313 template <
typename T>
315 std::vector<MuScleFitMuon>
muons;
316 typename std::vector<T>::const_iterator
track;
317 for (track = tracks.begin(); track != tracks.end(); ++
track) {
329 applyBias(mu, track->charge());
331 std::cout <<
"track charge: " << track->charge() << std::endl;
333 Double_t hitsTk = track->innerTrack()->hitPattern().numberOfValidTrackerHits();
334 Double_t hitsMuon = track->innerTrack()->hitPattern().numberOfValidMuonHits();
335 Double_t ptError = track->innerTrack()->ptError();
338 std::cout <<
"[MuScleFit::fillMuonCollection]" << std::endl;
344 muons.push_back(
muon);
349 template <
typename T>
354 if (muon->isGlobalMuon() && theMuonType_ == 1)
355 tracks.push_back(*(muon->globalTrack()));
356 else if (muon->isStandAloneMuon() && theMuonType_ == 2)
357 tracks.push_back(*(muon->outerTrack()));
358 else if (muon->isTrackerMuon() && theMuonType_ == 3)
359 tracks.push_back(*(muon->innerTrack()));
361 else if (theMuonType_ == 10 && !(muon->isStandAloneMuon()))
362 tracks.push_back(*(muon->innerTrack()));
363 else if (theMuonType_ == 11 && muon->isGlobalMuon())
364 tracks.push_back(*(muon->innerTrack()));
365 else if (theMuonType_ == 13 && muon->isTrackerMuon())
366 tracks.push_back(*(muon->innerTrack()));
374 std::cout <<
"[MuScleFit]: Constructor" << std::endl;
376 if ((theMuonType_ < -4 || theMuonType_ > 5) &&
theMuonType_ < 10) {
377 std::cout <<
"[MuScleFit]: Unknown muon type! Aborting." << std::endl;
421 int resolFitType = pset.
getParameter<
int>(
"ResolFitType");
508 if (MuScleFitUtils::SmearType > 0) {
509 std::cout <<
"[MuScleFit-Constructor]: Generating random values for smearing" << std::endl;
510 TF1
G(
"G",
"[0]*exp(-0.5*pow(x,2))", -5., 5.);
512 G.SetParameter(0, norm);
513 for (
int i = 0;
i < 10000;
i++) {
514 for (
int j = 0;
j < 7;
j++) {
535 MuScleFitUtils::rapidityBinsForZ_ =
false;
562 MuScleFitUtils::resfind,
563 MuScleFitUtils::speedup,
566 simTracksCollection_,
567 MuScleFitUtils::sherpa_,
572 pset.
getParameter<std::vector<double> >(
"LeftWindowBorder"),
573 pset.
getParameter<std::vector<double> >(
"RightWindowBorder"),
586 std::cout <<
"End of MuScleFit constructor" << std::endl;
603 std::cout <<
"[MuScleFit]: Destructor" << std::endl;
609 std::cout <<
"Saving muon pairs to root tree" << std::endl;
614 std::vector<MuonPair>::const_iterator it =
muonPairs_.begin();
615 std::cout <<
"[MuScleFit::~MuScleFit] (Destructor)" << std::endl;
617 std::cout <<
" Debugging pairs that are going to be written to file" << std::endl;
618 std::cout <<
" muon1 = " << it->mu1 << std::endl;
619 std::cout <<
" muon2 = " << it->mu2 << std::endl;
642 std::cout <<
"[MuScleFit]: beginOfJob" << std::endl;
649 std::cout <<
"[MuScleFit]: beginOfJob" << std::endl;
654 std::stringstream
ss;
657 theFiles_.push_back(
new TFile(rootFileName.c_str(),
"RECREATE"));
660 std::cout <<
"[MuScleFit]: Root file created" << std::endl;
662 std::cout <<
"creating plotter" << std::endl;
671 std::cout <<
"[MuScleFit]: endOfJob" << std::endl;
678 std::cout <<
"[MuScleFit]: Starting loop # " << iLoop << std::endl;
704 unsigned int iFastLoop = 1;
719 std::cout <<
"Starting fast loop number " << iFastLoop << std::endl;
729 if (
iev % 50000 == 0) {
730 std::cout <<
"Fast looping on event number " <<
iev << std::endl;
735 std::cout <<
"End of fast loop number " << iFastLoop <<
". Ran on " <<
iev <<
" events" << std::endl;
756 std::cout <<
"Ending loop # " << iLoop << std::endl;
766 TDirectory* likelihoodDir =
theFiles_[iLoop]->mkdir(
"likelihood");
786 bool isFired =
false;
791 isFired = triggerResults->
accept();
793 std::cout <<
"Trigger " << isFired << std::endl;
801 for (
unsigned i = 0;
i < triggerNames.
size();
i++) {
805 for (
unsigned int ipath = 0; ipath <
triggerPath_.size(); ipath++) {
806 if (hltName.find(
triggerPath_[ipath]) != std::string::npos) {
807 unsigned int triggerIndex(hltConfig.
triggerIndex(hltName));
810 if (triggerIndex < triggerResults->
size()) {
811 isFired = triggerResults->
accept(triggerIndex);
826 CALLGRIND_START_INSTRUMENTATION;
830 std::cout <<
"[MuScleFit-duringLoop]: loopCounter = " <<
loopCounter <<
" Run: " <<
event.id().run()
831 <<
" Event: " <<
event.id().event() << std::endl;
842 std::cout <<
"Reading from edm event" << std::endl;
852 CALLGRIND_STOP_INSTRUMENTATION;
853 CALLGRIND_DUMP_STATS;
861 std::vector<MuScleFitMuon>
muons;
866 std::cout <<
"[MuScleFit::selectMuons] Debugging muons collections after call to muonSelector_->selectMuons" 869 for (std::vector<MuScleFitMuon>::const_iterator it = muons.begin(); it < muons.end(); ++it) {
870 std::cout <<
" - muon n. " << iMu <<
" = " << (*it) << std::endl;
881 std::cout << std::setprecision(9) <<
"Pt after findbestrecores: " << (recMuFromBestRes.first).Pt() <<
" " 882 << (recMuFromBestRes.second).Pt() << std::endl;
886 recMu1 = recMuFromBestRes.first.p4();
887 recMu2 = recMuFromBestRes.second.p4();
909 Int_t the_numPUvtx(0);
910 Float_t the_TrueNumInteractions(0);
917 std::vector<PileupSummaryInfo>::const_iterator PVI;
918 for (PVI = puInfo->begin(); PVI != puInfo->end(); ++PVI) {
919 int BX = PVI->getBunchCrossing();
921 the_TrueNumInteractions = PVI->getTrueNumInteractions();
922 the_numPUvtx = PVI->getPU_NumInteractions();
930 std::vector<reco::Vertex>::const_iterator itv;
932 for (itv = vertices->begin(); itv != vertices->end(); ++itv) {
936 if (fabs(itv->z()) > 50.0)
938 if (fabs(itv->position().rho()) > 2.0)
946 event.getByLabel(
"generator", genEvtInfo);
947 double the_genEvtweight = 1.;
949 the_genEvtweight = genEvtInfo->
weight();
956 event.
run(),
event.id().event(), the_genEvtweight, the_numPUvtx, the_TrueNumInteractions, the_NVtx)));
964 std::cout <<
"Reading muon pairs from Root Tree in " << treeFileName << std::endl;
966 std::vector<std::pair<unsigned int, unsigned long long> > evtRun;
979 std::vector<std::pair<unsigned int, unsigned long long> >::iterator evtRunIt = evtRun.begin();
981 std::vector<std::pair<MuScleFitMuon, MuScleFitMuon> >::iterator genIt;
988 double pt1 = it->first.pt();
990 double pt2 = it->second.pt();
992 double eta1 = it->first.eta();
994 double eta2 = it->second.eta();
997 bool dontPass =
false;
998 bool eta1InFirstRange;
999 bool eta2InFirstRange;
1000 bool eta1InSecondRange;
1001 bool eta2InSecondRange;
1003 int ch1 = it->first.charge();
1004 int ch2 = it->second.charge();
1017 ((eta1InFirstRange && eta2InSecondRange && ch1 >= ch2) ||
1018 (eta1InSecondRange && eta2InFirstRange && ch1 < ch2))))
1029 (((eta1InFirstRange && !eta2InFirstRange) && (eta2InSecondRange && !eta1InSecondRange) && ch1 >= ch2) ||
1030 ((eta2InFirstRange && !eta1InFirstRange) && (eta1InSecondRange && !eta2InSecondRange) && ch1 < ch2))))
1064 (*evtRunIt).first, (*evtRunIt).second, 0, 0, 0, 0))
1109 <<
" Pt2 = " <<
recMu2.Pt() << std::endl;
1121 <<
" Pt2 = " <<
recMu2.Pt() << std::endl;
1135 mapHisto_[
"hRecBestRes"]->Fill(bestRecRes, +1, weight);
1136 mapHisto_[
"hRecBestResAllEvents"]->Fill(bestRecRes, +1, 1.);
1158 mapHisto_[
"hRecBestResVSRes"]->Fill(bestRecRes, bestRecRes, +1, weight);
1160 std::vector<double>* parval;
1161 std::vector<double> initpar;
1201 mapHisto_[
"hFunctionResolCotgTheta"]->Fill(
1207 mapHisto_[
"hFunctionResolCotgTheta"]->Fill(
1215 std::cout <<
"mass = " << bestRecRes.mass() << std::endl;
1221 std::vector<double> initpar;
1240 bestRecRes.Rapidity(),
1252 bestRecRes.Rapidity(),
1260 std::cout <<
"inside weight: mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1263 std::cout <<
"inside prob: mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1272 if (recoMass != 0) {
1276 mapHisto_[
"hFunctionResolMassVSMu"]->Fill(
recMu1, massResol / recoMass, -1);
1277 mapHisto_[
"hFunctionResolMassVSMu"]->Fill(
recMu2, massResol / recoMass, +1);
1299 double diffMass = (recoMass - genMass) / genMass;
1307 if (diffMass == diffMass) {
1309 mapHisto_[
"hDeltaMassOverGenMassVsPt"]->Fill(pt1, diffMass);
1310 mapHisto_[
"hDeltaMassOverGenMassVsPt"]->Fill(pt2, diffMass);
1311 mapHisto_[
"hDeltaMassOverGenMassVsEta"]->Fill(eta1, diffMass);
1312 mapHisto_[
"hDeltaMassOverGenMassVsEta"]->Fill(eta2, diffMass);
1314 mapHisto_[
"hMassResolutionVsPtEta"]->Fill(pt1, eta1, diffMass, diffMass);
1315 mapHisto_[
"hMassResolutionVsPtEta"]->Fill(pt2, eta2, diffMass, diffMass);
1317 std::cout <<
"Error, there is a nan: recoMass = " << recoMass <<
", genMass = " << genMass << std::endl;
1328 std::cout <<
"mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1331 mapHisto_[
"hMassProbVsRes"]->Fill(bestRecRes, bestRecRes, +1, prob);
1334 mapHisto_[
"hMassProbVsRes_fine"]->Fill(bestRecRes, bestRecRes, +1, prob);
1345 std::cout <<
"[MuScleFit]: filling the pair" << std::endl;
1359 ((recMu.Eta() - genMu.Eta()) * (recMu.Eta() - genMu.Eta())));
1363 std::cout <<
"Reco muon " << recMu <<
" with eta " << recMu.Eta() <<
" and phi " << recMu.Phi() << std::endl
1364 <<
" DOES NOT MATCH with generated muon from resonance: " << std::endl
1365 << genMu <<
" with eta " << genMu.Eta() <<
" and phi " << genMu.Phi() << std::endl;
1375 mapHisto_[
"hResolPt" +
name]->Fill(recMu, (-genMu.Pt() + recMu.Pt()) / genMu.Pt(),
charge);
1376 mapHisto_[
"hResolTheta" +
name]->Fill(recMu, (-genMu.Theta() + recMu.Theta()), charge);
1378 recMu, (-
cos(genMu.Theta()) /
sin(genMu.Theta()) +
cos(recMu.Theta()) /
sin(recMu.Theta())),
charge);
1379 mapHisto_[
"hResolEta" +
name]->Fill(recMu, (-genMu.Eta() + recMu.Eta()), charge);
1383 if ((genMu.Pt() != 0) && (recMu.Pt() != 0)) {
1384 mapHisto_[
"hPtRecoVsPt" + inputName]->Fill(genMu.Pt(), recMu.Pt());
1409 std::cout <<
"[MuScleFit-Constructor]: wrong size of resolution fits selector = " 1411 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1417 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1421 std::cout <<
"[MuScleFit-Constructor]: wrong size of cross section fits selector = " 1423 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1427 std::cout <<
"[MuScleFit-Constructor]: wrong size of background fits selector = " 1429 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1455 std::cout <<
"[MuScleFit-Constructor]: Wrong bias type or number of parameters: aborting!" << std::endl;
1468 std::cout <<
"[MuScleFit-Constructor]: Wrong smear type or number of parameters: aborting!" << std::endl;
1475 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Resol: aborting!" << std::endl;
1480 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Scale: aborting!" << std::endl;
1485 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Bgr: aborting!" << std::endl;
1490 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Bgr: aborting!" << std::endl;
1497 std::cout <<
"[MuScleFit-Constructor]: resfind must have 6 elements (1 Z, 3 Y, 2 Psi): aborting!" << std::endl;
1511 iTrack->chi2() / iTrack->ndof() < 4.0 && aMuon->
muonID(
"TrackerMuonArbitrated") &&
1513 fabs(iTrack->dxy()) < 3.0 &&
1514 fabs(iTrack->dz()) < 15.0);
1522 iTrack->found() > 11 && iTrack->chi2() / iTrack->ndof() < 4.0 && aMuon->
muonID(
"TrackerMuonArbitrated") &&
1524 fabs(iTrack->dxy()) < 3.0 &&
1525 fabs(iTrack->dz()) < 15.0);
static double deltaPhiNoFabs(const double &phi1, const double &phi2)
Without fabs at the end, used to have a symmetric distribution for the resolution fits and variance c...
static std::vector< std::pair< lorentzVector, lorentzVector > > simPair
static std::vector< int > doScaleFit
static std::vector< int > doResolFit
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
static std::vector< double > parBias
void selectMuons(const edm::Event &event)
static std::vector< int > parCrossSectionOrder
std::vector< GenMuonPair > genMuonPairs_
Stores the genMuon pairs and the motherId prior to the creation of the internal tree.
static smearFunctionBase * smearFunction
static std::vector< int > parScaleOrder
edm::InputTag theMuonLabel_
static std::vector< int > doCrossSectionFit
static void minimizeLikelihood()
static double maxMuonEtaSecondRange_
std::vector< MuScleFitMuon > fillMuonCollection(const std::vector< T > &tracks)
static std::vector< int > parBgrOrder
bool selGlobalMuon(const pat::Muon *aMuon)
Function for onia selections.
static unsigned int loopCounter
static double deltaPhiMaxCut_
static std::vector< double > parResolMax
static std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > SavedPairMuScleFitMuons
static std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > genMuscleFitPair
static bool startWithSimplex_
std::string triggerResultsProcess_
static std::vector< int > doBackgroundFit
static std::vector< double > parResol
static bool debugMassResol_
virtual void duringFastLoop()
Sin< T >::type sin(const T &t)
bool accept() const
Has at least one path accepted the event?
static BackgroundHandler * backgroundHandler
static double x[7][10000]
static double massWindowHalfWidth[3][6]
#define DEFINE_FWK_LOOPER(type)
bool muonID(const std::string &name) const
Run const & getRun() const
std::map< std::string, Histograms * > mapHisto_
The map of histograms.
void readTree(const int maxEvents, const TString &fileName, MuonPairVector *savedPair, const int muonType, std::vector< std::pair< unsigned int, unsigned long long > > *evtRun, MuonPairVector *genPair=nullptr)
void fillTreeRec(const std::vector< std::pair< reco::Particle::LorentzVector, reco::Particle::LorentzVector > > &savedPairs)
Used when running on the root tree containing preselected muon pairs.
static scaleFunctionBase< std::vector< double > > * biasFunction
bool selTrackerMuon(const pat::Muon *aMuon)
void startingNewLoop(unsigned int iLoop) override
Strings::size_type size() const
static std::vector< int > parBgrFix
static std::vector< double > parResolMin
static bool minimumShapePlots_
int pixelLayersWithMeasurement() const
edm::InputTag simTracksCollection_
static int MuonTypeForCheckMassWindow
static double minMuonEtaFirstRange_
static double massProb(const double &mass, const double &rapidity, const int ires, const double &massResol)
void fillComparisonHistograms(const reco::Particle::LorentzVector &genMu, const reco::Particle::LorentzVector &recoMu, const std::string &inputName, const int charge)
Fill the reco vs gen and reco vs sim comparison histograms.
static struct MuScleFitUtils::massResolComponentsStruct massResolComponents
std::vector< std::string > triggerPath_
static std::vector< int > parScaleFix
MuScleFitMuon recMuScleMu1
static bool computeMinosErrors_
reco::Particle::LorentzVector lorentzVector
static scaleFunctionBase< std::vector< double > > * scaleFunctionForVec
static std::vector< std::vector< double > > parvalue
unsigned int triggerIndex(const std::string &triggerName) const
slot position of trigger path in trigger table (0 to size-1)
resolutionFunctionBase< double * > * resolutionFunctionService(const int identifier)
Service to build the resolution functor corresponding to the passed identifier.
U second(std::pair< T, U > const &p)
void writeTree(const TString &fileName, const std::vector< MuonPair > *savedPair, const int muonType=0, const std::vector< GenMuonPair > *genPair=nullptr, const bool saveAll=false)
static std::pair< MuScleFitMuon, MuScleFitMuon > findBestRecoRes(const std::vector< MuScleFitMuon > &muons)
static std::vector< std::pair< lorentzVector, lorentzVector > > genPair
std::string outputRootTreeFileName_
std::string theGenInfoRootFileName_
reco::TrackRef innerTrack() const override
reference to Track reconstructed in the tracker only (reimplemented from reco::Muon) ...
resolutionFunctionBase< std::vector< double > > * resolutionFunctionVecService(const int identifier)
Service to build the resolution functor corresponding to the passed identifier when receiving a std::...
static double massResolution(const lorentzVector &mu1, const lorentzVector &mu2)
reco::Particle::LorentzVector recMu2
static std::vector< double > parScaleMin
std::vector< double > vec1
reco::Particle::LorentzVector recMu1
static lorentzVector applyBias(const lorentzVector &muon, const int charge)
static std::vector< double > parBgr
unsigned int maxLoopNumber
MuonServiceProxy * theService
std::string genParticlesName_
Cos< T >::type cos(const T &t)
scaleFunctionBase< double * > * scaleFunctionService(const int identifier)
Service to build the scale functor corresponding to the passed identifier.
void clearHistoMap()
Clean the histograms map.
MuScleFitMuon recMuScleMu2
static double computeWeight(const double &mass, const int iev, const bool doUseBkgrWindow=false)
static std::vector< double > parScaleStep
static std::vector< std::pair< lorentzVector, lorentzVector > > SavedPair
MuScleFit(const edm::ParameterSet &pset)
static std::string const triggerResults
static lorentzVector applyScale(const lorentzVector &muon, const std::vector< double > &parval, const int charge)
static std::vector< int > parResolFix
static std::vector< double > parSmear
void beginOfJobInConstructor()
smearFunctionBase * smearFunctionService(const int identifier)
Service to build the smearing functor corresponding to the passed identifier.
static std::vector< int > parResolOrder
edm::EDLooper::Status duringLoop(const edm::Event &event, const edm::EventSetup &eventSetup) override
static std::vector< double > parScaleMax
scaleFunctionBase< std::vector< double > > * scaleFunctionVecService(const int identifier)
Service to build the scale functor corresponding to the passed identifier when receiving a std::vecto...
void writeHistoMap(const unsigned int iLoop)
Save the histograms map to file.
static std::vector< double > parScale
static double oldNormalization_
void applySmearing(reco::Particle::LorentzVector &mu)
Apply the smearing if needed using the function in MuScleFitUtils.
reco::TrackRef globalTrack() const override
reference to Track reconstructed in both tracked and muon detector (reimplemented from reco::Muon) ...
std::string const & triggerName(unsigned int index) const
std::string theRootFileName_
void fillTreeGen(const std::vector< std::pair< reco::Particle::LorentzVector, reco::Particle::LorentzVector > > &genPairs)
bool init(const edm::Run &iRun, const edm::EventSetup &iSetup, const std::string &processName, bool &changed)
d'tor
static double deltaPhiMinCut_
std::string triggerResultsLabel_
static bool rapidityBinsForZ_
MuScleFitPlotter * plotter
void fillHistoMap(TFile *outputFile, unsigned int iLoop)
Create the histograms map.
std::vector< TFile * > theFiles_
The files were the histograms are saved.
double minResMass_hwindow[6]
static bool separateRanges_
static double minMuonEtaSecondRange_
static std::vector< double > parCrossSection
static lorentzVector applySmearing(const lorentzVector &muon)
static bool normalizeLikelihoodByEventNumber_
std::string inputRootTreeFileName_
bool checkDeltaR(reco::Particle::LorentzVector &genMu, reco::Particle::LorentzVector &recMu)
Check if two lorentzVector are near in deltaR.
int maxEventsFromRootTree_
double maxResMass_hwindow[6]
std::vector< MuonPair > muonPairs_
Used to store the muon pairs plus run and event number prior to the creation of the internal tree...
static double deltaPhi(const double &phi1, const double &phi2)
static scaleFunctionBase< double * > * scaleFunction
int numberOfValidMuonHits() const
static bool useProbsFile_
static std::vector< int > resfind
void readProbabilityDistributionsFromFile()
Read probability distributions from a local root file.
void takeSelectedMuonType(const T &muon, std::vector< reco::Track > &tracks)
Template method used to fill the track collection starting from reco::muons or pat::muons.
static int counter_resprob
static resolutionFunctionBase< std::vector< double > > * resolutionFunctionForVec
math::XYZTLorentzVector LorentzVector
Lorentz vector.
Analysis-level muon class.
static double maxMuonEtaFirstRange_
std::unique_ptr< MuScleFitMuonSelector > muonSelector_
Power< A, B >::type pow(const A &a, const B &b)
void applyBias(reco::Particle::LorentzVector &mu, const int charge)
Apply the bias if needed using the function in MuScleFitUtils.
static CrossSectionHandler * crossSectionHandler
edm::EDLooper::Status endOfLoop(const edm::EventSetup &eventSetup, unsigned int iLoop) override
static std::vector< double > parResolStep
static std::vector< int > parCrossSectionFix
static resolutionFunctionBase< double * > * resolutionFunction
void addParameters(std::vector< double > &initpar)
Inputs the vars in a vector.
virtual void endOfFastLoop(const unsigned int iLoop)