ATLAS Offline Software
Loading...
Searching...
No Matches
FPGATrackSimGenScanTool Class Reference

#include <FPGATrackSimGenScanTool.h>

Inheritance diagram for FPGATrackSimGenScanTool:
Collaboration diagram for FPGATrackSimGenScanTool:

Classes

class  HitPair
struct  HitPairSet
struct  IntermediateState

Public Types

using StoredHit = FPGATrackSimBinUtil::StoredHit
using BinEntry = FPGATrackSimBinnedHits::BinEntry

Public Member Functions

 FPGATrackSimGenScanTool (const std::string &algname, const std::string &name, const IInterface *ifc)
virtual StatusCode initialize () override
virtual StatusCode getRoads (const std::vector< std::shared_ptr< const FPGATrackSimHit > > &hits, std::vector< FPGATrackSimRoad > &road) override
virtual int getSubRegion () const override

Protected Member Functions

StatusCode pairThenGroupFilter (const BinEntry &bindata, std::vector< HitPairSet > &output_pairset)
void updateState (const IntermediateState &inputstate, IntermediateState &outputstate, unsigned lyridx, const std::vector< const StoredHit * > &newhits)
StatusCode incrementalBuildFilter (const BinEntry &bindata, std::vector< HitPairSet > &output_pairset)
StatusCode sortHitsByLayer (const BinEntry &bindata, std::vector< std::vector< const StoredHit * > > &hitsByLayer)
StatusCode makePairs (const std::vector< std::vector< const StoredHit * > > &hitsByLayer, HitPairSet &pairs)
bool pairPassesFilter (const HitPair &pair)
StatusCode filterPairs (HitPairSet &pairs, HitPairSet &filteredpairs)
StatusCode groupPairs (HitPairSet &filteredpairs, std::vector< HitPairSet > &clusters, bool verbose)
bool pairMatchesPairSet (const HitPairSet &pairset, const HitPair &pair, bool verbose)
void addRoad (std::vector< const StoredHit * > const &hits, const FPGATrackSimBinUtil::IdxSet &idx)
bool fitRoad (std::vector< const StoredHit * > const &hits, const FPGATrackSimBinUtil::IdxSet &idx, FPGATrackSimTrackPars &trackpars, double &chi2, double &chi2_phi, double &chi2_eta) const
std::vector< unsigned > PickHitsToUse (layer_bitmask_t) const

Protected Attributes

ServiceHandle< IFPGATrackSimEventSelectionSvcm_EvtSel {this, "FPGATrackSimEventSelectionSvc", ""}
ServiceHandle< IFPGATrackSimMappingSvcm_FPGATrackSimMapping {this, "FPGATrackSimMappingSvc", "FPGATrackSimMappingSvc"}
ToolHandle< FPGATrackSimGenScanMonitoringm_monitoring {this, "Monitoring", "FPGATrackSimGenScanMonitoring", "Monitoring Tool"}
ToolHandle< FPGATrackSimBinnedHitsm_binnedhits {this, "BinnedHits", "FPGATrackSimBinnedHits", "Binned Hits Class"}
Gaudi::Property< double > m_rin {this, "rin", {-1.0}, "Radius of inner layer for extrapolations and keylayer definition"}
Gaudi::Property< double > m_rout {this, "rout", {-1.0}, "Radius of outer layer for extrapolations and keylayer definition"}
Gaudi::Property< unsigned > m_threshold {this, "threshold", {}, "Minimum value to accept as a road (inclusive)"}
Gaudi::Property< std::string > m_binFilter {this, "binFilter", {"PairThenGroup"}, "which bin filter to run, current options: PairThenGroup, IncrementalBuild"}
Gaudi::Property< bool > m_binningOnly {this, "binningOnly", {false}, "Turn off road building to test the binning only"}
Gaudi::Property< bool > m_applyPairFilter {this, "applyPairFilter", {}, "Apply Pair Filter"}
Gaudi::Property< bool > m_reversePairDir {this, "reversePairDir", {}, "Build Pairs starting at last layer and work in"}
Gaudi::Property< std::vector< double > > m_pairFilterDeltaPhiCut {this, "pairFilterDeltaPhiCut", {}, "Pair Filter Delta Phi Cut Value (list one per layer)"}
Gaudi::Property< std::vector< double > > m_pairFilterDeltaEtaCut {this, "pairFilterDeltaEtaCut", {}, "Pair Filter Delta Eta Cut Value (list one per layer)"}
Gaudi::Property< std::vector< double > > m_pairFilterPhiExtrapCut {this, "pairFilterPhiExtrapCut", {}, "Pair Filter Phi Extrap Cut Value (in/out pair)"}
Gaudi::Property< std::vector< double > > m_pairFilterEtaExtrapCut {this, "pairFilterEtaExtrapCut", {}, "Pair Filter Eta Extrap Cut Value(in/out pair)"}
Gaudi::Property< bool > m_applyPairSetFilter {this, "applyPairSetFilter", {}, "Apply PairSet Filter"}
Gaudi::Property< double > m_pairSetMatchPhiCut {this, "pairSetMatchPhiCut", {}, "Pair Set Match Phi Cut Value"}
Gaudi::Property< double > m_pairSetMatchEtaCut {this, "pairSetMatchEtaCut", {}, "Pair Set Match Eta Cut Value"}
Gaudi::Property< double > m_pairSetDeltaDeltaPhiCut {this, "pairSetDeltaDeltaPhiCut", {}, "Pair Set Delta Delta Phi Cut Value"}
Gaudi::Property< double > m_pairSetDeltaDeltaEtaCut {this, "pairSetDeltaDeltaEtaCut", {}, "Pair Set Delta Eta Cut Value"}
Gaudi::Property< double > m_pairSetPhiCurvatureCut {this, "pairSetPhiCurvatureCut", {}, "Pair Set Phi Cut Value"}
Gaudi::Property< double > m_pairSetEtaCurvatureCut {this, "pairSetEtaCurvatureCut", {}, "Pair Set Eta Cut Value"}
Gaudi::Property< double > m_pairSetDeltaPhiCurvatureCut {this, "pairSetDeltaPhiCurvatureCut", {}, "Pair Set Delta Phi Curvature Cut Value"}
Gaudi::Property< double > m_pairSetDeltaEtaCurvatureCut {this, "pairSetDeltaEtaCurvatureCut", {}, "Pair Set Delta Eta Curvature Cut Value"}
Gaudi::Property< std::vector< double > > m_pairSetPhiExtrapCurvedCut {this, "pairSetPhiExtrapCurvedCut", {}, "Pair Set Phi Extrap Curved Cut Value(in/out pair)"}
Gaudi::Property< double > m_phiWeight_4hits {this, "phiChi2Weight_4hits", 1.0, "Weight for phi component of chi2 in genscan fit for 4 hit roads"}
Gaudi::Property< double > m_etaWeight_4hits {this, "etaChi2Weight_4hits", 1.0, "Weight for eta component of chi2 in genscan fit for 4 hit roads"}
Gaudi::Property< double > m_phiWeight_5hits {this, "phiChi2Weight_5hits", 1.0, "Weight for phi component of chi2 in genscan fit for 5 hit roads"}
Gaudi::Property< double > m_etaWeight_5hits {this, "etaChi2Weight_5hits", 1.0, "Weight for eta component of chi2 in genscan fit for 5 hit roads"}
Gaudi::Property< bool > m_inBinFiltering {this, "inBinFiltering", true, "Filter roads that appear to be outside their bin"}
Gaudi::Property< int > m_keepHitsStrategy {this, "keepHitsStrategy", -1, "If this is less than 0, do nothing. If 1, pick 3 hits furthest apart. If 2, pick 3 inner hits. If 3, pick 3 outer hits. If 4, drop only middle hit for 5/5 otherwise keep all 4 hits for 4/5"}
int m_evtsProcessed = 0
std::vector< unsigned int > m_pairingLayers
std::vector< FPGATrackSimRoadm_roads {}

Friends

class FPGATrackSimGenScanMonitoring

Detailed Description

Definition at line 74 of file FPGATrackSimGenScanTool.h.

Member Typedef Documentation

◆ BinEntry

◆ StoredHit

Constructor & Destructor Documentation

◆ FPGATrackSimGenScanTool()

FPGATrackSimGenScanTool::FPGATrackSimGenScanTool ( const std::string & algname,
const std::string & name,
const IInterface * ifc )

Definition at line 61 of file FPGATrackSimGenScanTool.cxx.

61 :
62 base_class(algname, name, ifc)
63{
64 declareInterface<IFPGATrackSimRoadFinderTool>(this);
65}

Member Function Documentation

◆ addRoad()

void FPGATrackSimGenScanTool::addRoad ( std::vector< const StoredHit * > const & hits,
const FPGATrackSimBinUtil::IdxSet & idx )
protected

Definition at line 612 of file FPGATrackSimGenScanTool.cxx.

613{
614 layer_bitmask_t hitLayers = 0;
615 std::vector<std::vector<std::shared_ptr<const FPGATrackSimHit>>>
616 sorted_hits(m_binnedhits->getNLayers(),std::vector<std::shared_ptr<const FPGATrackSimHit>>());
617 for (const FPGATrackSimBinUtil::StoredHit* hit : hits)
618 {
619 hitLayers |= 1 << hit->layer;
620 sorted_hits[hit->layer].push_back(hit->hitptr);
621 }
622
623 // "Fit" the track.
624 FPGATrackSimTrackPars fittedpars;
625 double chi2,chi2_phi,chi2_eta;
626 bool inBin = fitRoad(hits, idx, fittedpars, chi2, chi2_phi,chi2_eta);
627 if (!inBin && m_inBinFiltering) return;
628
629 m_roads.emplace_back();
630 FPGATrackSimRoad &r = m_roads.back();
631
632 r.setRoadID(static_cast<int>(m_roads.size()) - 1);
633 // r.setPID(y * m_imageSize_y + x);
634 r.setHits(std::move(sorted_hits));
635
636 r.setBinIdx(idx);
637
638 FPGATrackSimBinUtil::ParSet binCenterPars = m_binnedhits->getBinTool().lastStep()->binCenter(idx);
639 FPGATrackSimTrackPars trackpars = m_binnedhits->getBinTool().binDesc()->parSetToTrackPars(binCenterPars);
640 r.setX(trackpars[FPGATrackSimTrackPars::IPHI]);
641 r.setY(trackpars[FPGATrackSimTrackPars::IHIP]);
642 r.setXBin(idx[3]);
643 r.setYBin(idx[4]);
644 r.setHitLayers(hitLayers);
645 r.setSubRegion(0);
646
647 // Store the fitted information on the track.
648 r.setFitParams(fittedpars);
649 r.setFitChi2(chi2);
650 r.setFitChi2_2d(chi2_phi,chi2_eta);
651}
uint32_t layer_bitmask_t
bool fitRoad(std::vector< const StoredHit * > const &hits, const FPGATrackSimBinUtil::IdxSet &idx, FPGATrackSimTrackPars &trackpars, double &chi2, double &chi2_phi, double &chi2_eta) const
std::vector< FPGATrackSimRoad > m_roads
Gaudi::Property< bool > m_inBinFiltering
ToolHandle< FPGATrackSimBinnedHits > m_binnedhits
double chi2(TH1 *h0, TH1 *h1)
int r
Definition globals.cxx:22

◆ filterPairs()

StatusCode FPGATrackSimGenScanTool::filterPairs ( HitPairSet & pairs,
HitPairSet & filteredpairs )
protected

Definition at line 463 of file FPGATrackSimGenScanTool.cxx.

464{
465 ATH_MSG_VERBOSE("In filterPairs");
466
467 for (const FPGATrackSimGenScanTool::HitPair &pair : pairs.pairList) {
468 if (pairPassesFilter(pair)) {
469 filteredpairs.addPair(pair);
470 }
471 }
472 return StatusCode::SUCCESS;
473}
#define ATH_MSG_VERBOSE(x)
bool pairPassesFilter(const HitPair &pair)

◆ fitRoad()

bool FPGATrackSimGenScanTool::fitRoad ( std::vector< const StoredHit * > const & hits,
const FPGATrackSimBinUtil::IdxSet & idx,
FPGATrackSimTrackPars & trackpars,
double & chi2,
double & chi2_phi,
double & chi2_eta ) const
protected

Definition at line 754 of file FPGATrackSimGenScanTool.cxx.

755{
756
757 double N =hits.size();
758 double sum_Phi = 0;
759 double sum_Phi2 = 0;
760 double sum_PhiR = 0;
761 double sum_PhiR2 = 0;
762 double sum_Eta = 0;
763 double sum_Eta2 = 0;
764 double sum_EtaR = 0;
765 double sum_R = 0;
766 double sum_R2 = 0;
767 double sum_R3 = 0;
768 double sum_R4 = 0;
769
770 for (const FPGATrackSimBinUtil::StoredHit* hit : hits)
771 {
772 // these are just relevant sums of variables (moments) needed for the chi2 calculation
773 // Calculate r^2, r^3, and r^4, we'll sum these up later below
774 double r = hit->hitptr->getR();
775 double r2 = r*r;
776 double r3 = r2*r;
777 double r4 = r3*r;
778 double dphi = hit->phiShift;
779 double dphi2 = dphi*dphi;
780 double deta = hit->etaShift;
781 double deta2 = deta*deta;
782
783 sum_Phi += dphi;
784 sum_Phi2 += dphi2;
785 sum_PhiR += dphi*r;
786 sum_PhiR2 += dphi*r2;
787 sum_Eta += deta;
788 sum_Eta2 += deta2;
789 sum_EtaR += deta*r;
790 sum_R += r;
791 sum_R2 += r2;
792 sum_R3 += r3;
793 sum_R4 += r4;
794 }
795
796 // phi var calculation
797 // phi(r) = phivars[0] + phivars[1]*r + phivars[2]*r^2
798 // math below is calculated by analytically minimizing the chi2
799 // and solving for the phivars.
800 // the terms below which recur in the phivar expression are just organized
801 // by the power of r (i.e. the dimension), but otherwise have no deep meaning
802 double r6_t0 = (-sum_R2 * sum_R4 + sum_R3*sum_R3);
803 double r5_t0 = (sum_R*sum_R4 - sum_R2*sum_R3);
804 double r4_t0 = (-sum_R * sum_R3 + sum_R2*sum_R2);
805 double r4_t1 = (-N*sum_R4 + sum_R2*sum_R2);
806 double r3_t0 = (N*sum_R3 - sum_R*sum_R2);
807 double r2_t0 = (-N*sum_R2 + sum_R*sum_R);
808
809 // all three phi var expresions use the same demoninator
810 const double denom_phi = N * r6_t0 + sum_R * r5_t0 + sum_R2 * r4_t0;
811 if (nearZero(denom_phi)){
812 ATH_MSG_ERROR("Divide by zero (phi) trapped in FPGATrackSimGenScanTool::fitRoad");
813 return false;
814 }
815
816 // phivar expresions from analytic chi2 minimization
817 std::vector<double> phivars(3);
818 phivars[0] = (sum_Phi*r6_t0 + sum_PhiR*r5_t0 + sum_PhiR2*r4_t0)/denom_phi;
819 phivars[1] = (sum_Phi*r5_t0 + sum_PhiR*r4_t1 + sum_PhiR2*r3_t0)/denom_phi;
820 phivars[2] = (sum_Phi*r4_t0 + sum_PhiR*r3_t0 + sum_PhiR2*r2_t0)/denom_phi;
821
822 // eta vars
823 // same as phi but with not curvature (r^2) term
824 const double denom_eta = N*sum_R2 - sum_R*sum_R;
825 if (nearZero(denom_eta)){
826 ATH_MSG_ERROR("Divide by zero (eta) trapped in FPGATrackSimGenScanTool::fitRoad");
827 return false;
828 }
829
830 std::vector<double> etavars(2);
831 etavars[0] = (-sum_R*sum_EtaR + sum_R2*sum_Eta)/denom_eta;
832 etavars[1] = (N*sum_EtaR - sum_R*sum_Eta)/denom_eta;
833
834 // bin center
835 FPGATrackSimBinUtil::ParSet parset = m_binnedhits->getBinTool().lastStep()->binCenter(idx);
836 double parshift[FPGATrackSimTrackPars::NPARS];
837 parshift[0] = etavars[0] + etavars[1]*m_rin; // z at r in
838 parshift[1]= etavars[0] + etavars[1]*m_rout; // z at r out
839 parshift[2]= -(phivars[0]/m_rin + phivars[1] + phivars[2]*m_rin) ; // phi at r in
840 parshift[3]= -(phivars[0]/m_rout + phivars[1] + phivars[2]*m_rout) ; // phi at r out
841 double y = (m_rout-m_rin); // midpoint between rin and rout from rin
842 parshift[4]= -phivars[2]/4.0*y*y ; // xm
843
844 bool inBin = true;
845 const auto& lastStep = m_binnedhits->getBinTool().lastStep();
846 for (int par = 0; par < FPGATrackSimTrackPars::NPARS; par++ ){
847 parset[par]+=parshift[par];
848 inBin = inBin && (std::abs(parshift[par]) < lastStep->binWidth(par)/2.0);
849 }
850
851 double ec0 = etavars[0];
852 double ec1 = etavars[1];
853 eta_chi2 = sum_Eta2 - 2*ec0*sum_Eta - 2*ec1*sum_EtaR + N*ec0*ec0 + 2*ec0*ec1*sum_R + ec1*ec1*sum_R2;
854
855 double pc0 = phivars[0];
856 double pc1 = phivars[1];
857 double pc2 = phivars[2];
858
859 phi_chi2 = sum_Phi2 - 2*pc0*sum_Phi - 2*pc1*sum_PhiR - 2*pc2*sum_PhiR2 + N*pc0*pc0 + 2*pc0*pc1*sum_R + 2*pc0*pc2*sum_R2 + 2*pc1*pc2*sum_R3 + pc1*pc1*sum_R2 + pc2*pc2*sum_R4;
860
861 for (const FPGATrackSimBinUtil::StoredHit* hit : hits)
862 {
863 double r = hit->hitptr->getR();
864 ATH_MSG_VERBOSE("Fitted r= " << r << " phishift " << hit->phiShift << " =?= " << pc0+pc1*r+pc2*r*r << " etashift " << hit->etaShift << " =?= " << ec0+ec1*r);
865 }
866
867 ATH_MSG_DEBUG("Bin Info parset " << idx << " " << m_binnedhits->getBinTool().lastStep()->binCenter(idx));
868 ATH_MSG_DEBUG("Fitted parset inBin="<< inBin << " nhits=" << hits.size() << " " << parset << " chi2 " << eta_chi2 << "," << phi_chi2);
869
870 // Return by reference the "fitted" track parameters. shift q/pt dimension (GeV/MeV)
871 trackpars = m_binnedhits->getBinTool().binDesc()->parSetToTrackPars(parset);
872 trackpars[FPGATrackSimTrackPars::IHIP] = trackpars[FPGATrackSimTrackPars::IHIP] / 1000;
873 ATH_MSG_VERBOSE("Fitted track pars" << trackpars);
874
875 // and the summed chi2, which is assuming (right now) an even weighting between the two components.
876 // assume only options are 4 or 5 hits for now
877 chi2 = (hits.size() == 5) ?
878 m_etaWeight_5hits * eta_chi2 * eta_chi2 + m_phiWeight_5hits * phi_chi2 * phi_chi2 :
879 m_etaWeight_4hits * eta_chi2 * eta_chi2 + m_phiWeight_4hits * phi_chi2 * phi_chi2;
880
881
882 return inBin;
883}
#define ATH_MSG_ERROR(x)
#define ATH_MSG_DEBUG(x)
#define y
Gaudi::Property< double > m_etaWeight_4hits
Gaudi::Property< double > m_phiWeight_5hits
Gaudi::Property< double > m_rin
Gaudi::Property< double > m_etaWeight_5hits
Gaudi::Property< double > m_phiWeight_4hits
Gaudi::Property< double > m_rout

◆ getRoads()

StatusCode FPGATrackSimGenScanTool::getRoads ( const std::vector< std::shared_ptr< const FPGATrackSimHit > > & hits,
std::vector< FPGATrackSimRoad > & road )
overridevirtual

Definition at line 134 of file FPGATrackSimGenScanTool.cxx.

136{
137 ATH_MSG_DEBUG("In getRoads, Processing Event# " << ++m_evtsProcessed << " hit size = " << hits.size());
138
139
140 roads.clear();
141 m_roads.clear();
142 m_monitoring->resetDataFlowCounters();
143
144 // Currently assume that if less than 100 hits its a single track MC
145 m_monitoring->parseTruthInfo(getTruthTracks(),(hits.size() < 100));
146
147 // do the binning...
148 ATH_CHECK(m_binnedhits->fill(hits));
149 m_monitoring->fillBinningSummary(hits);
150
151 // scan over image building pairs for bins over threshold
152 for (FPGATrackSimBinArray<BinEntry>::ConstIterator &bin : m_binnedhits->lastStepBinnedHits())
153 {
154 // apply threshold
155 if (bin.data().lyrCnt() < m_threshold) continue;
156 ATH_MSG_DEBUG("Bin passes threshold " << bin.data().lyrCnt() << " "
157 << bin.idx());
158
159 // Monitor contents of bins passing threshold
160 m_monitoring->fillBinLevelOutput(bin.idx(), bin.data());
161 if (m_binningOnly) continue;
162
163 // pass hits for bin to filterRoad and get back pairs of hits grouped into pairsets
164 std::vector<HitPairSet> pairsets;
165 if (m_binFilter=="PairThenGroup") {
166 ATH_CHECK(pairThenGroupFilter(bin.data(), pairsets));
167 } else if (m_binFilter=="IncrementalBuild") {
168 ATH_CHECK(incrementalBuildFilter(bin.data(), pairsets));
169 } else {
170 ATH_MSG_FATAL("Unknown bin filter" << m_binFilter);
171 }
172 ATH_MSG_DEBUG("grouped PairSets " << pairsets.size());
173
174 // convert the group pairsets to FPGATrackSimRoads
175 for (const FPGATrackSimGenScanTool::HitPairSet& pairset: pairsets)
176 {
177 addRoad(pairset.hitlist, bin.idx());
178 ATH_MSG_DEBUG("Output road size=" <<pairset.hitlist.size());
179
180 // debug statement if more than one road found in bin
181 // not necessarily a problem
182 if (pairsets.size() >1) {
183 std::string s = "";
184 for (const FPGATrackSimBinUtil::StoredHit* const hit : pairset.hitlist)
185 {
186 s += "(" + std::to_string(hit->layer) + "," + std::to_string(hit->hitptr->getR()) + "), ";
187 }
188 ATH_MSG_DEBUG("Duplicate Group " << s);
189 }
190 }
191 }
192
193 // copy roads to output vector
194 roads.reserve(m_roads.size());
195
196 if (m_keepHitsStrategy > 0) {
197 for (auto & r : m_roads) {
198 const std::vector<std::vector<std::shared_ptr<const FPGATrackSimHit>>>& theseHits = r.getAllHits();
199 layer_bitmask_t hitmask = r.getHitLayers();
200 std::vector<unsigned> toUse = PickHitsToUse(hitmask);
201
202 std::vector<std::vector<std::shared_ptr<const FPGATrackSimHit>>> vec(5); // even if not all layers have hits, they need to be in the vector as empty vectors
203 for (size_t ihit = 0; ihit < toUse.size(); ++ihit) {
204 unsigned int layer = toUse[ihit];
205 if (layer >= theseHits.size() || theseHits[layer].empty()) {
206 ATH_MSG_ERROR("Hit index out of range in keepHitsStrategy: layer=" << layer << ", hits.size()=" << theseHits.size());
207 return StatusCode::FAILURE;
208 }
209 vec[ihit].push_back(theseHits[layer][0]);
210 }
211 r.setHits(std::move(vec));
212 }
213 }
214
215 roads = std::move(m_roads);
216 ATH_MSG_DEBUG("Roads = " << roads.size());
217
218 // clear previous event
219 // (reusing saves having to reallocate memory for each event)
220 m_binnedhits->resetBins();
221
223 return StatusCode::SUCCESS;
224}
#define ATH_CHECK
Evaluate an expression and check for errors.
#define ATH_MSG_FATAL(x)
std::vector< size_t > vec
std::vector< unsigned > PickHitsToUse(layer_bitmask_t) const
Gaudi::Property< int > m_keepHitsStrategy
Gaudi::Property< std::string > m_binFilter
Gaudi::Property< unsigned > m_threshold
void addRoad(std::vector< const StoredHit * > const &hits, const FPGATrackSimBinUtil::IdxSet &idx)
Gaudi::Property< bool > m_binningOnly
StatusCode pairThenGroupFilter(const BinEntry &bindata, std::vector< HitPairSet > &output_pairset)
StatusCode incrementalBuildFilter(const BinEntry &bindata, std::vector< HitPairSet > &output_pairset)
ToolHandle< FPGATrackSimGenScanMonitoring > m_monitoring
float getR() const
@ layer
Definition HitInfo.h:79
std::shared_ptr< const FPGATrackSimHit > hitptr

◆ getSubRegion()

virtual int FPGATrackSimGenScanTool::getSubRegion ( ) const
inlineoverridevirtual

Definition at line 90 of file FPGATrackSimGenScanTool.h.

90{return 0;}

◆ groupPairs()

StatusCode FPGATrackSimGenScanTool::groupPairs ( HitPairSet & filteredpairs,
std::vector< HitPairSet > & clusters,
bool verbose )
protected

Definition at line 477 of file FPGATrackSimGenScanTool.cxx.

480{
481 ATH_MSG_VERBOSE("In groupPairs");
482 for (const FPGATrackSimGenScanTool::HitPair & pair : filteredpairs.pairList)
483 {
484 bool added = false;
485 for (FPGATrackSimGenScanTool::HitPairSet &pairset : pairsets)
486 {
487 // Only add skip pairs if skipped layer is not already hit
488 if ((std::abs(int(pair.second->layer) - int(pair.first->layer)) > 1) // gives if is a skip pair
489 && (pairset.hasLayer(std::min(pair.first->layer,pair.second->layer) + 1))) // gives true if skipped layer already in set
490 {
491 // if it matches mark as added so it doesn't start a new pairset
492 // false here is so it doesn't plot these either
493 if (pairMatchesPairSet(pairset, pair, verbose))
494 added = true;
495 if (!added) {
496 ATH_MSG_VERBOSE("Skip pair does not match non-skip pair");
497 }
498 }
499 else
500 {
501 if (pairMatchesPairSet(pairset, pair, verbose))
502 {
503 int size = pairset.addPair(pair);
504 if (verbose)
505 ATH_MSG_VERBOSE("addPair " << pairsets.size() << " " << pairset.pairList.size() << " " << size);
506 added = true;
507 }
508 }
509
510 }
511
512 if (!added)
513 {
514 HitPairSet newpairset;
515 newpairset.addPair(pair);
516 pairsets.push_back(std::move(newpairset));
517 }
518 }
519
520 return StatusCode::SUCCESS;
521
522}
bool pairMatchesPairSet(const HitPairSet &pairset, const HitPair &pair, bool verbose)
bool verbose
Definition hcg.cxx:73

◆ incrementalBuildFilter()

StatusCode FPGATrackSimGenScanTool::incrementalBuildFilter ( const BinEntry & bindata,
std::vector< HitPairSet > & output_pairset )
protected

Definition at line 371 of file FPGATrackSimGenScanTool.cxx.

373{
374 ATH_MSG_VERBOSE("In buildGroupsWithPairs");
375
376 // Organize Hits by Layer
377 std::vector<std::vector<const StoredHit *>> hitsByLayer(m_binnedhits->getNLayers());
378 ATH_CHECK(sortHitsByLayer(bindata, hitsByLayer));
379
380 // This is monitoring for each bin over threshold
381 // It's here so it can get the hitsByLayer
382 m_monitoring->fillHitsByLayer(hitsByLayer);
383
384 std::vector<IntermediateState> states{m_binnedhits->getNLayers()+1};
385 for (unsigned lyridx = 0; lyridx < m_binnedhits->getNLayers(); lyridx++) {
386 unsigned lyr = m_pairingLayers[lyridx];
387 updateState(states[lyridx] , states[lyridx+1], lyridx, hitsByLayer[lyr]);
388 }
389
390 // this is a little ugly because it requires copying the output pairsets right now
391 output_pairsets=states[m_binnedhits->getNLayers()].pairsets;
392
393 m_monitoring->fillBuildGroupsWithPairs(states,m_binnedhits->getNLayers()-m_threshold);
394
395 return StatusCode::SUCCESS;
396}
std::vector< unsigned int > m_pairingLayers
StatusCode sortHitsByLayer(const BinEntry &bindata, std::vector< std::vector< const StoredHit * > > &hitsByLayer)
void updateState(const IntermediateState &inputstate, IntermediateState &outputstate, unsigned lyridx, const std::vector< const StoredHit * > &newhits)

◆ initialize()

StatusCode FPGATrackSimGenScanTool::initialize ( )
overridevirtual

Definition at line 68 of file FPGATrackSimGenScanTool.cxx.

69{
70 // Dump the configuration to make sure it propagated through right
71 const std::vector<Gaudi::Details::PropertyBase*> props = this->getProperties();
72 for( Gaudi::Details::PropertyBase* prop : props ) {
73 if (prop->ownerTypeName()==this->type()) {
74 ATH_MSG_DEBUG("Property:\t" << prop->name() << "\t : \t" << prop->toString());
75 }
76 }
77
78 // Retrieve info
80 ATH_MSG_INFO("Map specifies :" << m_binnedhits->getNLayers());
81 ATH_CHECK(m_binnedhits.retrieve());
82 ATH_CHECK(m_monitoring.retrieve());
83 ATH_MSG_INFO("Monitoring Dir :" << m_monitoring->dir());
84
85 // Setup layer configuration if not already set from layerMap
86 if (m_binnedhits->getNLayers()==0){
87 auto nLogicalLayers = m_FPGATrackSimMapping->PlaneMap_1st(getSubRegion())->getNLogiLayers();
88 if (nLogicalLayers == 0){
89 ATH_MSG_ERROR("Number of logical layers is zero in FPGATrackSimGenScanTool::initialize");
90 return StatusCode::FAILURE;
91 }
92 m_binnedhits->setNLayers(nLogicalLayers);
93 }
94 // This is the layers they get paired with previous layers
95 for (unsigned lyr = 0; lyr < m_binnedhits->getNLayers(); ++lyr) m_pairingLayers.push_back(lyr);
96 if (m_reversePairDir) {
98 }
99 ATH_MSG_INFO("Pairing Layers: " << m_pairingLayers);
100
101 // Check inputs
102 bool ok = false;
103 const int signedSize = static_cast<int>(m_binnedhits->getNLayers()) - 1;
104 if (std::ssize(m_pairFilterDeltaPhiCut) != signedSize)
105 ATH_MSG_FATAL("initialize() pairFilterDeltaPhiCut must have size nLayers-1=" << signedSize << " found " << m_pairFilterDeltaPhiCut.size());
106 else if (std::ssize(m_pairFilterDeltaEtaCut) != signedSize)
107 ATH_MSG_FATAL("initialize() pairFilterDeltaEtaCut must have size nLayers-1=" << signedSize << " found " << m_pairFilterDeltaEtaCut.size());
108 else if (m_pairFilterPhiExtrapCut.size() != 2)
109 ATH_MSG_FATAL("initialize() pairFilterPhiExtrapCut must have size 2 found " << m_pairFilterPhiExtrapCut.size());
110 else if (m_pairFilterEtaExtrapCut.size() != 2)
111 ATH_MSG_FATAL("initialize() pairFilterEtaExtrapCut must have size 2 found " << m_pairFilterEtaExtrapCut.size());
112 else if (m_pairSetPhiExtrapCurvedCut.size() != 2)
113 ATH_MSG_FATAL("initialize() PairSetPhiExtrapCurvedCut must have size 2found " << m_pairSetPhiExtrapCurvedCut.size());
114 else if ((m_rin < 0.0) || (m_rout < 0.0))
115 ATH_MSG_FATAL("Radii not set");
116 else
117 ok = true;
118 if (!ok)
119 return StatusCode::FAILURE;
120
121
122 // register histograms
123 ATH_CHECK(m_monitoring->registerHistograms(m_binnedhits.get()));
124
125 // write out the firmware LUTs
126 m_binnedhits->getBinTool().writeLUTs();
127
128 return StatusCode::SUCCESS;
129}
#define ATH_MSG_INFO(x)
Gaudi::Property< std::vector< double > > m_pairFilterDeltaEtaCut
virtual int getSubRegion() const override
ServiceHandle< IFPGATrackSimMappingSvc > m_FPGATrackSimMapping
Gaudi::Property< std::vector< double > > m_pairSetPhiExtrapCurvedCut
Gaudi::Property< std::vector< double > > m_pairFilterPhiExtrapCut
Gaudi::Property< std::vector< double > > m_pairFilterDeltaPhiCut
Gaudi::Property< bool > m_reversePairDir
Gaudi::Property< std::vector< double > > m_pairFilterEtaExtrapCut
void reverse(typename DataModel_detail::iterator< DVL > beg, typename DataModel_detail::iterator< DVL > end)
Specialization of reverse for DataVector/List.

◆ makePairs()

StatusCode FPGATrackSimGenScanTool::makePairs ( const std::vector< std::vector< const StoredHit * > > & hitsByLayer,
HitPairSet & pairs )
protected

Definition at line 417 of file FPGATrackSimGenScanTool.cxx.

419{
420 ATH_MSG_VERBOSE("In makePairs");
421
422 std::vector<const StoredHit *> const * lastlyr = 0;
423 std::vector<const StoredHit *> const * lastlastlyr = 0;
424
425 // order here is designed so lower radius hits come first
426 for (unsigned lyr : m_pairingLayers) {
427 for (const StoredHit *const &ptr1 :
428 hitsByLayer[lyr]) {
429 if (lastlyr) {
430 for (const StoredHit *const &ptr2 : *lastlyr) {
431 pairs.addPair(HitPair(ptr2, ptr1,m_reversePairDir));
432 }
433 // Add Pairs that skip one layer
434 if (lastlastlyr) {
435 for (const StoredHit *const &ptr2 : *lastlastlyr) {
436 pairs.addPair(HitPair(ptr2, ptr1,m_reversePairDir));
437 }
438 }
439 }
440 }
441 lastlastlyr = lastlyr;
442 lastlyr = &hitsByLayer[lyr];
443 m_monitoring->fillPairingHits(lastlyr,lastlastlyr);
444 }
445
446 return StatusCode::SUCCESS;
447}
FPGATrackSimBinUtil::StoredHit StoredHit

◆ pairMatchesPairSet()

bool FPGATrackSimGenScanTool::pairMatchesPairSet ( const HitPairSet & pairset,
const HitPair & pair,
bool verbose )
protected

Definition at line 525 of file FPGATrackSimGenScanTool.cxx.

527 {
528 // In order to make it easy to have a long list of possible cuts,
529 // a vector of cutvar structs is used to represent each cut
530 // then apply the AND of all the cuts is done with a std::count_if function
531
532 // define the struct (effectively mapping because variable, configured cut value,
533 // and histograms for plotting
534 struct cutvar {
535 cutvar(std::string name, double val, double cut, std::vector<TH1D *>& histset) :
536 m_name(std::move(name)), m_val(val), m_cut(cut), m_histset(histset) {}
537 bool passed() { return std::abs(m_val) < m_cut; }
538 void fill(unsigned cat) { m_histset[cat]->Fill(m_val); }
539 std::string m_name;
540 double m_val;
541 double m_cut;
542 std::vector<TH1D *> &m_histset;
543 };
544
545 // add the cuts to the list of all cuts
546 std::vector<cutvar> allcuts;
547 allcuts.push_back(cutvar("MatchPhi", pairset.MatchPhi(pair),
549 m_monitoring->m_pairSetMatchPhi));
550 allcuts.push_back(cutvar("MatchEta", pairset.MatchEta(pair),
552 m_monitoring->m_pairSetMatchEta));
553 allcuts.push_back(cutvar("DeltaDeltaPhi", pairset.DeltaDeltaPhi(pair),
555 m_monitoring->m_deltaDeltaPhi));
556 allcuts.push_back(cutvar("DeltaDeltaEta", pairset.DeltaDeltaEta(pair),
558 m_monitoring->m_deltaDeltaEta));
559 allcuts.push_back(cutvar("PhiCurvature", pairset.PhiCurvature(pair),
561 m_monitoring->m_phiCurvature));
562 allcuts.push_back(cutvar("EtaCurvature", pairset.EtaCurvature(pair),
564 m_monitoring->m_etaCurvature));
565 if (pairset.pairList.size() > 1) {
566 allcuts.push_back(cutvar(
567 "DeltaPhiCurvature", pairset.DeltaPhiCurvature(pair),
568 m_pairSetDeltaPhiCurvatureCut, m_monitoring->m_deltaPhiCurvature));
569 allcuts.push_back(cutvar(
570 "DeltaEtaCurvature", pairset.DeltaEtaCurvature(pair),
571 m_pairSetDeltaEtaCurvatureCut, m_monitoring->m_deltaEtaCurvature));
572 }
573 allcuts.push_back(cutvar(
574 "PhiInExtrapCurved", pairset.PhiInExtrapCurved(pair, m_rin),
575 m_pairSetPhiExtrapCurvedCut[0], m_monitoring->m_phiInExtrapCurved));
576 allcuts.push_back(cutvar(
577 "PhiOutExtrapCurved", pairset.PhiOutExtrapCurved(pair, m_rout),
578 m_pairSetPhiExtrapCurvedCut[1], m_monitoring->m_phiOutExtrapCurved));
579
580 // count number of cuts passed
581 unsigned passedCuts = std::count_if(allcuts.begin(), allcuts.end(),
582 [](cutvar& cut) { return cut.passed(); });
583 bool passedAll = (passedCuts == allcuts.size());
584
585 // monitoring
586 bool passedAllButOne = (passedCuts == allcuts.size() - 1);
587 for (cutvar& cut: allcuts) {
588 // the last value computes if an n-1 histogram should be filled
589 m_monitoring->fillPairSetFilterCut(cut.m_histset, cut.m_val, pair,
590 pairset.lastpair(),
591 (passedAll || (passedAllButOne && !cut.passed())));
592 }
593
594 if (verbose)
595 {
596 std::string s = "";
597 for (cutvar &cut : allcuts)
598 {
599 s += cut.m_name + " : (" + cut.passed() + ", " + cut.m_val + "), ";
600 }
601 ATH_MSG_DEBUG("PairSet test " << passedAll << " " << s);
602 ATH_MSG_DEBUG("Hits: \n " << *pairset.lastpair().first << "\n "
603 << *pairset.lastpair().second << "\n "
604 << *pair.first << "\n "
605 << *pair.second);
606 }
607
608 return passedAll;
609}
bool passed(DecisionID id, const DecisionIDContainer &)
checks if required decision ID is in the set of IDs in the container
Gaudi::Property< double > m_pairSetMatchPhiCut
Gaudi::Property< double > m_pairSetDeltaDeltaPhiCut
Gaudi::Property< double > m_pairSetDeltaEtaCurvatureCut
Gaudi::Property< double > m_pairSetDeltaDeltaEtaCut
Gaudi::Property< double > m_pairSetEtaCurvatureCut
Gaudi::Property< double > m_pairSetMatchEtaCut
Gaudi::Property< double > m_pairSetPhiCurvatureCut
Gaudi::Property< double > m_pairSetDeltaPhiCurvatureCut
cut
This script demonstrates how to call a C++ class from Python Also how to use PyROOT is shown.
void fill(H5::Group &out_file, size_t iterations)

◆ pairPassesFilter()

bool FPGATrackSimGenScanTool::pairPassesFilter ( const HitPair & pair)
protected

Definition at line 452 of file FPGATrackSimGenScanTool.cxx.

452 {
453 m_monitoring->fillPairFilterCuts(pair,m_rin,m_rout);
454 int lyr = std::min(pair.first->layer,pair.second->layer);
455 return (std::abs(pair.dPhi()) < m_pairFilterDeltaPhiCut[lyr]) &&
456 (std::abs(pair.dEta()) < m_pairFilterDeltaEtaCut[lyr]) &&
457 (std::abs(pair.PhiInExtrap(m_rin)) < m_pairFilterPhiExtrapCut[0]) &&
458 (std::abs(pair.PhiOutExtrap(m_rout)) < m_pairFilterPhiExtrapCut[1]) &&
459 (std::abs(pair.EtaInExtrap(m_rin)) < m_pairFilterEtaExtrapCut[0]) &&
460 (std::abs(pair.EtaOutExtrap(m_rout)) < m_pairFilterEtaExtrapCut[1]);
461}

◆ pairThenGroupFilter()

StatusCode FPGATrackSimGenScanTool::pairThenGroupFilter ( const BinEntry & bindata,
std::vector< HitPairSet > & output_pairset )
protected

Definition at line 227 of file FPGATrackSimGenScanTool.cxx.

229{
230 ATH_MSG_VERBOSE("In pairThenGroupFilter");
231
232 // Organize Hits by Layer
233 std::vector<std::vector<const StoredHit *>> hitsByLayer(m_binnedhits->getNLayers());
234 ATH_CHECK(sortHitsByLayer(bindata, hitsByLayer));
235
236 // This is monitoring for each bin over threshold
237 // It's here so it can get the hitsByLayer
238 m_monitoring->fillHitsByLayer(hitsByLayer);
239
240 // Make Pairs
242 ATH_CHECK(makePairs(hitsByLayer, pairs));
243
244 // Filter Pairs
245 HitPairSet filteredpairs;
246 ATH_CHECK(filterPairs(pairs, filteredpairs));
247
248 // Require road is still over threshold
249 bool passedPairFilter = (filteredpairs.lyrCnt() >= m_threshold);
250 m_monitoring->pairFilterCheck(pairs, filteredpairs, passedPairFilter);
251
252 // if passed Pair Filter proceed to group the filtered pairs into pairsets
253 if (passedPairFilter)
254 {
255 // Pair Set Grouping
256 std::vector<HitPairSet> pairsets;
257 ATH_CHECK(groupPairs(filteredpairs, pairsets, false));
258
259 // loop over pairsets and find those that are over thresold
260 for (const FPGATrackSimGenScanTool::HitPairSet& pairset : pairsets)
261 {
262 // if over threshold add it to the output
263 if (pairset.lyrCnt() >= m_threshold)
264 {
266 output_pairsets.push_back(pairset);
267 }
268 }
269 }
270 }
271
272 // set outputs if not all filters applied
273 if (!m_applyPairFilter) {
274 // output is just the filtered pairs
275 output_pairsets.push_back(std::move(pairs));
276 }
277 else if (passedPairFilter && !m_applyPairSetFilter)
278 {
279 // output is just the filtered pairs
280 output_pairsets.push_back(std::move(filteredpairs));
281 }
282
283 return StatusCode::SUCCESS;
284}
StatusCode groupPairs(HitPairSet &filteredpairs, std::vector< HitPairSet > &clusters, bool verbose)
Gaudi::Property< bool > m_applyPairFilter
StatusCode filterPairs(HitPairSet &pairs, HitPairSet &filteredpairs)
StatusCode makePairs(const std::vector< std::vector< const StoredHit * > > &hitsByLayer, HitPairSet &pairs)
Gaudi::Property< bool > m_applyPairSetFilter

◆ PickHitsToUse()

std::vector< unsigned > FPGATrackSimGenScanTool::PickHitsToUse ( layer_bitmask_t hitmask) const
protected

Definition at line 885 of file FPGATrackSimGenScanTool.cxx.

886{
887 std::vector<unsigned> toUse;
888 switch (m_keepHitsStrategy) {
889 case 1: // try and pick hits furthest apart, use only 3
890 {
891 if (hitmask == 0x1f) { // miss no hits
892 toUse = {0,2,4};
893 }
894 else if (hitmask == 0x1e) { // miss inner layer, ie layer 0
895 toUse = {1,3,4};
896 }
897 else if (hitmask == 0x1d) { // miss layer 1
898 toUse = {0,2,4};
899 }
900 else if (hitmask == 0x1b) { // miss layer 2
901 toUse = {0,3,4};
902 }
903 else if (hitmask == 0x17) { // miss layer 3
904 toUse = {0,2,4};
905 }
906 else if (hitmask == 0x0f) { // miss layer 4
907 toUse = {0,2,3};
908 }
909 }
910 break;
911 case 2: // pick inner hits, use only 3
912 {
913 if (hitmask == 0x1f) { // miss no hits
914 toUse = {0,1,2};
915 }
916 else if (hitmask == 0x1e) { // miss inner layer, ie layer 0
917 toUse = {1,2,3};
918 }
919 else if (hitmask == 0x1d) { // miss layer 1
920 toUse = {0,2,3};
921 }
922 else if (hitmask == 0x1b) { // miss layer 2
923 toUse = {0,1,3};
924 }
925 else if (hitmask == 0x17) { // miss layer 3
926 toUse = {0,1,2};
927 }
928 else if (hitmask == 0x0f) { // miss layer 4
929 toUse = {0,1,2};
930 }
931 }
932 break;
933 case 3: // pick outer hits, use only 3
934 {
935 if (hitmask == 0x1f) { // miss no hits
936 toUse = {2,3,4};
937 }
938 else if (hitmask == 0x1e) { // miss inner layer, ie layer 0
939 toUse = {2,3,4};
940 }
941 else if (hitmask == 0x1d) { // miss layer 1
942 toUse = {2,3,4};
943 }
944 else if (hitmask == 0x1b) { // miss layer 2
945 toUse = {1,3,4};
946 }
947 else if (hitmask == 0x17) { // miss layer 3
948 toUse = {1,2,4};
949 }
950 else if (hitmask == 0x0f) { // miss layer 4
951 toUse = {1,2,3};
952 }
953 }
954 break;
955 case 4: // keep 4 hits, choose middle one to drop if necessary
956 {
957 if (hitmask == 0x1f) { // miss no hits
958 toUse = {0,1,2,3};
959 }
960 else if (hitmask == 0x1e) { // miss inner layer, ie layer 0
961 toUse = {1,2,3,4};
962 }
963 else if (hitmask == 0x1d) { // miss layer 1
964 toUse = {0,2,3,4};
965 }
966 else if (hitmask == 0x1b) { // miss layer 2
967 toUse = {0,1,3,4};
968 }
969 else if (hitmask == 0x17) { // miss layer 3
970 toUse = {0,1,2,4};
971 }
972 else if (hitmask == 0x0f) { // miss layer 4
973 toUse = {0,1,2,3};
974 }
975 }
976 break;
977 }
978 return toUse;
979}

◆ sortHitsByLayer()

StatusCode FPGATrackSimGenScanTool::sortHitsByLayer ( const BinEntry & bindata,
std::vector< std::vector< const StoredHit * > > & hitsByLayer )
protected

Definition at line 400 of file FPGATrackSimGenScanTool.cxx.

402{
403 ATH_MSG_DEBUG("In fillHitsByLayer");
404
405 for (const FPGATrackSimBinUtil::StoredHit &hit : bindata.hits) {
406 hitsByLayer.at(hit.layer).push_back(&hit);
407 }
408
409 return StatusCode::SUCCESS;
410}

◆ updateState()

void FPGATrackSimGenScanTool::updateState ( const IntermediateState & inputstate,
IntermediateState & outputstate,
unsigned lyridx,
const std::vector< const StoredHit * > & newhits )
protected

Definition at line 287 of file FPGATrackSimGenScanTool.cxx.

291{
292 unsigned int allowed_missed_hits = m_binnedhits->getNLayers() - m_threshold;
293
294 std::vector<bool> pairset_used(inputstate.pairsets.size(),false);
295
296 for (auto &newhit : newhits) {
297
298 // don't make new pairs with hits that the new hit is already paired with in a group
299 std::set<const StoredHit *> vetoList;
300
301 // try adding hit to existing pair sets
302 for (unsigned ps_idx = 0; ps_idx < inputstate.pairsets.size(); ++ps_idx) {
303 auto &pairset = inputstate.pairsets[ps_idx];
304 HitPair nextpair(pairset.lastpair().second, newhit, m_reversePairDir);
305 if (pairMatchesPairSet(pairset, nextpair, false) || (m_applyPairSetFilter==false)) {
306 HitPairSet newset(pairset);
307 newset.addPair(nextpair);
308 pairset_used[ps_idx]=true;
309 outputstate.pairsets.push_back(std::move(newset));
310 // put inpair hits in list of hits not to pair again with the new hits
311 for (auto vetohit : pairset.hitlist) {
312 vetoList.insert(vetohit);
313 }
314 }
315 }
316
317 // make new pairsets with unpaired hits
318 for (auto prevhit : inputstate.unpairedHits) {
319 if (vetoList.count(prevhit) == 0) {
320 HitPair newpair(prevhit, newhit, m_reversePairDir);
321 if (pairPassesFilter(newpair) || (m_applyPairFilter == false)) {
322 HitPairSet newset;
323 newset.addPair(newpair);
324 outputstate.pairsets.push_back(std::move(newset));
325 }
326 }
327 }
328
329 // if this can be the start of a the start of a track and still
330 // have enough hits to make a track, add it to the unpaired hits list
331 if (lyridx <= allowed_missed_hits) {
332 outputstate.unpairedHits.push_back(newhit);
333 }
334 }
335
336 // Add groups to output without new hit if they have enough hits to skip
337 // this layer. Note expected hits at this point is lyridx+1, since we start
338 // counting lyridx from zero. Logic is then keep the pairset if
339 // expected hits <= hits in set + allows misses
340 for (unsigned ps_idx = 0; ps_idx < inputstate.pairsets.size(); ++ps_idx) {
341 auto &pairset = inputstate.pairsets[ps_idx];
342 if ((!pairset_used[ps_idx])&&(lyridx < (pairset.hitlist.size() + allowed_missed_hits))) {
343 outputstate.pairsets.push_back(pairset);
344 }
345 }
346
347 // Add hits to unpaired list if hits are still allowed to start a track
348 // ---------------------------------------------------------------------
349 // If you start a new track with a pair whose second element is
350 // layer N (layer numbering starting from zero), then you'll have missed N-1
351 // layers Minus 1 because the first hit was one of the N layers already
352 // passed.
353 //
354 // The next pass will be layer N=lyridx+1 where lyridx is the current value
355 // at this point in the code. You will have then missed lyridx layers, so...
356 // E.g. if you allow one missed layer then this stops putting hits in the
357 // unpairedHits list if lyridx>1, so tracks must start with layer 0 or 1,
358 // which makes sense
359 if (lyridx > allowed_missed_hits) {
360 // make no new track starts
361 outputstate.unpairedHits.clear();
362 } else {
363 // copy in any previous unpairedHits as well
364 for (auto prevhit : inputstate.unpairedHits) {
365 outputstate.unpairedHits.push_back(prevhit);
366 }
367 }
368}

◆ FPGATrackSimGenScanMonitoring

friend class FPGATrackSimGenScanMonitoring
friend

Definition at line 92 of file FPGATrackSimGenScanTool.h.

Member Data Documentation

◆ m_applyPairFilter

Gaudi::Property<bool> FPGATrackSimGenScanTool::m_applyPairFilter {this, "applyPairFilter", {}, "Apply Pair Filter"}
protected

Definition at line 114 of file FPGATrackSimGenScanTool.h.

114{this, "applyPairFilter", {}, "Apply Pair Filter"};

◆ m_applyPairSetFilter

Gaudi::Property<bool> FPGATrackSimGenScanTool::m_applyPairSetFilter {this, "applyPairSetFilter", {}, "Apply PairSet Filter"}
protected

Definition at line 121 of file FPGATrackSimGenScanTool.h.

121{this, "applyPairSetFilter", {}, "Apply PairSet Filter"};

◆ m_binFilter

Gaudi::Property<std::string> FPGATrackSimGenScanTool::m_binFilter {this, "binFilter", {"PairThenGroup"}, "which bin filter to run, current options: PairThenGroup, IncrementalBuild"}
protected

Definition at line 111 of file FPGATrackSimGenScanTool.h.

111{this, "binFilter", {"PairThenGroup"}, "which bin filter to run, current options: PairThenGroup, IncrementalBuild"};

◆ m_binnedhits

ToolHandle<FPGATrackSimBinnedHits> FPGATrackSimGenScanTool::m_binnedhits {this, "BinnedHits", "FPGATrackSimBinnedHits", "Binned Hits Class"}
protected

Definition at line 101 of file FPGATrackSimGenScanTool.h.

101{this, "BinnedHits", "FPGATrackSimBinnedHits", "Binned Hits Class"};

◆ m_binningOnly

Gaudi::Property<bool> FPGATrackSimGenScanTool::m_binningOnly {this, "binningOnly", {false}, "Turn off road building to test the binning only"}
protected

Definition at line 113 of file FPGATrackSimGenScanTool.h.

113{this, "binningOnly", {false}, "Turn off road building to test the binning only"};

◆ m_etaWeight_4hits

Gaudi::Property<double> FPGATrackSimGenScanTool::m_etaWeight_4hits {this, "etaChi2Weight_4hits", 1.0, "Weight for eta component of chi2 in genscan fit for 4 hit roads"}
protected

Definition at line 132 of file FPGATrackSimGenScanTool.h.

132{this, "etaChi2Weight_4hits", 1.0, "Weight for eta component of chi2 in genscan fit for 4 hit roads"};

◆ m_etaWeight_5hits

Gaudi::Property<double> FPGATrackSimGenScanTool::m_etaWeight_5hits {this, "etaChi2Weight_5hits", 1.0, "Weight for eta component of chi2 in genscan fit for 5 hit roads"}
protected

Definition at line 134 of file FPGATrackSimGenScanTool.h.

134{this, "etaChi2Weight_5hits", 1.0, "Weight for eta component of chi2 in genscan fit for 5 hit roads"};

◆ m_EvtSel

ServiceHandle<IFPGATrackSimEventSelectionSvc> FPGATrackSimGenScanTool::m_EvtSel {this, "FPGATrackSimEventSelectionSvc", ""}
protected

Definition at line 98 of file FPGATrackSimGenScanTool.h.

98{this, "FPGATrackSimEventSelectionSvc", ""};

◆ m_evtsProcessed

int FPGATrackSimGenScanTool::m_evtsProcessed = 0
protected

Definition at line 270 of file FPGATrackSimGenScanTool.h.

◆ m_FPGATrackSimMapping

ServiceHandle<IFPGATrackSimMappingSvc> FPGATrackSimGenScanTool::m_FPGATrackSimMapping {this, "FPGATrackSimMappingSvc", "FPGATrackSimMappingSvc"}
protected

Definition at line 99 of file FPGATrackSimGenScanTool.h.

99{this, "FPGATrackSimMappingSvc", "FPGATrackSimMappingSvc"};

◆ m_inBinFiltering

Gaudi::Property<bool> FPGATrackSimGenScanTool::m_inBinFiltering {this, "inBinFiltering", true, "Filter roads that appear to be outside their bin"}
protected

Definition at line 135 of file FPGATrackSimGenScanTool.h.

135{this, "inBinFiltering", true, "Filter roads that appear to be outside their bin"};

◆ m_keepHitsStrategy

Gaudi::Property<int> FPGATrackSimGenScanTool::m_keepHitsStrategy {this, "keepHitsStrategy", -1, "If this is less than 0, do nothing. If 1, pick 3 hits furthest apart. If 2, pick 3 inner hits. If 3, pick 3 outer hits. If 4, drop only middle hit for 5/5 otherwise keep all 4 hits for 4/5"}
protected

Definition at line 136 of file FPGATrackSimGenScanTool.h.

136{this, "keepHitsStrategy", -1, "If this is less than 0, do nothing. If 1, pick 3 hits furthest apart. If 2, pick 3 inner hits. If 3, pick 3 outer hits. If 4, drop only middle hit for 5/5 otherwise keep all 4 hits for 4/5"};

◆ m_monitoring

ToolHandle<FPGATrackSimGenScanMonitoring> FPGATrackSimGenScanTool::m_monitoring {this, "Monitoring", "FPGATrackSimGenScanMonitoring", "Monitoring Tool"}
protected

Definition at line 100 of file FPGATrackSimGenScanTool.h.

100{this, "Monitoring", "FPGATrackSimGenScanMonitoring", "Monitoring Tool"};

◆ m_pairFilterDeltaEtaCut

Gaudi::Property<std::vector<double> > FPGATrackSimGenScanTool::m_pairFilterDeltaEtaCut {this, "pairFilterDeltaEtaCut", {}, "Pair Filter Delta Eta Cut Value (list one per layer)"}
protected

Definition at line 117 of file FPGATrackSimGenScanTool.h.

117{this, "pairFilterDeltaEtaCut", {}, "Pair Filter Delta Eta Cut Value (list one per layer)"};

◆ m_pairFilterDeltaPhiCut

Gaudi::Property<std::vector<double> > FPGATrackSimGenScanTool::m_pairFilterDeltaPhiCut {this, "pairFilterDeltaPhiCut", {}, "Pair Filter Delta Phi Cut Value (list one per layer)"}
protected

Definition at line 116 of file FPGATrackSimGenScanTool.h.

116{this, "pairFilterDeltaPhiCut", {}, "Pair Filter Delta Phi Cut Value (list one per layer)"};

◆ m_pairFilterEtaExtrapCut

Gaudi::Property<std::vector<double> > FPGATrackSimGenScanTool::m_pairFilterEtaExtrapCut {this, "pairFilterEtaExtrapCut", {}, "Pair Filter Eta Extrap Cut Value(in/out pair)"}
protected

Definition at line 119 of file FPGATrackSimGenScanTool.h.

119{this, "pairFilterEtaExtrapCut", {}, "Pair Filter Eta Extrap Cut Value(in/out pair)"};

◆ m_pairFilterPhiExtrapCut

Gaudi::Property<std::vector<double> > FPGATrackSimGenScanTool::m_pairFilterPhiExtrapCut {this, "pairFilterPhiExtrapCut", {}, "Pair Filter Phi Extrap Cut Value (in/out pair)"}
protected

Definition at line 118 of file FPGATrackSimGenScanTool.h.

118{this, "pairFilterPhiExtrapCut", {}, "Pair Filter Phi Extrap Cut Value (in/out pair)"};

◆ m_pairingLayers

std::vector<unsigned int> FPGATrackSimGenScanTool::m_pairingLayers
protected

Definition at line 271 of file FPGATrackSimGenScanTool.h.

◆ m_pairSetDeltaDeltaEtaCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetDeltaDeltaEtaCut {this, "pairSetDeltaDeltaEtaCut", {}, "Pair Set Delta Eta Cut Value"}
protected

Definition at line 125 of file FPGATrackSimGenScanTool.h.

125{this, "pairSetDeltaDeltaEtaCut", {}, "Pair Set Delta Eta Cut Value"};

◆ m_pairSetDeltaDeltaPhiCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetDeltaDeltaPhiCut {this, "pairSetDeltaDeltaPhiCut", {}, "Pair Set Delta Delta Phi Cut Value"}
protected

Definition at line 124 of file FPGATrackSimGenScanTool.h.

124{this, "pairSetDeltaDeltaPhiCut", {}, "Pair Set Delta Delta Phi Cut Value"};

◆ m_pairSetDeltaEtaCurvatureCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetDeltaEtaCurvatureCut {this, "pairSetDeltaEtaCurvatureCut", {}, "Pair Set Delta Eta Curvature Cut Value"}
protected

Definition at line 129 of file FPGATrackSimGenScanTool.h.

129{this, "pairSetDeltaEtaCurvatureCut", {}, "Pair Set Delta Eta Curvature Cut Value"};

◆ m_pairSetDeltaPhiCurvatureCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetDeltaPhiCurvatureCut {this, "pairSetDeltaPhiCurvatureCut", {}, "Pair Set Delta Phi Curvature Cut Value"}
protected

Definition at line 128 of file FPGATrackSimGenScanTool.h.

128{this, "pairSetDeltaPhiCurvatureCut", {}, "Pair Set Delta Phi Curvature Cut Value"};

◆ m_pairSetEtaCurvatureCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetEtaCurvatureCut {this, "pairSetEtaCurvatureCut", {}, "Pair Set Eta Cut Value"}
protected

Definition at line 127 of file FPGATrackSimGenScanTool.h.

127{this, "pairSetEtaCurvatureCut", {}, "Pair Set Eta Cut Value"};

◆ m_pairSetMatchEtaCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetMatchEtaCut {this, "pairSetMatchEtaCut", {}, "Pair Set Match Eta Cut Value"}
protected

Definition at line 123 of file FPGATrackSimGenScanTool.h.

123{this, "pairSetMatchEtaCut", {}, "Pair Set Match Eta Cut Value"};

◆ m_pairSetMatchPhiCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetMatchPhiCut {this, "pairSetMatchPhiCut", {}, "Pair Set Match Phi Cut Value"}
protected

Definition at line 122 of file FPGATrackSimGenScanTool.h.

122{this, "pairSetMatchPhiCut", {}, "Pair Set Match Phi Cut Value"};

◆ m_pairSetPhiCurvatureCut

Gaudi::Property<double> FPGATrackSimGenScanTool::m_pairSetPhiCurvatureCut {this, "pairSetPhiCurvatureCut", {}, "Pair Set Phi Cut Value"}
protected

Definition at line 126 of file FPGATrackSimGenScanTool.h.

126{this, "pairSetPhiCurvatureCut", {}, "Pair Set Phi Cut Value"};

◆ m_pairSetPhiExtrapCurvedCut

Gaudi::Property<std::vector<double> > FPGATrackSimGenScanTool::m_pairSetPhiExtrapCurvedCut {this, "pairSetPhiExtrapCurvedCut", {}, "Pair Set Phi Extrap Curved Cut Value(in/out pair)"}
protected

Definition at line 130 of file FPGATrackSimGenScanTool.h.

130{this, "pairSetPhiExtrapCurvedCut", {}, "Pair Set Phi Extrap Curved Cut Value(in/out pair)"};

◆ m_phiWeight_4hits

Gaudi::Property<double> FPGATrackSimGenScanTool::m_phiWeight_4hits {this, "phiChi2Weight_4hits", 1.0, "Weight for phi component of chi2 in genscan fit for 4 hit roads"}
protected

Definition at line 131 of file FPGATrackSimGenScanTool.h.

131{this, "phiChi2Weight_4hits", 1.0, "Weight for phi component of chi2 in genscan fit for 4 hit roads"};

◆ m_phiWeight_5hits

Gaudi::Property<double> FPGATrackSimGenScanTool::m_phiWeight_5hits {this, "phiChi2Weight_5hits", 1.0, "Weight for phi component of chi2 in genscan fit for 5 hit roads"}
protected

Definition at line 133 of file FPGATrackSimGenScanTool.h.

133{this, "phiChi2Weight_5hits", 1.0, "Weight for phi component of chi2 in genscan fit for 5 hit roads"};

◆ m_reversePairDir

Gaudi::Property<bool> FPGATrackSimGenScanTool::m_reversePairDir {this, "reversePairDir", {}, "Build Pairs starting at last layer and work in"}
protected

Definition at line 115 of file FPGATrackSimGenScanTool.h.

115{this, "reversePairDir", {}, "Build Pairs starting at last layer and work in"};

◆ m_rin

Gaudi::Property<double> FPGATrackSimGenScanTool::m_rin {this, "rin", {-1.0}, "Radius of inner layer for extrapolations and keylayer definition"}
protected

Definition at line 105 of file FPGATrackSimGenScanTool.h.

105{this, "rin", {-1.0}, "Radius of inner layer for extrapolations and keylayer definition"};

◆ m_roads

std::vector<FPGATrackSimRoad> FPGATrackSimGenScanTool::m_roads {}
protected

Definition at line 274 of file FPGATrackSimGenScanTool.h.

274{};

◆ m_rout

Gaudi::Property<double> FPGATrackSimGenScanTool::m_rout {this, "rout", {-1.0}, "Radius of outer layer for extrapolations and keylayer definition"}
protected

Definition at line 106 of file FPGATrackSimGenScanTool.h.

106{this, "rout", {-1.0}, "Radius of outer layer for extrapolations and keylayer definition"};

◆ m_threshold

Gaudi::Property<unsigned> FPGATrackSimGenScanTool::m_threshold {this, "threshold", {}, "Minimum value to accept as a road (inclusive)"}
protected

Definition at line 109 of file FPGATrackSimGenScanTool.h.

109{this, "threshold", {}, "Minimum value to accept as a road (inclusive)"};

The documentation for this class was generated from the following files: