EIC Software
Reference for
EIC
simulation and reconstruction software on GitHub
|
A fun4all implementation of Alan's Hough Transform. More...
#include <fun4all_coresoftware/blob/master/offline/packages/trackreco/PHHoughSeeding.h>
Public Member Functions | |
PHHoughSeeding (const std::string &name="PHHoughSeeding", unsigned int nlayers_maps=3, unsigned int nlayers_intt=8, unsigned int nlayers_tpc=60, unsigned int seeding_nlayer=12, unsigned int min_seeding_nlayer=4) | |
~PHHoughSeeding () override | |
void | set_mag_field (float magField) |
float | get_mag_field () const |
void | set_chi2_cut_fast (double cut_par0, double cut_par1=0.0, double cut_max=FLT_MAX) |
set the tracking pt-dependent chi2 cut for fast fit, cut = min(par0 + par1 / pt, max) | |
void | set_chi2_cut_full (double chi2_cut) |
set the tracking chi2 cut for full fit | |
double | get_chi2_cut_full () const |
get the tracking chi2 cut for full fit | |
void | set_ca_chi2_cut (double chi2_cut) |
set early combination-land chi2 cut(?) | |
double | get_ca_chi2_cut () const |
get early combination-land chi2 cut(?) | |
void | set_cos_angle_cut (double cos_angle_cut) |
set early curvature cut between hits, lower values are more open | |
double | get_cos_angle_cut () const |
get early curvature cut between hits, lower values are more open | |
void | set_min_pT (float pt) |
void | set_z0_range (float min_z0, float max_z0) |
set the z0 search window | |
void | set_r_max (float max_r) |
set the r search window | |
void | set_material (int layer, float value) |
radiation length per layer, sequential layer indexes required here | |
void | setRejectGhosts (bool rg) |
set internal ghost rejection | |
void | setRemoveHits (bool rh) |
set for internal hit rejection | |
void | setBinScale (float scale) |
adjusts the rate of zooming | |
void | setZBinScale (float scale) |
adjusts the rate of zooming | |
void | setCutOnDCA (bool cod) |
turn on DCA limitation | |
void | setDCACut (float dcut) |
sets an upper limit on X-Y DCA | |
void | setDCAZCut (float dzcut) |
sets an upper limit on Z DCA | |
void | setPtRescaleFactor (float pt_rescale) |
void | setVoteErrorScale (unsigned int layer, float scale) |
adjust the relative voting error scale w.r.t. the cluster size | |
void | setFitErrorScale (unsigned int layer, float scale) |
adjust the relative fit error scale w.r.t. the cluster size | |
void | set_use_vertex (bool) |
set option to produce initial vertex for further tracking | |
void | setInitialResMultiplier (int) |
void | setFullResMultiplier (int) |
void | set_min_pT_init (float) |
set the minimum pT to try to find during initial vertex finding tracking | |
void | setMaxClusterError (float) |
limit the maximum error reported by cluster (in number of cell units) | |
void | setUseCellSize (bool) |
use the cell size as cluster size instead of value stored on cluster | |
void | set_chi2_cut_init (double) |
set the tracking chi2 for initial vertex finding | |
const std::vector< int > & | get_seeding_layer () const |
void | set_seeding_layer (const int *seedingLayer, const int n) |
void | set_analyzing_mode (bool analyzingMode) |
float | get_max_merging_deta () const |
void | set_max_merging_deta (float maxMergingDeta) |
float | get_max_merging_dphi () const |
void | set_max_merging_dphi (float maxMergingDphi) |
float | get_max_merging_dr () const |
void | set_max_merging_dr (float maxMergingDr) |
float | get_max_merging_dz () const |
void | set_max_merging_dz (float maxMergingDz) |
unsigned int | get_min_nlayers_seeding () const |
void | set_min_nlayers_seeding (unsigned int minNlayersSeeding) |
Public Member Functions inherited from PHTrackSeeding | |
PHTrackSeeding (const std::string &name="PHTrackSeeding") | |
~PHTrackSeeding () override | |
int | InitRun (PHCompositeNode *topNode) override |
int | process_event (PHCompositeNode *topNode) override |
int | End (PHCompositeNode *topNode) override |
Called at the end of all processing. | |
void | set_track_map_name (const std::string &map_name) |
void | SetUseTruthClusters (bool setit) |
void | SetIteration (int iter) |
Public Member Functions inherited from SubsysReco | |
~SubsysReco () override | |
virtual int | EndRun (const int) |
Called at the end of each run. | |
virtual int | Init (PHCompositeNode *) |
virtual int | Reset (PHCompositeNode *) |
Reset. | |
virtual int | ResetEvent (PHCompositeNode *) |
Clean up after each event. | |
void | Print (const std::string &="ALL") const override |
Public Member Functions inherited from Fun4AllBase | |
virtual | ~Fun4AllBase () |
virtual const std::string | Name () const |
Returns the name of this module. | |
virtual void | Name (const std::string &name) |
Sets the name of this module. | |
virtual void | Verbosity (const int ival) |
Sets the verbosity of this module (0 by default=quiet). | |
virtual void | Verbosity (enu_Verbosity ival) |
Sets the verbosity of this module (0 by default=quiet). | |
virtual int | Verbosity () const |
Gets the verbosity of this module. | |
Protected Member Functions | |
int | Setup (PHCompositeNode *topNode) override |
int | Process (PHCompositeNode *topNode) override |
int | End () override |
Called in SubsysReco::End. | |
Private Member Functions | |
int | GetNodes (PHCompositeNode *topNode) |
fetch node pointers | |
int | InitializeGeometry (PHCompositeNode *topNode) |
create new node output pointers | |
int | InitializePHGenFit (PHCompositeNode *topNode) |
track propagation | |
int | setup_seed_tracker_objects () |
code to setup seed tracking objects | |
int | setup_initial_tracker_object () |
code to setup initial vertexing tracker | |
int | setup_tracker_object () |
code to setup full tracking object | |
int | translate_input () |
fetch node pointers | |
int | fast_composite_seed () |
code to combine seed tracking vertex with BBCZ if available | |
int | fast_vertex_from_bbc () |
code to seed vertex from bbc | |
int | vertexing () |
code to seed vertex from initial tracking using a broad search window | |
int | full_track_seeding (int ivert) |
code to perform the final tracking and vertexing | |
int | export_output () |
code to translate back to the SVTX universe | |
int | CleanupSeedsByHitPattern () |
int | CleanupTracksByHitPattern () |
int | CleanupSeeds () |
void | print_timers () |
float | kappaToPt (float kappa) |
convert from inverse curvature to momentum | |
float | ptToKappa (float pt) |
convert from momentum to inverse curvature | |
void | convertHelixCovarianceToEuclideanCovariance (float B, float phi, float d, float kappa, float z0, float dzdl, Eigen::Matrix< float, 5, 5 > const &input, Eigen::Matrix< float, 6, 6 > &output) |
convert the covariance from HelixHough coords to x,y,z,px,py,pz | |
void | shift_coordinate_system (double dx, double dy, double dz, int ivertex) |
translate the clusters, tracks, and vertex from one origin to another | |
Private Attributes | |
int | _event |
PHTimer * | _t_seeding |
PHTimer * | _t_seed_init1 |
PHTimer * | _t_seed_init2 |
PHTimer * | _t_seed_init3 |
PHTimer * | _t_seeds_cleanup |
PHTimer * | _t_translate_to_PHGenFitTrack |
PHTimer * | _t_translate1 |
PHTimer * | _t_translate2 |
PHTimer * | _t_translate3 |
PHTimer * | _t_kalman_pat_rec |
PHTimer * | _t_search_clusters |
PHTimer * | _t_search_clusters_encoding |
PHTimer * | _t_search_clusters_map_iter |
PHTimer * | _t_track_propagation |
PHTimer * | _t_full_fitting |
PHTimer * | _t_output_io |
std::vector< int > | _seeding_layer |
unsigned int | _nlayers_seeding |
number of detector layers | |
unsigned int | _min_nlayers_seeding |
minimum number of layers to make a track | |
std::vector< float > | _radii |
radial distance of each layer (cm) | |
std::vector< float > | _material |
material at each layer in rad. lengths | |
std::map< int, float > | _user_material |
material in user ladder indexes | |
float | _magField |
in Tesla | |
bool | _reject_ghosts |
bool | _remove_hits |
float | _min_pt |
float | _min_z0 |
float | _max_z0 |
float | _max_r |
bool | _cut_on_dca |
float | _dcaxy_cut |
float | _dcaz_cut |
double | _chi2_cut_fast_par0 |
fit quality chisq/dof for fast fit track fitting | |
double | _chi2_cut_fast_par1 |
fit quality chisq/dof for fast fit track fitting | |
double | _chi2_cut_fast_max |
fit quality chisq/dof for fast fit track fitting | |
double | _chi2_cut_full |
fit quality chisq/dof for kalman track fitting | |
double | _ca_chi2_cut |
initial combination cut? | |
double | _cos_angle_cut |
curvature restriction on cluster combos | |
float | _bin_scale |
float | _z_bin_scale |
unsigned int | _min_combo_hits |
minimum hits to enter combination gun | |
unsigned int | _max_combo_hits |
maximum hits to enter combination gun | |
float | _pt_rescale |
std::vector< float > | _fit_error_scale |
std::vector< float > | _vote_error_scale |
std::map< int, unsigned int > | _layer_ilayer_map |
recorded layer indexes to internal sequential indexes | |
std::vector< SimpleHit3D > | _clusters |
working array of clusters | |
std::vector< SimpleTrack3D > | _tracks |
working array of tracks | |
std::vector< double > | _track_errors |
working array of track chisq | |
std::vector< Eigen::Matrix < float, 5, 5 > > | _track_covars |
working array of track covariances | |
std::vector< SimpleTrack3D > | _all_tracks |
working array of tracks | |
std::vector< double > | _all_track_errors |
working array of track chisq | |
std::vector< Eigen::Matrix < float, 5, 5 > > | _all_track_covars |
working array of track covariances | |
std::vector< std::vector< float > > | _vertex |
working array for collision vertex list | |
std::vector< std::vector< float > > | _vertex_error |
sqrt(cov) | |
std::vector< int > | _vertex_tracks |
sPHENIXSeedFinder * | _tracker |
tracks in this vertex | |
sPHENIXSeedFinder * | _tracker_vertex |
finds a subset of tracks for initial vertex-finding | |
sPHENIXSeedFinder * | _tracker_etap_seed |
finds a subset of tracks for the vertex guess | |
sPHENIXSeedFinder * | _tracker_etam_seed |
finds a subset of tracks for the vertex guess | |
VertexFinder | _vertexFinder |
vertex finding object | |
BbcVertexMap * | _bbc_vertexes |
int * | _hit_used_map |
int | _hit_used_map_size |
PHG4CylinderGeomContainer * | _geom_container_intt |
PHG4CylinderGeomContainer * | _geom_container_maps |
bool | _analyzing_mode |
TFile * | _analyzing_file |
TNtuple * | _analyzing_ntuple |
float | _max_merging_dphi |
Cleanup Seeds. | |
float | _max_merging_deta |
float | _max_merging_dr |
float | _max_merging_dz |
unsigned int | _max_share_hits |
if two seeds have common hits more than this number, merge them | |
double | _cut_min_pT |
unsigned int | _nlayers_maps |
unsigned int | _nlayers_intt |
unsigned int | _nlayers_tpc |
int | _nlayers_all |
std::map< int, unsigned int > | _layer_ilayer_map_all |
std::vector< float > | _radii_all |
Additional Inherited Members | |
Public Types inherited from Fun4AllBase | |
enum | enu_Verbosity { VERBOSITY_QUIET = 0, VERBOSITY_SOME = 1, VERBOSITY_MORE = 2, VERBOSITY_EVEN_MORE = 3, VERBOSITY_A_LOT = 4, VERBOSITY_MAX = INT_MAX - 10 } |
Protected Attributes inherited from PHTrackSeeding | |
TrkrClusterContainer * | _cluster_map = nullptr |
TrkrClusterHitAssoc * | _cluster_hit_map = nullptr |
TrkrClusterIterationMapv1 * | _iteration_map |
int | _n_iteration |
SvtxVertexMap * | _vertex_map = nullptr |
SvtxTrackMap * | _track_map = nullptr |
AssocInfoContainer * | _assoc_container = nullptr |
TrkrHitSetContainer * | _hitsets = nullptr |
std::string | _track_map_name = "SvtxTrackMap" |
bool | _use_truth_clusters = false |
A fun4all implementation of Alan's Hough Transform.
This module run Alan's Hough Transform and quick vertex finding on the SvxClusterList of the event. It will produce both SvxTrack and SvxSegments for the time being.
Definition at line 44 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 44 of file PHHoughSeeding.h
PHHoughSeeding::PHHoughSeeding | ( | const std::string & | name = "PHHoughSeeding" , |
unsigned int | nlayers_maps = 3 , |
||
unsigned int | nlayers_intt = 8 , |
||
unsigned int | nlayers_tpc = 60 , |
||
unsigned int | seeding_nlayer = 12 , |
||
unsigned int | min_seeding_nlayer = 4 |
||
) |
Definition at line 85 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 85 of file PHHoughSeeding.cc
References _analyzing_file, _analyzing_mode, _analyzing_ntuple, _event, _nlayers_all, _nlayers_intt, _nlayers_maps, _nlayers_tpc, _user_material, _vertex_error, and set_seeding_layer().
|
inlineoverride |
Definition at line 56 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 56 of file PHHoughSeeding.h
|
private |
find tracks winthin neighbor bins
Add hits from other related tracks
hits from itrack already registered
Definition at line 2266 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 2266 of file PHHoughSeeding.cc
References _event, _max_merging_deta, _max_merging_dphi, _max_merging_dr, _max_merging_dz, _max_share_hits, _tracks, SimpleTrack3D::d, SimpleTrack3D::dzdl, Fun4AllReturnCodes::EVENT_OK, SimpleHit3D::get_id(), SimpleTrack3D::hits, it, SimpleTrack3D::phi, printf(), SimpleHit3D::set_id(), and SimpleTrack3D::z0.
Referenced by full_track_seeding().
|
private |
Definition at line 1887 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1887 of file PHHoughSeeding.cc
References _event, _tracks, Fun4AllReturnCodes::EVENT_OK, SimpleHit3D::get_id(), SimpleTrack3D::hits, it, SimpleHit3D::set_id(), and Fun4AllBase::Verbosity().
|
private |
Definition at line 2078 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 2078 of file PHHoughSeeding.cc
References _event, _track_covars, _track_errors, _tracker, _tracks, Acts::UnitConstants::C, Fun4AllReturnCodes::EVENT_OK, SimpleHit3D::get_id(), HelixHough::getKalmanStates(), SimpleTrack3D::hits, it, SimpleHit3D::set_id(), and Fun4AllBase::Verbosity().
|
private |
convert the covariance from HelixHough coords to x,y,z,px,py,pz
Definition at line 1816 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1816 of file PHHoughSeeding.cc
References starlightConstants::alpha, cos(), d, and dzdl.
Referenced by export_output().
|
overrideprotectedvirtual |
Called in SubsysReco::End.
Implements PHTrackSeeding.
Definition at line 473 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 473 of file PHHoughSeeding.cc
References _analyzing_file, _analyzing_mode, _analyzing_ntuple, _t_full_fitting, _t_kalman_pat_rec, _t_output_io, _t_search_clusters, _t_seeding, _t_seeds_cleanup, _t_track_propagation, _t_translate1, _t_translate2, _t_translate3, _t_translate_to_PHGenFitTrack, _tracker, _tracker_etam_seed, _tracker_etap_seed, _tracker_vertex, Fun4AllReturnCodes::EVENT_OK, and LogDebug.
|
private |
code to translate back to the SVTX universe
Definition at line 1590 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1590 of file PHHoughSeeding.cc
References _all_track_covars, _all_track_errors, _all_tracks, PHTrackSeeding::_assoc_container, PHTrackSeeding::_cluster_map, _clusters, _magField, _track_covars, _track_errors, PHTrackSeeding::_track_map, _tracks, _vertex, PHTrackSeeding::_vertex_map, SvtxVertexMap::clear(), convertHelixCovarianceToEuclideanCovariance(), cos(), d, dzdl, Fun4AllReturnCodes::EVENT_OK, TrkrClusterContainer::findCluster(), SvtxTrackMap::get(), SvtxTrack_v1::get_id(), SvtxTrack_v1::get_px(), SvtxTrack_v1::get_py(), SvtxTrack_v1::get_pz(), SvtxTrack_v1::get_quality(), SvtxVertex_v1::get_x(), SvtxVertex_v1::get_y(), SvtxVertex_v1::get_z(), SvtxTrackMap::identify(), SvtxVertex::identify(), TrkrCluster::identify(), SvtxTrack::identify(), SvtxTrackMap::insert(), SvtxVertexMap::insert_clone(), SvtxTrack_v1::insert_cluster_key(), SvtxVertex_v1::insert_track(), kappaToPt(), M_PI, phi, PHWHERE, SvtxTrack_v1::set_charge(), SvtxVertex_v1::set_chisq(), SvtxTrack_v1::set_chisq(), SvtxTrack_v1::set_dca2d(), SvtxTrack_v1::set_dca2d_error(), SvtxVertex_v1::set_error(), SvtxTrack_v1::set_error(), SvtxTrack_v1::set_id(), SvtxTrack_v1::set_ndf(), SvtxVertex_v1::set_ndof(), SvtxVertex_v1::set_position(), SvtxTrack_v1::set_px(), SvtxTrack_v1::set_py(), SvtxTrack_v1::set_pz(), SvtxVertex_v1::set_t0(), SvtxTrack_v1::set_vertex_id(), SvtxTrack_v1::set_x(), SvtxTrack_v1::set_y(), SvtxTrack_v1::set_z(), AssocInfoContainer::SetClusterTrackAssoc(), SvtxTrackMap::size(), TrkrClusterContainer::size(), SvtxTrack_v1::size_cluster_keys(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
code to combine seed tracking vertex with BBCZ if available
|
private |
code to seed vertex from bbc
Definition at line 1196 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1196 of file PHHoughSeeding.cc
References _bbc_vertexes, _vertex, BbcVertexMap::begin(), Fun4AllReturnCodes::EVENT_OK, BbcVertex::get_z(), and Fun4AllBase::Verbosity().
|
private |
code to perform the final tracking and vertexing
Definition at line 1441 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1441 of file PHHoughSeeding.cc
References _clusters, _event, _max_combo_hits, _min_combo_hits, _min_nlayers_seeding, _t_seeds_cleanup, _track_covars, _track_errors, _tracker, _tracks, _vertex, _vertexFinder, Acts::UnitConstants::C, CleanupSeeds(), sPHENIXSeedFinder::clear(), Fun4AllReturnCodes::EVENT_OK, sPHENIXSeedFinder::finalize(), HelixHough::findHelices(), VertexFinder::findVertex(), HelixHough::getKalmanStates(), PHTimer::restart(), shift_coordinate_system(), PHTimer::stop(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
inline |
get early combination-land chi2 cut(?)
Definition at line 107 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 107 of file PHHoughSeeding.h
References _ca_chi2_cut.
|
inline |
get the tracking chi2 cut for full fit
Definition at line 96 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 96 of file PHHoughSeeding.h
References _chi2_cut_full.
|
inline |
get early curvature cut between hits, lower values are more open
Definition at line 118 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 118 of file PHHoughSeeding.h
References _cos_angle_cut.
|
inline |
Definition at line 76 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 76 of file PHHoughSeeding.h
References _magField.
|
inline |
Definition at line 272 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 272 of file PHHoughSeeding.h
References _max_merging_deta.
|
inline |
Definition at line 282 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 282 of file PHHoughSeeding.h
References _max_merging_dphi.
|
inline |
Definition at line 292 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 292 of file PHHoughSeeding.h
References _max_merging_dr.
|
inline |
Definition at line 302 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 302 of file PHHoughSeeding.h
References _max_merging_dz.
|
inline |
Definition at line 320 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 320 of file PHHoughSeeding.h
References _min_nlayers_seeding.
|
inline |
Definition at line 252 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 252 of file PHHoughSeeding.h
References _seeding_layer.
|
private |
fetch node pointers
Definition at line 1048 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1048 of file PHHoughSeeding.cc
References _bbc_vertexes, and Fun4AllReturnCodes::EVENT_OK.
Referenced by Setup().
|
private |
create new node output pointers
scan tracker geometry objects
Now have to load geometry nodes to get norm vector
Definition at line 518 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 518 of file PHHoughSeeding.cc
References _geom_container_intt, _geom_container_maps, _layer_ilayer_map, _layer_ilayer_map_all, _material, _min_nlayers_seeding, _nlayers_all, _nlayers_seeding, _radii, _radii_all, _seeding_layer, _tracker, _tracker_etap_seed, _tracker_vertex, _user_material, Fun4AllReturnCodes::EVENT_OK, PHG4CylinderCellGeomContainer::get_begin_end(), PHG4CylinderCellGeom::get_layer(), PHG4CylinderGeom::get_layer(), PHG4CylinderCellGeom::get_radius(), PHG4CylinderGeom::get_radius(), PHG4CylinderCellGeom::get_thickness(), PHG4CylinderGeom::get_thickness(), findNode::getClass(), setup_initial_tracker_object(), setup_seed_tracker_objects(), setup_tracker_object(), and Fun4AllBase::Verbosity().
Referenced by Setup().
|
private |
track propagation
|
private |
convert from inverse curvature to momentum
Definition at line 1806 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1806 of file PHHoughSeeding.cc
References _magField, and _pt_rescale.
Referenced by export_output().
|
private |
Definition at line 451 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 451 of file PHHoughSeeding.cc
References _t_full_fitting, _t_kalman_pat_rec, _t_output_io, _t_search_clusters, _t_search_clusters_encoding, _t_search_clusters_map_iter, _t_seed_init1, _t_seed_init2, _t_seed_init3, _t_seeding, _t_seeds_cleanup, _t_track_propagation, _t_translate1, _t_translate2, _t_translate3, _t_translate_to_PHGenFitTrack, and PHTimer::get_accumulated_time().
Referenced by Process().
|
overrideprotectedvirtual |
process event interface for trackers, called in process_event. implemented in derived classes
Implements PHTrackSeeding.
Definition at line 365 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 365 of file PHHoughSeeding.cc
References _all_track_covars, _all_track_errors, _all_tracks, _clusters, _event, _min_nlayers_seeding, _nlayers_intt, _nlayers_maps, _nlayers_seeding, _nlayers_tpc, _t_seed_init1, _t_seeding, _track_covars, _track_errors, _tracks, _vertex, _vertex_error, _vertex_tracks, Fun4AllReturnCodes::EVENT_OK, export_output(), full_track_seeding(), PHWHERE, print_timers(), PHTimer::restart(), PHTimer::stop(), translate_input(), Fun4AllBase::Verbosity(), and vertexing().
|
private |
convert from momentum to inverse curvature
Definition at line 1811 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1811 of file PHHoughSeeding.cc
References _magField, and _pt_rescale.
Referenced by setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
inline |
Definition at line 267 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 267 of file PHHoughSeeding.h
References _analyzing_mode.
|
inline |
set early combination-land chi2 cut(?)
Definition at line 102 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 102 of file PHHoughSeeding.h
References _ca_chi2_cut.
|
inline |
set the tracking pt-dependent chi2 cut for fast fit, cut = min(par0 + par1 / pt, max)
Definition at line 82 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 82 of file PHHoughSeeding.h
References _chi2_cut_fast_max, _chi2_cut_fast_par0, and _chi2_cut_fast_par1.
|
inline |
set the tracking chi2 cut for full fit
Definition at line 91 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 91 of file PHHoughSeeding.h
References _chi2_cut_full.
|
inline |
set the tracking chi2 for initial vertex finding
Definition at line 248 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 248 of file PHHoughSeeding.h
|
inline |
set early curvature cut between hits, lower values are more open
Definition at line 113 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 113 of file PHHoughSeeding.h
References _cos_angle_cut.
|
inline |
Definition at line 72 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 72 of file PHHoughSeeding.h
References _magField.
void PHHoughSeeding::set_material | ( | int | layer, |
float | value | ||
) |
radiation length per layer, sequential layer indexes required here
Definition at line 513 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 513 of file PHHoughSeeding.cc
References _user_material, G4TTL::layer, and value.
|
inline |
Definition at line 277 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 277 of file PHHoughSeeding.h
References _max_merging_deta.
|
inline |
Definition at line 287 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 287 of file PHHoughSeeding.h
References _max_merging_dphi.
|
inline |
Definition at line 297 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 297 of file PHHoughSeeding.h
References _max_merging_dr.
|
inline |
Definition at line 307 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 307 of file PHHoughSeeding.h
References _max_merging_dz.
|
inline |
Definition at line 325 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 325 of file PHHoughSeeding.h
References _min_combo_hits, and _min_nlayers_seeding.
Referenced by Setup().
|
inline |
Definition at line 123 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 123 of file PHHoughSeeding.h
References _min_pt.
|
inline |
set the minimum pT to try to find during initial vertex finding tracking
Definition at line 233 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 233 of file PHHoughSeeding.h
|
inline |
set the r search window
Definition at line 136 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 136 of file PHHoughSeeding.h
References _max_r.
|
inline |
Definition at line 261 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 261 of file PHHoughSeeding.h
References _seeding_layer.
Referenced by PHHoughSeeding(), and Setup().
|
inline |
set option to produce initial vertex for further tracking
Definition at line 221 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 221 of file PHHoughSeeding.h
|
inline |
set the z0 search window
Definition at line 129 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 129 of file PHHoughSeeding.h
|
inline |
adjusts the rate of zooming
Definition at line 156 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 156 of file PHHoughSeeding.h
References _bin_scale.
|
inline |
turn on DCA limitation
Definition at line 167 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 167 of file PHHoughSeeding.h
References _cut_on_dca.
|
inline |
sets an upper limit on X-Y DCA
Definition at line 172 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 172 of file PHHoughSeeding.h
References _dcaxy_cut.
|
inline |
sets an upper limit on Z DCA
Definition at line 177 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 177 of file PHHoughSeeding.h
References _dcaz_cut.
|
inline |
adjust the relative fit error scale w.r.t. the cluster size
Definition at line 204 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 204 of file PHHoughSeeding.h
References _fit_error_scale.
|
inline |
Definition at line 228 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 228 of file PHHoughSeeding.h
|
inline |
Definition at line 225 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 225 of file PHHoughSeeding.h
|
inline |
limit the maximum error reported by cluster (in number of cell units)
Definition at line 238 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 238 of file PHHoughSeeding.h
|
inline |
adjust the fit pt by a recalibration factor (constant B versus real mag field)
Definition at line 184 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 184 of file PHHoughSeeding.h
References _pt_rescale.
|
inline |
set internal ghost rejection
Definition at line 145 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 145 of file PHHoughSeeding.h
References _reject_ghosts.
|
inline |
set for internal hit rejection
Definition at line 150 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 150 of file PHHoughSeeding.h
References _remove_hits.
|
overrideprotectedvirtual |
setup interface for trackers, called in InitRun, setup things like pointers to nodes. overrided in derived classes
Initilize parameters
Reimplemented from PHTrackSeeding.
Definition at line 204 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 204 of file PHHoughSeeding.cc
References _bin_scale, _ca_chi2_cut, _chi2_cut_fast_max, _chi2_cut_fast_par0, _chi2_cut_fast_par1, _chi2_cut_full, _cos_angle_cut, _cut_on_dca, _dcaxy_cut, _dcaz_cut, _fit_error_scale, _magField, _material, _min_nlayers_seeding, _min_pt, _nlayers_intt, _nlayers_maps, _nlayers_seeding, _pt_rescale, _radii, _reject_ghosts, _remove_hits, _t_full_fitting, _t_kalman_pat_rec, _t_output_io, _t_search_clusters, _t_search_clusters_encoding, _t_search_clusters_map_iter, _t_seed_init1, _t_seed_init2, _t_seed_init3, _t_seeding, _t_seeds_cleanup, _t_track_propagation, _t_translate1, _t_translate2, _t_translate3, _t_translate_to_PHGenFitTrack, _vote_error_scale, _z_bin_scale, Fun4AllReturnCodes::EVENT_OK, GetNodes(), InitializeGeometry(), set_min_nlayers_seeding(), set_seeding_layer(), PHTrackSeeding::Setup(), PHTimer::stop(), and Fun4AllBase::Verbosity().
|
private |
code to setup initial vertexing tracker
Definition at line 885 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 885 of file PHHoughSeeding.cc
References _bin_scale, _ca_chi2_cut, _chi2_cut_fast_max, _chi2_cut_fast_par0, _chi2_cut_fast_par1, _chi2_cut_full, _cos_angle_cut, _fit_error_scale, _magField, _material, _min_nlayers_seeding, _min_pt, _nlayers_seeding, _radii, _reject_ghosts, _remove_hits, _tracker_vertex, _vote_error_scale, _z_bin_scale, Fun4AllReturnCodes::EVENT_OK, M_PI, ptToKappa(), sPHENIXSeedFinder::requireLayers(), sPHENIXSeedFinder::setBinScale(), sPHENIXSeedFinder::setCellularAutomatonChi2Cut(), sPHENIXSeedFinder::setChi2Cut(), sPHENIXSeedFinder::setChi2RemovalCut(), HelixHough::setClusterStartBin(), sPHENIXSeedFinder::setCosAngleCut(), sPHENIXSeedFinder::setCutOnDca(), sPHENIXSeedFinder::setFastChi2Cut(), sPHENIXSeedFinder::setHitErrorScale(), sPHENIXSeedFinder::setMaxHitsPairs(), sPHENIXSeedFinder::setNLayers(), HelixHough::setPrintTimings(), sPHENIXSeedFinder::setRejectGhosts(), sPHENIXSeedFinder::setRemoveHits(), sPHENIXSeedFinder::setSeparateByHelicity(), HelixHough::setSmoothBack(), and sPHENIXSeedFinder::setZBinScale().
Referenced by InitializeGeometry().
|
private |
code to setup seed tracking objects
Definition at line 772 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 772 of file PHHoughSeeding.cc
References _bin_scale, _ca_chi2_cut, _chi2_cut_fast_max, _chi2_cut_fast_par0, _chi2_cut_fast_par1, _chi2_cut_full, _cos_angle_cut, _fit_error_scale, _magField, _material, _max_r, _max_z0, _min_nlayers_seeding, _min_pt, _min_z0, _nlayers_seeding, _radii, _reject_ghosts, _remove_hits, _tracker_etam_seed, _tracker_etap_seed, _vote_error_scale, _z_bin_scale, Fun4AllReturnCodes::EVENT_OK, M_PI, ptToKappa(), sPHENIXSeedFinder::requireLayers(), sPHENIXSeedFinder::setBinScale(), sPHENIXSeedFinder::setCellularAutomatonChi2Cut(), sPHENIXSeedFinder::setChi2Cut(), sPHENIXSeedFinder::setChi2RemovalCut(), HelixHough::setClusterStartBin(), sPHENIXSeedFinder::setCosAngleCut(), sPHENIXSeedFinder::setCutOnDca(), sPHENIXSeedFinder::setFastChi2Cut(), sPHENIXSeedFinder::setHitErrorScale(), sPHENIXSeedFinder::setMaxHitsPairs(), sPHENIXSeedFinder::setNLayers(), HelixHough::setPrintTimings(), sPHENIXSeedFinder::setRejectGhosts(), sPHENIXSeedFinder::setRemoveHits(), sPHENIXSeedFinder::setSeparateByHelicity(), HelixHough::setSmoothBack(), and sPHENIXSeedFinder::setZBinScale().
Referenced by InitializeGeometry().
|
private |
code to setup full tracking object
Definition at line 967 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 967 of file PHHoughSeeding.cc
References _bin_scale, _ca_chi2_cut, _chi2_cut_fast_max, _chi2_cut_fast_par0, _chi2_cut_fast_par1, _chi2_cut_full, _cos_angle_cut, _cut_on_dca, _dcaxy_cut, _dcaz_cut, _fit_error_scale, _magField, _material, _min_nlayers_seeding, _min_pt, _nlayers_seeding, _radii, _reject_ghosts, _remove_hits, _tracker, _vote_error_scale, _z_bin_scale, Fun4AllReturnCodes::EVENT_OK, M_PI, ptToKappa(), sPHENIXSeedFinder::requireLayers(), sPHENIXSeedFinder::setBinScale(), sPHENIXSeedFinder::setCellularAutomatonChi2Cut(), sPHENIXSeedFinder::setChi2Cut(), sPHENIXSeedFinder::setChi2RemovalCut(), HelixHough::setClusterStartBin(), sPHENIXSeedFinder::setCosAngleCut(), sPHENIXSeedFinder::setCutOnDca(), sPHENIXSeedFinder::setDcaCut(), sPHENIXSeedFinder::setFastChi2Cut(), sPHENIXSeedFinder::setHitErrorScale(), sPHENIXSeedFinder::setMaxHitsPairs(), sPHENIXSeedFinder::setNLayers(), HelixHough::setPrintTimings(), sPHENIXSeedFinder::setRejectGhosts(), sPHENIXSeedFinder::setRemoveHits(), sPHENIXSeedFinder::setSeparateByHelicity(), HelixHough::setSmoothBack(), sPHENIXSeedFinder::setVerbosity(), sPHENIXSeedFinder::setZBinScale(), and Fun4AllBase::Verbosity().
Referenced by InitializeGeometry().
|
inline |
use the cell size as cluster size instead of value stored on cluster
Definition at line 243 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 243 of file PHHoughSeeding.h
|
inline |
adjust the relative voting error scale w.r.t. the cluster size
Definition at line 190 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 190 of file PHHoughSeeding.h
References _vote_error_scale.
|
inline |
adjusts the rate of zooming
Definition at line 161 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 161 of file PHHoughSeeding.h
References _z_bin_scale.
|
private |
translate the clusters, tracks, and vertex from one origin to another
Definition at line 1857 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1857 of file PHHoughSeeding.cc
References _clusters, _tracks, _vertex, dx, dy, and dz.
Referenced by full_track_seeding().
|
private |
fetch node pointers
code to translate into the HelixHough universe
Definition at line 1077 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1077 of file PHHoughSeeding.cc
References PHTrackSeeding::_cluster_map, _clusters, PHTrackSeeding::_hitsets, _layer_ilayer_map, _nlayers_seeding, Fun4AllReturnCodes::EVENT_OK, TrkrCluster::getClusKey(), TrkrClusterContainer::getClusters(), TrkrCluster::getError(), TrkrHitSetContainer::getHitSets(), TrkrDefs::getLayer(), TrkrCluster::getPosition(), it, G4TTL::layer, SimpleHit3D::set_cluskey(), SimpleHit3D::set_error(), SimpleHit3D::set_id(), SimpleHit3D::set_layer(), SimpleHit3D::set_size(), SimpleHit3D::set_x(), SimpleHit3D::set_y(), SimpleHit3D::set_z(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
code to seed vertex from initial tracking using a broad search window
code to produce an initial track vertex from the seed SvtxVtxMap[0] -> _vertex and _vertex_error
Definition at line 1400 of file PHHoughSeeding.cc.
View newest version in sPHENIX GitHub at line 1400 of file PHHoughSeeding.cc
References _vertex, _vertex_error, PHTrackSeeding::_vertex_map, _vertex_tracks, Fun4AllReturnCodes::EVENT_OK, SvtxVertexMap::get(), SvtxVertex::get_error(), SvtxVertex::get_x(), SvtxVertex::get_y(), SvtxVertex::get_z(), PHWHERE, SvtxVertexMap::size(), SvtxVertex::size_tracks(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
working array of track covariances
Definition at line 486 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 486 of file PHHoughSeeding.h
Referenced by export_output(), and Process().
|
private |
working array of track chisq
Definition at line 485 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 485 of file PHHoughSeeding.h
Referenced by export_output(), and Process().
|
private |
working array of tracks
Definition at line 484 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 484 of file PHHoughSeeding.h
Referenced by export_output(), and Process().
|
private |
Definition at line 514 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 514 of file PHHoughSeeding.h
Referenced by End(), and PHHoughSeeding().
|
private |
Definition at line 513 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 513 of file PHHoughSeeding.h
Referenced by End(), PHHoughSeeding(), and set_analyzing_mode().
|
private |
Definition at line 515 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 515 of file PHHoughSeeding.h
Referenced by End(), and PHHoughSeeding().
|
private |
Definition at line 500 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 500 of file PHHoughSeeding.h
Referenced by fast_vertex_from_bbc(), and GetNodes().
|
private |
Definition at line 464 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 464 of file PHHoughSeeding.h
Referenced by setBinScale(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
initial combination cut?
Definition at line 461 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 461 of file PHHoughSeeding.h
Referenced by get_ca_chi2_cut(), set_ca_chi2_cut(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
fit quality chisq/dof for fast fit track fitting
Definition at line 459 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 459 of file PHHoughSeeding.h
Referenced by set_chi2_cut_fast(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
fit quality chisq/dof for fast fit track fitting
Definition at line 457 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 457 of file PHHoughSeeding.h
Referenced by set_chi2_cut_fast(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
fit quality chisq/dof for fast fit track fitting
Definition at line 458 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 458 of file PHHoughSeeding.h
Referenced by set_chi2_cut_fast(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
fit quality chisq/dof for kalman track fitting
Definition at line 460 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 460 of file PHHoughSeeding.h
Referenced by get_chi2_cut_full(), set_chi2_cut_full(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
working array of clusters
Definition at line 478 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 478 of file PHHoughSeeding.h
Referenced by export_output(), full_track_seeding(), Process(), shift_coordinate_system(), and translate_input().
|
private |
curvature restriction on cluster combos
Definition at line 462 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 462 of file PHHoughSeeding.h
Referenced by get_cos_angle_cut(), set_cos_angle_cut(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 526 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 526 of file PHHoughSeeding.h
|
private |
Definition at line 453 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 453 of file PHHoughSeeding.h
Referenced by setCutOnDCA(), Setup(), and setup_tracker_object().
|
private |
Definition at line 454 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 454 of file PHHoughSeeding.h
Referenced by setDCACut(), Setup(), and setup_tracker_object().
|
private |
Definition at line 455 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 455 of file PHHoughSeeding.h
Referenced by setDCAZCut(), Setup(), and setup_tracker_object().
|
private |
Definition at line 417 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 417 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), CleanupSeedsByHitPattern(), CleanupTracksByHitPattern(), full_track_seeding(), PHHoughSeeding(), and Process().
|
private |
Definition at line 471 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 471 of file PHHoughSeeding.h
Referenced by setFitErrorScale(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 510 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 510 of file PHHoughSeeding.h
Referenced by InitializeGeometry().
|
private |
Definition at line 511 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 511 of file PHHoughSeeding.h
Referenced by InitializeGeometry().
|
private |
Definition at line 507 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 507 of file PHHoughSeeding.h
|
private |
Definition at line 508 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 508 of file PHHoughSeeding.h
|
private |
recorded layer indexes to internal sequential indexes
Definition at line 475 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 475 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), and translate_input().
|
private |
Definition at line 534 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 534 of file PHHoughSeeding.h
Referenced by InitializeGeometry().
|
private |
in Tesla
Definition at line 443 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 443 of file PHHoughSeeding.h
Referenced by export_output(), get_mag_field(), kappaToPt(), ptToKappa(), set_mag_field(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
material at each layer in rad. lengths
Definition at line 440 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 440 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
maximum hits to enter combination gun
Definition at line 468 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 468 of file PHHoughSeeding.h
Referenced by full_track_seeding().
|
private |
Definition at line 519 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 519 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), get_max_merging_deta(), and set_max_merging_deta().
|
private |
Cleanup Seeds.
Definition at line 518 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 518 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), get_max_merging_dphi(), and set_max_merging_dphi().
|
private |
Definition at line 520 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 520 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), get_max_merging_dr(), and set_max_merging_dr().
|
private |
Definition at line 521 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 521 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), get_max_merging_dz(), and set_max_merging_dz().
|
private |
Definition at line 451 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 451 of file PHHoughSeeding.h
Referenced by set_r_max(), and setup_seed_tracker_objects().
|
private |
if two seeds have common hits more than this number, merge them
Definition at line 524 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 524 of file PHHoughSeeding.h
Referenced by CleanupSeeds().
|
private |
Definition at line 450 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 450 of file PHHoughSeeding.h
Referenced by set_z0_range(), and setup_seed_tracker_objects().
|
private |
minimum hits to enter combination gun
Definition at line 467 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 467 of file PHHoughSeeding.h
Referenced by full_track_seeding(), and set_min_nlayers_seeding().
|
private |
minimum number of layers to make a track
Definition at line 438 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 438 of file PHHoughSeeding.h
Referenced by full_track_seeding(), get_min_nlayers_seeding(), InitializeGeometry(), Process(), set_min_nlayers_seeding(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 448 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 448 of file PHHoughSeeding.h
Referenced by set_min_pT(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 449 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 449 of file PHHoughSeeding.h
Referenced by set_z0_range(), and setup_seed_tracker_objects().
|
private |
Definition at line 532 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 532 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), and PHHoughSeeding().
|
private |
Definition at line 529 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 529 of file PHHoughSeeding.h
Referenced by PHHoughSeeding(), Process(), and Setup().
|
private |
Definition at line 528 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 528 of file PHHoughSeeding.h
Referenced by PHHoughSeeding(), Process(), and Setup().
|
private |
number of detector layers
Definition at line 437 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 437 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), Process(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), setup_tracker_object(), and translate_input().
|
private |
Definition at line 530 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 530 of file PHHoughSeeding.h
Referenced by PHHoughSeeding(), and Process().
|
private |
Definition at line 470 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 470 of file PHHoughSeeding.h
Referenced by kappaToPt(), ptToKappa(), setPtRescaleFactor(), and Setup().
|
private |
radial distance of each layer (cm)
Definition at line 439 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 439 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 535 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 535 of file PHHoughSeeding.h
Referenced by InitializeGeometry().
|
private |
Definition at line 445 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 445 of file PHHoughSeeding.h
Referenced by setRejectGhosts(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 446 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 446 of file PHHoughSeeding.h
Referenced by setRemoveHits(), Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), and setup_tracker_object().
|
private |
Definition at line 435 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 435 of file PHHoughSeeding.h
Referenced by get_seeding_layer(), InitializeGeometry(), and set_seeding_layer().
|
private |
Definition at line 432 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 432 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 427 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 427 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 433 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 433 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 428 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 428 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 429 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 429 of file PHHoughSeeding.h
Referenced by print_timers(), and Setup().
|
private |
Definition at line 430 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 430 of file PHHoughSeeding.h
Referenced by print_timers(), and Setup().
|
private |
Definition at line 419 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 419 of file PHHoughSeeding.h
Referenced by print_timers(), Process(), and Setup().
|
private |
Definition at line 420 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 420 of file PHHoughSeeding.h
Referenced by print_timers(), and Setup().
|
private |
Definition at line 421 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 421 of file PHHoughSeeding.h
Referenced by print_timers(), and Setup().
|
private |
Definition at line 418 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 418 of file PHHoughSeeding.h
Referenced by End(), print_timers(), Process(), and Setup().
|
private |
Definition at line 422 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 422 of file PHHoughSeeding.h
Referenced by End(), full_track_seeding(), print_timers(), and Setup().
|
private |
Definition at line 431 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 431 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 424 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 424 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 425 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 425 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 426 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 426 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
Definition at line 423 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 423 of file PHHoughSeeding.h
Referenced by End(), print_timers(), and Setup().
|
private |
working array of track covariances
Definition at line 482 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 482 of file PHHoughSeeding.h
Referenced by CleanupTracksByHitPattern(), export_output(), full_track_seeding(), and Process().
|
private |
working array of track chisq
Definition at line 481 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 481 of file PHHoughSeeding.h
Referenced by CleanupTracksByHitPattern(), export_output(), full_track_seeding(), and Process().
|
private |
tracks in this vertex
finds full tracks
Definition at line 493 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 493 of file PHHoughSeeding.h
Referenced by CleanupTracksByHitPattern(), End(), full_track_seeding(), InitializeGeometry(), and setup_tracker_object().
|
private |
finds a subset of tracks for the vertex guess
Definition at line 496 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 496 of file PHHoughSeeding.h
Referenced by End(), and setup_seed_tracker_objects().
|
private |
finds a subset of tracks for the vertex guess
Definition at line 495 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 495 of file PHHoughSeeding.h
Referenced by End(), InitializeGeometry(), and setup_seed_tracker_objects().
|
private |
finds a subset of tracks for initial vertex-finding
Definition at line 494 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 494 of file PHHoughSeeding.h
Referenced by End(), InitializeGeometry(), and setup_initial_tracker_object().
|
private |
working array of tracks
Definition at line 480 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 480 of file PHHoughSeeding.h
Referenced by CleanupSeeds(), CleanupSeedsByHitPattern(), CleanupTracksByHitPattern(), export_output(), full_track_seeding(), Process(), and shift_coordinate_system().
|
private |
material in user ladder indexes
Definition at line 441 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 441 of file PHHoughSeeding.h
Referenced by InitializeGeometry(), PHHoughSeeding(), and set_material().
|
private |
working array for collision vertex list
Definition at line 488 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 488 of file PHHoughSeeding.h
Referenced by export_output(), fast_vertex_from_bbc(), full_track_seeding(), Process(), shift_coordinate_system(), and vertexing().
|
private |
sqrt(cov)
Definition at line 489 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 489 of file PHHoughSeeding.h
Referenced by PHHoughSeeding(), Process(), and vertexing().
|
private |
Definition at line 490 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 490 of file PHHoughSeeding.h
Referenced by Process(), and vertexing().
|
private |
vertex finding object
Definition at line 497 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 497 of file PHHoughSeeding.h
Referenced by full_track_seeding().
|
private |
Definition at line 472 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 472 of file PHHoughSeeding.h
Referenced by Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), setup_tracker_object(), and setVoteErrorScale().
|
private |
Definition at line 465 of file PHHoughSeeding.h.
View newest version in sPHENIX GitHub at line 465 of file PHHoughSeeding.h
Referenced by Setup(), setup_initial_tracker_object(), setup_seed_tracker_objects(), setup_tracker_object(), and setZBinScale().