ECCE @ EIC Software
Reference for
ECCE @ EIC
simulation and reconstruction software on GitHub
|
#include <coresoftware/blob/master/offline/packages/trackreco/PHInitZVertexing.h>
Public Member Functions | |
PHInitZVertexing (unsigned int nlayers=7, unsigned int min_nlayers=7, const std::string &name="PHInitZVertexing") | |
~PHInitZVertexing () override | |
void | set_file_name (const std::string &fname) |
void | set_mag_field (float mag_field) |
float | get_mag_field () const |
void | set_min_pT (float pt) |
void | set_max_kappa (float kappa_max) |
void | set_min_d (float d_min) |
void | set_max_d (float d_max) |
void | set_min_dzdl (float dzdl_min) |
void | set_max_dzdl (float dzdl_max) |
void | set_min_z0 (float z0_min) |
void | set_max_z0 (float z0_max) |
float | get_max_kappa () const |
float | get_min_z0 () const |
float | get_max_z0 () const |
void | set_material (int layer, float value) |
radiation length per layer, sequential layer indexes required here | |
void | setCutOnDCA (bool cod) |
turn on DCA limitation | |
void | set_dcaxy_cut (float dcut) |
sets an upper limit on X-Y DCA | |
void | set_dcaz_cut (float dzcut) |
sets an upper limit on Z DCA | |
void | set_chi2_cut (float chi2_cut) |
sets a chi2 cut | |
void | set_ca_z_cut (float z_cut) |
void | setPtRescaleFactor (float pt_rescale) |
void | set_ca_phi_cut (float phi_cut) |
void | set_mult_onebin (float mult) |
void | set_mult_twobins (float mult) |
void | set_mult_threebins (float mult) |
void | set_min_zvtx_tracks (unsigned int min_zvtx_tracks) |
const std::vector< int > & | get_seeding_layer () const |
void | set_seeding_layer (const int *seedingLayer, const int n) |
void | add_zoom (unsigned int n_kappa, unsigned int n_phi, unsigned int n_d, unsigned int n_dzdl, unsigned int n_z0) |
void | set_nzooms () |
void | reset_zooms () |
Public Member Functions inherited from PHInitVertexing | |
PHInitVertexing (const std::string &name="PHInitVertexing") | |
~PHInitVertexing () override | |
int | InitRun (PHCompositeNode *topNode) override |
int | process_event (PHCompositeNode *topNode) override |
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 (PHCompositeNode *) override |
Called at the end of all processing. | |
Private Member Functions | |
int | create_nodes (PHCompositeNode *topNode) |
int | initialize_geometry (PHCompositeNode *topNode) |
int | get_nodes (PHCompositeNode *topNode) |
int | translate_input (PHCompositeNode *topNode) |
void | set_nbins (unsigned int izoom) |
void | initialize_houghbin () |
void | vote_z_init (unsigned int zoomlevel) |
void | find_track_candidates_z_init (unsigned int zoomlevel) |
void | vote_z (unsigned int zoomlevel) |
void | find_track_candidates_z (unsigned int zoomlevel) |
void | vote_xy (unsigned int zoomlevel) |
void | find_track_candidates_xy (unsigned int zoomlevel) |
void | prune_z (unsigned int zoomlevel) |
void | prune_xy (unsigned int zoomlevel) |
void | reset_hits_used () |
int | export_output () |
float | kappa_to_pt (float kappa) |
convert from inverse curvature to momentum | |
float | pt_to_kappa (float pt) |
convert from momentum to inverse curvature | |
void | bins_to_SimpleTrack3D (std::vector< SimpleTrack3D > &temp_tracks, int imap, unsigned int zoomlevel) |
int | build_triplets_to_SimpleTrack3D (std::vector< SimpleTrack3D > &new_tracks, bool forward) |
int | cellular_automaton_zvtx_init (std::vector< SimpleTrack3D > &temp_tracks) |
int | fit_vertex () |
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) |
float | shift_phi_range (float phi) |
Private Attributes | |
int | _event |
PHTimer * | _t_output_io |
std::vector< int > | _seeding_layer |
unsigned int | _nlayers |
number of detector layers | |
unsigned int | _min_nlayers |
minimum number of layers to make a track | |
unsigned int | _ca_nlayers |
float | _ca_chi2 |
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 | _mag_field |
in Tesla | |
bool | _use_max_kappa |
bool | fill_multi_zvtx |
float | _min_pt |
float | _max_kappa |
float | _min_d |
float | _max_d |
float | _min_dzdl |
float | _max_dzdl |
float | _min_z0 |
float | _max_z0 |
bool | _cut_on_dca |
float | _dcaxy_cut |
float | _dcaz_cut |
float | _pt_rescale |
float | _ca_phi_cut |
float | _ca_z_cut |
float | _z_cut |
float | _mult_onebin |
float | _mult_twobins |
float | _mult_threebins |
unsigned int | _min_zvtx_tracks |
bool | _override_min_zvtx_tracks |
unsigned int | bin |
unsigned int | ik |
unsigned int | ip |
unsigned int | id |
unsigned int | il |
unsigned int | iz |
unsigned int | nkappa |
unsigned int | nphi |
unsigned int | nd |
unsigned int | ndzdl |
unsigned int | nz0 |
TrkrDefs::cluskey | cluster_key |
std::map< int, unsigned int > | _layer_ilayer_map |
recorded layer indexes to internal sequential indexes | |
std::vector< SimpleTrack3D > | _temp_tracks |
std::vector< SimpleTrack3D > | _tracks |
working array of tracks | |
std::vector< HelixKalmanState > | _track_states |
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< float > | _vertex |
working array for collision vertex | |
std::vector< std::vector< float > > | _vertex_list |
BbcVertexMap * | _bbc_vertexes |
SvtxTrackMap * | _trackmap |
VertexFitter | _vertex_finder |
HelixHoughSpace * | _hough_space |
HelixHoughFuncs * | _hough_funcs |
TNtuple * | _ntp_zvtx_by_event |
TNtuple * | _ntp_zvtx_by_track |
TH2D * | _z0_dzdl |
TH2D * | _kappa_phi |
TH2D * | _d_phi |
TH3D * | _kappa_d_phi |
TFile * | _ofile |
TFile * | _ofile2 |
std::string | _fname |
int | _nlayers_all |
int | _nclus_mvtx |
std::map< int, unsigned int > | _layer_ilayer_map_all |
std::vector< float > | _radii_all |
std::vector< std::vector < unsigned int > > | zooms_vec |
std::map< unsigned int, bool > | hits_used |
std::map< unsigned int, SimpleHit3D > | hits_map |
std::map< unsigned int, HelixHoughBin * > | bins_map |
std::map< unsigned int, HelixHoughBin * > | bins_map_prev |
std::map< unsigned int, HelixHoughBin * > | bins_map_cur |
std::map< unsigned int, HelixHoughBin * > | bins_map_sel |
std::map< unsigned int, unsigned int > | kappa_phi_map |
std::map< unsigned int, unsigned int > | d_phi_map |
std::map< unsigned int, unsigned int > | kappa_d_phi_map |
float | hit [50][3] |
float | hitpos3d [3] |
unsigned int | nzooms |
bool | separate_helicity |
int | helicity |
int | n_vtx_tracks |
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 PHInitVertexing | |
TrkrClusterContainer * | _cluster_map |
TrkrHitSetContainer * | _hitsets |
SvtxVertexMap * | _vertex_map |
Definition at line 41 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 41 of file PHInitZVertexing.h
PHInitZVertexing::PHInitZVertexing | ( | unsigned int | nlayers = 7 , |
unsigned int | min_nlayers = 7 , |
||
const std::string & | name = "PHInitZVertexing" |
||
) |
Definition at line 72 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 72 of file PHInitZVertexing.cc
|
override |
Definition at line 168 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 168 of file PHInitZVertexing.cc
References _hough_funcs, _hough_space, and _t_output_io.
void PHInitZVertexing::add_zoom | ( | unsigned int | n_kappa, |
unsigned int | n_phi, | ||
unsigned int | n_d, | ||
unsigned int | n_dzdl, | ||
unsigned int | n_z0 | ||
) |
Definition at line 525 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 525 of file PHInitZVertexing.cc
References zooms_vec.
Referenced by Process().
|
private |
Definition at line 1808 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1808 of file PHInitZVertexing.cc
References _tracks, HelixHoughBin::begin_clusters(), bins_map_prev, bins_map_sel, SimpleTrack3D::d, SimpleTrack3D::dzdl, HelixHoughBin::end_clusters(), HelixHoughBin::get_count(), HelixHoughBin::get_dzdl_center(), HelixHoughBin::get_kappa_center(), HelixHoughBin::get_phi_center(), HelixHoughBin::get_z0_center(), hit, SimpleTrack3D::hits, hits_map, it, SimpleTrack3D::kappa, SimpleTrack3D::phi, track, and SimpleTrack3D::z0.
Referenced by Process().
|
private |
Definition at line 1870 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1870 of file PHInitZVertexing.cc
References _ca_phi_cut, _nlayers, _z_cut, SimpleHit3D::get_id(), SimpleHit3D::get_layer(), SimpleHit3D::get_x(), SimpleHit3D::get_y(), SimpleHit3D::get_z(), hit, SimpleTrack3D::hits, hits_map, hits_used, it, G4TTL::layer, M_PI, shift_phi_range(), track, and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
Definition at line 1992 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1992 of file PHInitZVertexing.cc
References _ca_chi2, _ca_nlayers, _ca_phi_cut, _ca_z_cut, _dcaxy_cut, _hough_space, _mag_field, _material, _pt_rescale, _radii, _track_states, _tracks, Fun4AllReturnCodes::EVENT_OK, hits_map, hits_used, CellularAutomaton_v1::Reset(), CellularAutomaton_v1::run(), CellularAutomaton_v1::set_ca_chi2(), CellularAutomaton_v1::set_ca_chi2_layer(), CellularAutomaton_v1::set_ca_dcaxy_cut(), CellularAutomaton_v1::set_ca_phi_cut(), CellularAutomaton_v1::set_ca_z_cut(), CellularAutomaton_v1::set_hits_map(), CellularAutomaton_v1::set_hough_space(), CellularAutomaton_v1::set_mag_field(), CellularAutomaton_v1::set_n_layers(), CellularAutomaton_v1::set_propagate_forward(), CellularAutomaton_v1::set_pt_rescale(), CellularAutomaton_v1::set_remove_hits(), CellularAutomaton_v1::set_remove_inner_hits(), CellularAutomaton_v1::set_required_layers(), CellularAutomaton_v1::set_seeding_mode(), CellularAutomaton_v1::set_triplet_mode(), CellularAutomaton_v1::set_verbose(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
convert the covariance from HelixHough coords to x,y,z,px,py,pz
Definition at line 2335 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 2335 of file PHInitZVertexing.cc
|
private |
Definition at line 531 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 531 of file PHInitZVertexing.cc
References _trackmap, Fun4AllReturnCodes::ABORTEVENT, PHCompositeNode::addNode(), Fun4AllReturnCodes::EVENT_OK, PHNodeIterator::findFirst(), PHWHERE, and Fun4AllBase::Verbosity().
Referenced by Setup().
|
overrideprotectedvirtual |
Called at the end of all processing.
Reimplemented from SubsysReco.
Definition at line 494 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 494 of file PHInitZVertexing.cc
References _d_phi, _fname, _kappa_d_phi, _kappa_phi, _ntp_zvtx_by_event, _ntp_zvtx_by_track, _ofile, _ofile2, _temp_tracks, _z0_dzdl, Fun4AllReturnCodes::EVENT_OK, fill_multi_zvtx, PHWHERE, and Fun4AllBase::Verbosity().
|
private |
Definition at line 824 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 824 of file PHInitZVertexing.cc
References PHInitVertexing::_cluster_map, _mag_field, _track_covars, _track_errors, _trackmap, _tracks, _vertex, _vertex_list, PHInitVertexing::_vertex_map, SvtxVertexMap::clear(), SvtxTrackMap::clear(), col, d, dzdl, Fun4AllReturnCodes::EVENT_OK, SvtxTrack_v1::get_id(), SvtxTrack_v1::get_px(), SvtxTrack_v1::get_py(), SvtxTrack_v1::get_pz(), SvtxTrack_v1::get_quality(), helicity, hits_map, SvtxVertex::identify(), SvtxTrackMap::insert(), SvtxVertexMap::insert_clone(), SvtxTrack_v1::insert_cluster_key(), kappa_to_pt(), G4TTL::layer, M_PI, phi, PHWHERE, ds::pT, SvtxTrack_v1::set_charge(), SvtxVertex_v1::set_chisq(), SvtxTrack_v1::set_dca2d(), SvtxVertex_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_x(), SvtxTrack_v1::set_y(), SvtxTrack_v1::set_z(), TrkrClusterContainer::size(), track, Fun4AllBase::Verbosity(), and G4InuclParticleNames::z0.
Referenced by Process().
Definition at line 1648 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1648 of file PHInitZVertexing.cc
References _min_nlayers, bin, bins_map_cur, bins_map_prev, HelixHoughBin::get_count(), HelixHoughBin::get_d_bin(), HelixHoughBin::get_dzdl_bin(), HelixHoughBin::get_kappa_bin(), HelixHoughBin::get_phi_bin(), HelixHoughBin::get_z0_bin(), ik, il, ip, it, iz, and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1322 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1322 of file PHInitZVertexing.cc
References _min_nlayers, bin, bins_map_cur, bins_map_sel, HelixHoughBin::get_count(), HelixHoughBin::get_dzdl_bin(), HelixHoughBin::get_z0_bin(), il, it, iz, and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1133 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1133 of file PHInitZVertexing.cc
References _hough_space, _min_nlayers, _z0_dzdl, bin, bins_map, bins_map_sel, HelixHoughSpace::get_bin(), HelixHoughSpace::get_n_dzdl_bins(), HelixHoughSpace::get_n_z0_bins(), k, and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
< working array of track chisq
< working array of track covariances
Definition at line 2079 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 2079 of file PHInitZVertexing.cc
References _dcaz_cut, _event, _max_z0, _min_z0, _min_zvtx_tracks, _mult_onebin, _mult_twobins, _ntp_zvtx_by_event, _ntp_zvtx_by_track, _track_covars, _track_errors, _track_states, _tracks, _vertex, _vertex_finder, _vertex_list, C(), Fun4AllReturnCodes::EVENT_OK, fill_multi_zvtx, VertexFitter::findVertex(), iz, k, n_vtx_tracks, SimpleTrack3D::set_vertex_id(), Fun4AllBase::Verbosity(), and G4InuclParticleNames::z0.
Referenced by Process().
|
inline |
Definition at line 53 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 53 of file PHInitZVertexing.h
References _mag_field.
|
inline |
Definition at line 68 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 68 of file PHInitZVertexing.h
References _max_kappa.
|
inline |
Definition at line 70 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 70 of file PHInitZVertexing.h
References _max_z0.
|
inline |
Definition at line 69 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 69 of file PHInitZVertexing.h
References _min_z0.
|
private |
|
inline |
Definition at line 125 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 125 of file PHInitZVertexing.h
References _seeding_layer.
|
private |
Definition at line 557 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 557 of file PHInitZVertexing.cc
References _layer_ilayer_map, _layer_ilayer_map_all, _material, _nlayers, _nlayers_all, _radii, _radii_all, _seeding_layer, _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(), PHG4CylinderCellGeom::identify(), PHG4CylinderGeom::identify(), and Fun4AllBase::Verbosity().
Referenced by Setup().
|
private |
Definition at line 1010 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1010 of file PHInitZVertexing.cc
References _hough_space, bin, bins_map, HelixHoughSpace::get_bin(), id, HelixHoughBin::identify(), ik, il, HelixHoughBin::init(), ip, iz, nd, ndzdl, nkappa, nphi, nz0, HelixHoughBin::set_hough_space(), HelixHoughBin::set_zoomlevel(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
convert from inverse curvature to momentum
Definition at line 989 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 989 of file PHInitZVertexing.cc
References _mag_field, and _pt_rescale.
Referenced by export_output().
|
overrideprotectedvirtual |
process event interface for trackers, called in process_event. implemented in derived classes
Implements PHInitVertexing.
Definition at line 289 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 289 of file PHInitZVertexing.cc
References _ca_chi2, _ca_nlayers, _event, _temp_tracks, _track_covars, _track_errors, _track_states, _tracks, _vertex, _vertex_list, add_zoom(), bins_map, bins_map_cur, bins_map_prev, bins_map_sel, bins_to_SimpleTrack3D(), build_triplets_to_SimpleTrack3D(), cellular_automaton_zvtx_init(), Fun4AllReturnCodes::EVENT_OK, g4zmq::exit(), export_output(), find_track_candidates_xy(), find_track_candidates_z(), find_track_candidates_z_init(), fit_vertex(), helicity, hits_map, hits_used, initialize_houghbin(), nd, ndzdl, nkappa, nphi, nz0, prune_xy(), prune_z(), reset_hits_used(), reset_zooms(), separate_helicity, set_nbins(), shift_coordinate_system(), translate_input(), Fun4AllBase::Verbosity(), vote_xy(), vote_z(), and vote_z_init().
Definition at line 1744 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1744 of file PHInitZVertexing.cc
References _nlayers, HelixHoughBin::add_cluster_ID(), bins_map_prev, HelixHoughBin::get_count(), HelixHoughBin::get_d_bin(), HelixHoughBin::get_dzdl_bin(), HelixHoughBin::get_global_bin(), HelixHoughBin::get_kappa_bin(), HelixHoughBin::get_neighbors_global_bin(), HelixHoughBin::get_phi_bin(), HelixHoughBin::get_z0_bin(), it, set_nbins(), sign(), and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1691 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1691 of file PHInitZVertexing.cc
References _nlayers, HelixHoughBin::add_cluster_ID(), bins_map_sel, HelixHoughBin::get_count(), HelixHoughBin::get_d_bin(), HelixHoughBin::get_dzdl_bin(), HelixHoughBin::get_global_bin(), HelixHoughBin::get_kappa_bin(), HelixHoughBin::get_neighbors_global_bin(), HelixHoughBin::get_phi_bin(), HelixHoughBin::get_z0_bin(), it, set_nbins(), sign(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
convert from momentum to inverse curvature
Definition at line 993 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 993 of file PHInitZVertexing.cc
References _mag_field, _pt_rescale, and pt.
Referenced by Setup().
|
private |
Definition at line 1800 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1800 of file PHInitZVertexing.cc
Referenced by Process().
|
inline |
Definition at line 136 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 136 of file PHInitZVertexing.h
References zooms_vec.
Referenced by Process().
|
inline |
Definition at line 103 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 103 of file PHInitZVertexing.h
References _ca_phi_cut.
|
inline |
Definition at line 92 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 92 of file PHInitZVertexing.h
References _ca_z_cut.
|
inline |
sets a chi2 cut
Definition at line 88 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 88 of file PHInitZVertexing.h
References _ca_chi2.
|
inline |
sets an upper limit on X-Y DCA
Definition at line 80 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 80 of file PHInitZVertexing.h
References _dcaxy_cut.
|
inline |
sets an upper limit on Z DCA
Definition at line 84 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 84 of file PHInitZVertexing.h
References _dcaz_cut.
|
inline |
Definition at line 49 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 49 of file PHInitZVertexing.h
References _fname, and test::fname.
|
inline |
Definition at line 50 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 50 of file PHInitZVertexing.h
References _mag_field.
radiation length per layer, sequential layer indexes required here
Definition at line 521 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 521 of file PHInitZVertexing.cc
References _user_material, and G4TTL::layer.
|
inline |
Definition at line 63 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 63 of file PHInitZVertexing.h
References _max_d.
|
inline |
Definition at line 65 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 65 of file PHInitZVertexing.h
References _max_dzdl.
void PHInitZVertexing::set_max_kappa | ( | float | kappa_max | ) |
Definition at line 997 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 997 of file PHInitZVertexing.cc
References _max_kappa, and _use_max_kappa.
|
inline |
Definition at line 67 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 67 of file PHInitZVertexing.h
References _max_z0.
|
inline |
Definition at line 62 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 62 of file PHInitZVertexing.h
References _min_d.
|
inline |
Definition at line 64 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 64 of file PHInitZVertexing.h
References _min_dzdl.
|
inline |
Definition at line 57 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 57 of file PHInitZVertexing.h
|
inline |
Definition at line 66 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 66 of file PHInitZVertexing.h
References _min_z0.
Definition at line 176 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 176 of file PHInitZVertexing.cc
References _min_zvtx_tracks, and _override_min_zvtx_tracks.
|
inline |
Definition at line 108 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 108 of file PHInitZVertexing.h
References _mult_onebin.
|
inline |
Definition at line 118 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 118 of file PHInitZVertexing.h
References _mult_threebins.
|
inline |
Definition at line 113 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 113 of file PHInitZVertexing.h
References _mult_twobins.
Definition at line 1002 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1002 of file PHInitZVertexing.cc
References _hough_space, HelixHoughSpace::get_n_d_bins(), HelixHoughSpace::get_n_dzdl_bins(), HelixHoughSpace::get_n_kappa_bins(), HelixHoughSpace::get_n_phi_bins(), HelixHoughSpace::get_n_z0_bins(), nd, ndzdl, nkappa, nphi, and nz0.
Referenced by Process(), prune_xy(), prune_z(), vote_xy(), and vote_z().
|
inline |
Definition at line 135 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 135 of file PHInitZVertexing.h
References nzooms, and zooms_vec.
Referenced by Setup().
Definition at line 129 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 129 of file PHInitZVertexing.h
References _seeding_layer.
|
inline |
turn on DCA limitation
Definition at line 76 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 76 of file PHInitZVertexing.h
References _cut_on_dca.
|
inline |
adjust the fit pt by a recalibration factor (constant B versus real mag field)
Definition at line 99 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 99 of file PHInitZVertexing.h
References _pt_rescale.
|
overrideprotectedvirtual |
setup interface for trackers, called in InitRun, setup things like pointers to nodes. overrided in derived classes
Reimplemented from PHInitVertexing.
Definition at line 183 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 183 of file PHInitZVertexing.cc
References _cut_on_dca, _d_phi, _dcaxy_cut, _dcaz_cut, _fname, _hough_funcs, _hough_space, _kappa_d_phi, _kappa_phi, _mag_field, _material, _max_d, _max_dzdl, _max_kappa, _max_z0, _min_d, _min_dzdl, _min_nlayers, _min_pt, _min_z0, _nlayers, _ntp_zvtx_by_event, _ntp_zvtx_by_track, _ofile, _ofile2, _pt_rescale, _radii, _t_output_io, _use_max_kappa, _z0_dzdl, Fun4AllReturnCodes::ABORTRUN, HelixHoughSpace::add_one_zoom(), create_nodes(), Fun4AllReturnCodes::EVENT_OK, fill_multi_zvtx, HelixHoughSpace::get_d_max(), HelixHoughSpace::get_d_min(), HelixHoughSpace::get_dzdl_max(), HelixHoughSpace::get_dzdl_min(), HelixHoughSpace::get_kappa_max(), HelixHoughSpace::get_kappa_min(), HelixHoughSpace::get_n_d_bins(), HelixHoughSpace::get_n_dzdl_bins(), HelixHoughSpace::get_n_kappa_bins(), HelixHoughSpace::get_n_phi_bins(), HelixHoughSpace::get_n_z0_bins(), HelixHoughSpace::get_phi_max(), HelixHoughSpace::get_phi_min(), HelixHoughSpace::get_z0_max(), HelixHoughSpace::get_z0_min(), initialize_geometry(), M_PI, nzooms, pt_to_kappa(), HelixHoughSpace::set_d_max(), HelixHoughSpace::set_d_min(), HelixHoughSpace::set_dzdl_max(), HelixHoughSpace::set_dzdl_min(), HelixHoughFuncs::set_hough_space(), HelixHoughSpace::set_kappa_max(), HelixHoughSpace::set_kappa_min(), set_nzooms(), HelixHoughSpace::set_phi_max(), HelixHoughSpace::set_phi_min(), HelixHoughSpace::set_z0_max(), HelixHoughSpace::set_z0_min(), PHInitVertexing::Setup(), PHTimer::stop(), Fun4AllBase::Verbosity(), and zooms_vec.
|
private |
Definition at line 2376 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 2376 of file PHInitZVertexing.cc
References _tracks, _vertex, dx, dy, dz, SimpleHit3D::get_x(), SimpleHit3D::get_y(), SimpleHit3D::get_z(), hit, hits(), hits_map, it, SimpleHit3D::set_x(), SimpleHit3D::set_y(), and SimpleHit3D::set_z().
Referenced by Process().
|
private |
Definition at line 2405 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 2405 of file PHInitZVertexing.cc
References M_PI.
Referenced by build_triplets_to_SimpleTrack3D().
|
private |
Definition at line 722 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 722 of file PHInitZVertexing.cc
References PHInitVertexing::_cluster_map, PHInitVertexing::_hitsets, _layer_ilayer_map, _min_zvtx_tracks, _nclus_mvtx, _nlayers, _override_min_zvtx_tracks, Fun4AllReturnCodes::EVENT_OK, SimpleHit3D::get_id(), TrkrClusterContainer::getClusters(), TrkrCluster::getError(), TrkrHitSetContainer::getHitSets(), TrkrDefs::getLayer(), TrkrCluster::getPosition(), hit, hits_map, hits_used, it, G4TTL::layer, PHWHERE, SimpleHit3D::print(), SimpleHit3D::set_cluskey(), SimpleHit3D::set_error(), SimpleHit3D::set_id(), SimpleHit3D::set_layer(), SimpleHit3D::set_size(), SimpleHit3D::set_x(), SimpleHit3D::set_y(), SimpleHit3D::set_z(), TrkrClusterContainer::size(), and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1360 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1360 of file PHInitZVertexing.cc
References _d_phi, _hough_funcs, _hough_space, _kappa_d_phi, _kappa_phi, HelixHoughBin::add_cluster_ID(), HelixHoughBin::begin_clusters(), bin, bins_map_cur, bins_map_sel, HelixHoughFuncs::calculate_phi_range(), HelixHoughBin::clear_clusters(), HelixHoughBin::CloneMe(), d_phi_map, HelixHoughBin::end_clusters(), HelixHoughSpace::get_bin(), HelixHoughBin::get_count(), HelixHoughBin::get_d_bin(), HelixHoughSpace::get_d_bin_size(), HelixHoughBin::get_d_center(), HelixHoughSpace::get_d_min(), HelixHoughBin::get_dzdl_bin(), HelixHoughBin::get_global_bin(), HelixHoughBin::get_kappa_bin(), HelixHoughSpace::get_kappa_bin_size(), HelixHoughBin::get_kappa_center(), HelixHoughSpace::get_kappa_min(), HelixHoughSpace::get_n_phi_bins(), HelixHoughBin::get_phi_bin(), HelixHoughSpace::get_phi_bin(), HelixHoughSpace::get_phi_bin_size(), HelixHoughBin::get_phi_center(), HelixHoughSpace::get_phi_max(), HelixHoughSpace::get_phi_min(), SimpleHit3D::get_x(), SimpleHit3D::get_y(), HelixHoughBin::get_z0_bin(), helicity, hit, hitpos3d, hits_map, id, ik, il, ip, it, iz, kappa_d_phi_map, kappa_phi_map, nd, nkappa, separate_helicity, HelixHoughBin::set_bin(), HelixHoughBin::set_bins(), HelixHoughFuncs::set_current_zoom(), set_nbins(), HelixHoughBin::set_zoomlevel(), and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1191 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1191 of file PHInitZVertexing.cc
References _hough_funcs, _hough_space, _z0_dzdl, HelixHoughBin::add_cluster_ID(), bin, bins_map_cur, bins_map_prev, HelixHoughFuncs::calculate_dzdl_range(), HelixHoughBin::clear_clusters(), HelixHoughBin::CloneMe(), HelixHoughSpace::get_bin(), HelixHoughSpace::get_d_bin_size(), HelixHoughBin::get_d_center(), HelixHoughBin::get_dzdl_bin(), HelixHoughSpace::get_dzdl_bin(), HelixHoughSpace::get_dzdl_bin_size(), HelixHoughBin::get_dzdl_center(), HelixHoughBin::get_global_bin(), HelixHoughSpace::get_kappa_bin_size(), HelixHoughBin::get_kappa_center(), HelixHoughSpace::get_n_dzdl_bins(), HelixHoughSpace::get_n_z0_bins(), HelixHoughBin::get_phi_bin(), HelixHoughSpace::get_phi_bin_size(), HelixHoughBin::get_phi_center(), SimpleHit3D::get_x(), SimpleHit3D::get_y(), SimpleHit3D::get_z(), HelixHoughBin::get_z0_bin(), HelixHoughSpace::get_z0_bin_size(), HelixHoughBin::get_z0_center(), hit, hitpos3d, hits_map, il, it, iz, HelixHoughBin::set_bin(), HelixHoughBin::set_bins(), HelixHoughFuncs::set_current_zoom(), set_nbins(), HelixHoughBin::set_zoomlevel(), and Fun4AllBase::Verbosity().
Referenced by Process().
Definition at line 1037 of file PHInitZVertexing.cc.
View newest version in sPHENIX GitHub at line 1037 of file PHInitZVertexing.cc
References _hough_funcs, _hough_space, bin, bins_map, HelixHoughFuncs::calculate_dzdl_range(), HelixHoughSpace::get_bin(), HelixHoughSpace::get_d_max(), HelixHoughSpace::get_d_min(), HelixHoughSpace::get_dzdl_bin(), HelixHoughSpace::get_dzdl_max(), HelixHoughSpace::get_dzdl_min(), HelixHoughSpace::get_kappa_max(), HelixHoughSpace::get_kappa_min(), HelixHoughSpace::get_n_dzdl_bins(), HelixHoughSpace::get_n_z0_bins(), HelixHoughSpace::get_phi_max(), HelixHoughSpace::get_phi_min(), SimpleHit3D::get_x(), SimpleHit3D::get_y(), SimpleHit3D::get_z(), HelixHoughSpace::get_z0_bin_size(), HelixHoughSpace::get_z0_min(), hit, hitpos3d, hits_map, hits_used, il, it, iz, HelixHoughFuncs::set_current_zoom(), and Fun4AllBase::Verbosity().
Referenced by Process().
|
private |
Definition at line 273 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 273 of file PHInitZVertexing.h
|
private |
Definition at line 211 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 211 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), Process(), and set_chi2_cut().
|
private |
Definition at line 209 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 209 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), and Process().
|
private |
Definition at line 234 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 234 of file PHInitZVertexing.h
Referenced by build_triplets_to_SimpleTrack3D(), cellular_automaton_zvtx_init(), and set_ca_phi_cut().
|
private |
Definition at line 235 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 235 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), and set_ca_z_cut().
|
private |
Definition at line 230 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 230 of file PHInitZVertexing.h
Referenced by setCutOnDCA(), and Setup().
|
private |
Definition at line 288 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 288 of file PHInitZVertexing.h
|
private |
Definition at line 231 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 231 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), set_dcaxy_cut(), and Setup().
|
private |
Definition at line 232 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 232 of file PHInitZVertexing.h
Referenced by fit_vertex(), set_dcaz_cut(), and Setup().
|
private |
Definition at line 202 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 202 of file PHInitZVertexing.h
Referenced by fit_vertex(), PHInitZVertexing(), and Process().
|
private |
Definition at line 293 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 293 of file PHInitZVertexing.h
Referenced by End(), set_file_name(), and Setup().
|
private |
Definition at line 280 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 280 of file PHInitZVertexing.h
Referenced by Setup(), vote_xy(), vote_z(), vote_z_init(), and ~PHInitZVertexing().
|
private |
Definition at line 279 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 279 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), find_track_candidates_z_init(), initialize_houghbin(), set_nbins(), Setup(), vote_xy(), vote_z(), vote_z_init(), and ~PHInitZVertexing().
|
private |
Definition at line 289 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 289 of file PHInitZVertexing.h
|
private |
Definition at line 287 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 287 of file PHInitZVertexing.h
recorded layer indexes to internal sequential indexes
Definition at line 261 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 261 of file PHInitZVertexing.h
Referenced by initialize_geometry(), and translate_input().
Definition at line 296 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 296 of file PHInitZVertexing.h
Referenced by initialize_geometry().
|
private |
in Tesla
Definition at line 216 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 216 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), export_output(), get_mag_field(), kappa_to_pt(), pt_to_kappa(), set_mag_field(), and Setup().
|
private |
material at each layer in rad. lengths
Definition at line 213 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 213 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), initialize_geometry(), and Setup().
|
private |
Definition at line 224 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 224 of file PHInitZVertexing.h
Referenced by set_max_d(), and Setup().
|
private |
Definition at line 226 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 226 of file PHInitZVertexing.h
Referenced by set_max_dzdl(), and Setup().
|
private |
Definition at line 222 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 222 of file PHInitZVertexing.h
Referenced by get_max_kappa(), set_max_kappa(), and Setup().
|
private |
Definition at line 228 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 228 of file PHInitZVertexing.h
Referenced by fit_vertex(), get_max_z0(), set_max_z0(), and Setup().
|
private |
Definition at line 223 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 223 of file PHInitZVertexing.h
Referenced by set_min_d(), and Setup().
|
private |
Definition at line 225 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 225 of file PHInitZVertexing.h
Referenced by set_min_dzdl(), and Setup().
|
private |
minimum number of layers to make a track
Definition at line 208 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 208 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), find_track_candidates_z(), find_track_candidates_z_init(), and Setup().
|
private |
Definition at line 221 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 221 of file PHInitZVertexing.h
Referenced by set_min_pT(), and Setup().
|
private |
Definition at line 227 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 227 of file PHInitZVertexing.h
Referenced by fit_vertex(), get_min_z0(), set_min_z0(), and Setup().
|
private |
Definition at line 240 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 240 of file PHInitZVertexing.h
Referenced by fit_vertex(), set_min_zvtx_tracks(), and translate_input().
|
private |
Definition at line 237 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 237 of file PHInitZVertexing.h
Referenced by fit_vertex(), and set_mult_onebin().
|
private |
Definition at line 239 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 239 of file PHInitZVertexing.h
Referenced by set_mult_threebins().
|
private |
Definition at line 238 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 238 of file PHInitZVertexing.h
Referenced by fit_vertex(), and set_mult_twobins().
|
private |
Definition at line 295 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 295 of file PHInitZVertexing.h
Referenced by translate_input().
|
private |
number of detector layers
Definition at line 207 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 207 of file PHInitZVertexing.h
Referenced by build_triplets_to_SimpleTrack3D(), initialize_geometry(), prune_xy(), prune_z(), Setup(), and translate_input().
|
private |
Definition at line 294 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 294 of file PHInitZVertexing.h
Referenced by initialize_geometry().
|
private |
Definition at line 284 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 284 of file PHInitZVertexing.h
Referenced by End(), fit_vertex(), and Setup().
|
private |
Definition at line 285 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 285 of file PHInitZVertexing.h
Referenced by End(), fit_vertex(), and Setup().
|
private |
Definition at line 290 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 290 of file PHInitZVertexing.h
|
private |
Definition at line 291 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 291 of file PHInitZVertexing.h
|
private |
Definition at line 241 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 241 of file PHInitZVertexing.h
Referenced by set_min_zvtx_tracks(), and translate_input().
|
private |
Definition at line 233 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 233 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), kappa_to_pt(), pt_to_kappa(), setPtRescaleFactor(), and Setup().
|
private |
radial distance of each layer (cm)
Definition at line 212 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 212 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), initialize_geometry(), and Setup().
|
private |
Definition at line 297 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 297 of file PHInitZVertexing.h
Referenced by initialize_geometry().
|
private |
Definition at line 205 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 205 of file PHInitZVertexing.h
Referenced by get_seeding_layer(), initialize_geometry(), and set_seeding_layer().
|
private |
Definition at line 203 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 203 of file PHInitZVertexing.h
Referenced by Setup(), and ~PHInitZVertexing().
|
private |
Definition at line 264 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 264 of file PHInitZVertexing.h
|
private |
working array of track covariances
Definition at line 268 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 268 of file PHInitZVertexing.h
Referenced by export_output(), fit_vertex(), and Process().
|
private |
working array of track chisq
Definition at line 267 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 267 of file PHInitZVertexing.h
Referenced by export_output(), fit_vertex(), and Process().
|
private |
Definition at line 266 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 266 of file PHInitZVertexing.h
Referenced by cellular_automaton_zvtx_init(), fit_vertex(), and Process().
|
private |
Definition at line 274 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 274 of file PHInitZVertexing.h
Referenced by create_nodes(), and export_output().
|
private |
working array of tracks
Definition at line 265 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 265 of file PHInitZVertexing.h
Referenced by bins_to_SimpleTrack3D(), cellular_automaton_zvtx_init(), export_output(), fit_vertex(), Process(), and shift_coordinate_system().
|
private |
Definition at line 218 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 218 of file PHInitZVertexing.h
Referenced by set_max_kappa(), and Setup().
|
private |
material in user ladder indexes
Definition at line 214 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 214 of file PHInitZVertexing.h
Referenced by initialize_geometry(), and set_material().
|
private |
working array for collision vertex
Definition at line 269 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 269 of file PHInitZVertexing.h
Referenced by export_output(), fit_vertex(), Process(), and shift_coordinate_system().
|
private |
Definition at line 277 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 277 of file PHInitZVertexing.h
Referenced by fit_vertex().
|
private |
Definition at line 270 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 270 of file PHInitZVertexing.h
Referenced by export_output(), fit_vertex(), and Process().
|
private |
Definition at line 286 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 286 of file PHInitZVertexing.h
Referenced by End(), find_track_candidates_z_init(), Setup(), and vote_z().
|
private |
Definition at line 236 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 236 of file PHInitZVertexing.h
Referenced by build_triplets_to_SimpleTrack3D().
|
private |
Definition at line 243 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 243 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), find_track_candidates_z(), find_track_candidates_z_init(), initialize_houghbin(), vote_xy(), vote_z(), and vote_z_init().
|
private |
Definition at line 302 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 302 of file PHInitZVertexing.h
Referenced by find_track_candidates_z_init(), initialize_houghbin(), Process(), and vote_z_init().
|
private |
Definition at line 304 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 304 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), find_track_candidates_z(), Process(), vote_xy(), and vote_z().
|
private |
Definition at line 303 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 303 of file PHInitZVertexing.h
Referenced by bins_to_SimpleTrack3D(), find_track_candidates_xy(), Process(), prune_xy(), and vote_z().
|
private |
Definition at line 305 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 305 of file PHInitZVertexing.h
Referenced by bins_to_SimpleTrack3D(), find_track_candidates_z(), find_track_candidates_z_init(), Process(), prune_z(), and vote_xy().
|
private |
Definition at line 258 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 258 of file PHInitZVertexing.h
Definition at line 308 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 308 of file PHInitZVertexing.h
Referenced by vote_xy().
|
private |
Definition at line 219 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 219 of file PHInitZVertexing.h
Referenced by End(), fit_vertex(), and Setup().
|
private |
Definition at line 316 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 316 of file PHInitZVertexing.h
Referenced by export_output(), Process(), and vote_xy().
|
private |
Definition at line 311 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 311 of file PHInitZVertexing.h
Referenced by bins_to_SimpleTrack3D(), build_triplets_to_SimpleTrack3D(), shift_coordinate_system(), translate_input(), vote_xy(), vote_z(), and vote_z_init().
|
private |
Definition at line 312 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 312 of file PHInitZVertexing.h
Referenced by vote_xy(), vote_z(), and vote_z_init().
|
private |
Definition at line 301 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 301 of file PHInitZVertexing.h
Referenced by bins_to_SimpleTrack3D(), build_triplets_to_SimpleTrack3D(), cellular_automaton_zvtx_init(), export_output(), Process(), shift_coordinate_system(), translate_input(), vote_xy(), vote_z(), and vote_z_init().
|
private |
Definition at line 300 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 300 of file PHInitZVertexing.h
Referenced by build_triplets_to_SimpleTrack3D(), cellular_automaton_zvtx_init(), Process(), reset_hits_used(), translate_input(), and vote_z_init().
|
private |
Definition at line 247 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 247 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), and vote_xy().
|
private |
Definition at line 245 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 245 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), initialize_houghbin(), and vote_xy().
|
private |
Definition at line 248 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 248 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), find_track_candidates_z(), initialize_houghbin(), vote_xy(), vote_z(), and vote_z_init().
|
private |
Definition at line 246 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 246 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), initialize_houghbin(), and vote_xy().
|
private |
Definition at line 249 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 249 of file PHInitZVertexing.h
Referenced by find_track_candidates_xy(), find_track_candidates_z(), fit_vertex(), initialize_houghbin(), vote_xy(), vote_z(), and vote_z_init().
Definition at line 309 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 309 of file PHInitZVertexing.h
Referenced by vote_xy().
Definition at line 307 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 307 of file PHInitZVertexing.h
Referenced by vote_xy().
|
private |
Definition at line 317 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 317 of file PHInitZVertexing.h
Referenced by fit_vertex().
|
private |
Definition at line 253 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 253 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), Process(), set_nbins(), and vote_xy().
|
private |
Definition at line 254 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 254 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), Process(), and set_nbins().
|
private |
Definition at line 251 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 251 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), Process(), set_nbins(), and vote_xy().
|
private |
Definition at line 252 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 252 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), Process(), and set_nbins().
|
private |
Definition at line 255 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 255 of file PHInitZVertexing.h
Referenced by initialize_houghbin(), Process(), and set_nbins().
|
private |
Definition at line 313 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 313 of file PHInitZVertexing.h
Referenced by set_nzooms(), and Setup().
|
private |
Definition at line 315 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 315 of file PHInitZVertexing.h
|
private |
Definition at line 298 of file PHInitZVertexing.h.
View newest version in sPHENIX GitHub at line 298 of file PHInitZVertexing.h
Referenced by add_zoom(), PHInitZVertexing(), reset_zooms(), set_nzooms(), and Setup().