CMS 3D CMS Logo

List of all members | Classes | Public Member Functions | Static Private Member Functions | Private Attributes
ProtonReconstructionAlgorithm Class Reference

#include <ProtonReconstructionAlgorithm.h>

Classes

class  ChiSquareCalculator
 class for calculation of chi^2 More...
 
struct  RPOpticsData
 optics data associated with 1 RP More...
 

Public Member Functions

void init (const LHCInterpolatedOpticalFunctionsSetCollection &opticalFunctions)
 
 ProtonReconstructionAlgorithm (bool fit_vtx_y, bool improved_estimate, unsigned int verbosity)
 
reco::ForwardProton reconstructFromMultiRP (const CTPPSLocalTrackLiteRefVector &tracks, const LHCInfo &lhcInfo, std::ostream &os) const
 run proton reconstruction using multiple-RP strategy More...
 
reco::ForwardProton reconstructFromSingleRP (const CTPPSLocalTrackLiteRef &track, const LHCInfo &lhcInfo, std::ostream &os) const
 run proton reconstruction using single-RP strategy More...
 
void release ()
 
 ~ProtonReconstructionAlgorithm ()=default
 

Static Private Member Functions

static void doLinearFit (const std::vector< double > &vx, const std::vector< double > &vy, double &b, double &a)
 

Private Attributes

std::unique_ptr< ChiSquareCalculatorchiSquareCalculator_
 object to calculate chi^2 More...
 
std::unique_ptr< ROOT::Fit::Fitter > fitter_
 fitter object More...
 
bool fitVtxY_
 
bool initialized_
 
std::map< unsigned int, RPOpticsDatam_rp_optics_
 map: RP id –> optics data More...
 
bool useImprovedInitialEstimate_
 
unsigned int verbosity_
 

Detailed Description

Definition at line 26 of file ProtonReconstructionAlgorithm.h.

Constructor & Destructor Documentation

ProtonReconstructionAlgorithm::ProtonReconstructionAlgorithm ( bool  fit_vtx_y,
bool  improved_estimate,
unsigned int  verbosity 
)

Definition at line 22 of file ProtonReconstructionAlgorithm.cc.

References chiSquareCalculator_, and fitter_.

22  :
24  fitVtxY_(fit_vtx_y),
25  useImprovedInitialEstimate_(improved_estimate),
26  initialized_(false),
27  fitter_(new ROOT::Fit::Fitter), chiSquareCalculator_(new ChiSquareCalculator)
28 {
29  // needed for thread safety
30  TMinuitMinimizer::UseStaticMinuit(false);
31 
32  // initialise fitter
33  double pStart[] = { 0, 0, 0, 0 };
34  fitter_->SetFCN(4, *chiSquareCalculator_, pStart, 0, true);
35 }
std::unique_ptr< ROOT::Fit::Fitter > fitter_
fitter object
std::unique_ptr< ChiSquareCalculator > chiSquareCalculator_
object to calculate chi^2
ProtonReconstructionAlgorithm::~ProtonReconstructionAlgorithm ( )
default

Member Function Documentation

void ProtonReconstructionAlgorithm::doLinearFit ( const std::vector< double > &  vx,
const std::vector< double > &  vy,
double &  b,
double &  a 
)
staticprivate

Definition at line 83 of file ProtonReconstructionAlgorithm.cc.

References edmIntegrityCheck::d, and mps_fire::i.

Referenced by init().

84 {
85  double s_1=0., s_x=0., s_xx=0., s_y=0., s_xy=0.;
86  for (unsigned int i = 0; i < vx.size(); ++i)
87  {
88  s_1 += 1.;
89  s_x += vx[i];
90  s_xx += vx[i] * vx[i];
91  s_y += vy[i];
92  s_xy += vx[i] * vy[i];
93  }
94 
95  const double d = s_xx * s_1 - s_x * s_x;
96  a = ( s_1 * s_xy - s_x * s_y) / d;
97  b = (-s_x * s_xy + s_xx * s_y) / d;
98 }
double b
Definition: hdecay.h:120
double a
Definition: hdecay.h:121
void ProtonReconstructionAlgorithm::init ( const LHCInterpolatedOpticalFunctionsSetCollection opticalFunctions)

Definition at line 39 of file ProtonReconstructionAlgorithm.cc.

References ProtonReconstructionAlgorithm::RPOpticsData::ch0, ProtonReconstructionAlgorithm::RPOpticsData::ch1, doLinearFit(), LHCOpticalFunctionsSet::eLx, LHCOpticalFunctionsSet::eLy, LHCOpticalFunctionsSet::evy, LHCOpticalFunctionsSet::exd, LHCOpticalFunctionsSet::eyd, LHCOpticalFunctionsSet::getFcnValues(), LHCOpticalFunctionsSet::getXiValues(), initialized_, ProtonReconstructionAlgorithm::RPOpticsData::la0, ProtonReconstructionAlgorithm::RPOpticsData::la1, m_rp_optics_, eostools::move(), ProtonReconstructionAlgorithm::RPOpticsData::optics, AlCaHLTBitMon_ParallelJobs::p, release(), ProtonReconstructionAlgorithm::RPOpticsData::s_L_y_vs_xi, ProtonReconstructionAlgorithm::RPOpticsData::s_v_y_vs_xi, ProtonReconstructionAlgorithm::RPOpticsData::s_xi_vs_x_d, ProtonReconstructionAlgorithm::RPOpticsData::s_y_d_vs_xi, LHCInterpolatedOpticalFunctionsSet::splines(), LHCInterpolatedOpticalFunctionsSet::transport(), LHCInterpolatedOpticalFunctionsSet::Kinematics::x, ProtonReconstructionAlgorithm::RPOpticsData::x0, LHCInterpolatedOpticalFunctionsSet::Kinematics::y, and ProtonReconstructionAlgorithm::RPOpticsData::y0.

Referenced by CTPPSProtonProducer::produce().

40 {
41  // reset cache
42  release();
43 
44  // build optics data for each object
45  for (const auto &p : opticalFunctions)
46  {
47  const LHCInterpolatedOpticalFunctionsSet &ofs = p.second;
48 
49  // make record
50  RPOpticsData rpod;
51  rpod.optics = &p.second;
52  rpod.s_y_d_vs_xi = ofs.splines()[LHCOpticalFunctionsSet::eyd];
53  rpod.s_v_y_vs_xi = ofs.splines()[LHCOpticalFunctionsSet::evy];
54  rpod.s_L_y_vs_xi = ofs.splines()[LHCOpticalFunctionsSet::eLy];
55 
56  vector<double> xiValues = ofs.getXiValues(); // local copy made since the TSpline constructor needs non-const parameters
57  vector<double> xDValues = ofs.getFcnValues()[LHCOpticalFunctionsSet::exd];
58  rpod.s_xi_vs_x_d = make_shared<TSpline3>("", xDValues.data(), xiValues.data(), xiValues.size());
59 
60  // calculate auxiliary data
61  LHCInterpolatedOpticalFunctionsSet::Kinematics k_in = { 0., 0., 0., 0., 0. };
63  rpod.optics->transport(k_in, k_out);
64  rpod.x0 = k_out.x;
65  rpod.y0 = k_out.y;
66 
67  doLinearFit(ofs.getXiValues(), ofs.getFcnValues()[LHCOpticalFunctionsSet::exd], rpod.ch0, rpod.ch1);
68  rpod.ch0 -= rpod.x0;
69 
70  doLinearFit(ofs.getXiValues(), ofs.getFcnValues()[LHCOpticalFunctionsSet::eLx], rpod.la0, rpod.la1);
71 
72  // insert record
73  const CTPPSDetId rpId(p.first);
74  m_rp_optics_.emplace(rpId, std::move(rpod));
75  }
76 
77  // update settings
78  initialized_ = true;
79 }
const std::vector< double > & getXiValues() const
std::map< unsigned int, RPOpticsData > m_rp_optics_
map: RP id –> optics data
const std::vector< std::shared_ptr< const TSpline3 > > & splines() const
static void doLinearFit(const std::vector< double > &vx, const std::vector< double > &vy, double &b, double &a)
Set of optical functions corresponding to one scoring plane along LHC, including splines for interpol...
Base class for CTPPS detector IDs.
Definition: CTPPSDetId.h:32
const std::vector< std::vector< double > > & getFcnValues() const
def move(src, dest)
Definition: eostools.py:511
reco::ForwardProton ProtonReconstructionAlgorithm::reconstructFromMultiRP ( const CTPPSLocalTrackLiteRefVector tracks,
const LHCInfo lhcInfo,
std::ostream &  os 
) const

run proton reconstruction using multiple-RP strategy

Definition at line 144 of file ProtonReconstructionAlgorithm.cc.

References a, b, EnergyCorrector::c, ProtonReconstructionAlgorithm::RPOpticsData::ch0, ProtonReconstructionAlgorithm::RPOpticsData::ch1, chiSquareCalculator_, LHCInfo::energy(), fitter_, fitVtxY_, mps_fire::i, createfilelist::int, ProtonReconstructionAlgorithm::RPOpticsData::la0, ProtonReconstructionAlgorithm::RPOpticsData::la1, m_rp_optics_, AlCaHLTBitMon_ParallelJobs::p, mps_fire::result, mathSSE::sqrt(), HiIsolationCommonParameters_cff::track, l1t::tracks, useImprovedInitialEstimate_, verbosity_, hybridSuperClusters_cfi::xi, and y.

Referenced by CTPPSProtonProducer::produce().

146 {
147  // make sure optics is available for all tracks
148  for (const auto &it : tracks) {
149  auto oit = m_rp_optics_.find(it->getRPId());
150  if (oit == m_rp_optics_.end())
151  throw cms::Exception("ProtonReconstructionAlgorithm") << "Optics data not available for RP " <<
152  it->getRPId() << ", i.e. " << CTPPSDetId(it->getRPId()) << ".";
153  }
154 
155  // initial estimate of xi and th_x
156  double xi_init = 0., th_x_init = 0.;
157 
159  double x_N = tracks[0]->getX()*1E-1, // conversion: mm --> cm
160  x_F = tracks[1]->getX()*1E-1;
161 
162  const RPOpticsData &i_N = m_rp_optics_.find(tracks[0]->getRPId())->second,
163  &i_F = m_rp_optics_.find(tracks[1]->getRPId())->second;
164 
165  const double a = i_F.ch1*i_N.la1 - i_N.ch1*i_F.la1;
166  const double b = i_F.ch0*i_N.la1 - i_N.ch0*i_F.la1 + i_F.ch1*i_N.la0 - i_N.ch1*i_F.la0 + x_N*i_F.la1 - x_F*i_N.la1;
167  const double c = x_N*i_F.la0 - x_F*i_N.la0 + i_F.ch0*i_N.la0 - i_N.ch0*i_F.la0;
168  const double D = b*b - 4.*a*c;
169  const double sqrt_D = (D >= 0.) ? sqrt(D) : 0.;
170 
171  xi_init = (-b + sqrt_D) / 2. / a;
172  th_x_init = (x_N - i_N.ch0 - i_N.ch1 * xi_init) / (i_N.la0 + i_N.la1 * xi_init);
173  }
174  else {
175  double s_xi0 = 0., s_1 = 0.;
176  for (const auto &track : tracks) {
177  auto oit = m_rp_optics_.find(track->getRPId());
178  double xi = oit->second.s_xi_vs_x_d->Eval(track->getX()*1E-1 + oit->second.x0); // conversion: mm --> cm
179 
180  s_1 += 1.;
181  s_xi0 += xi;
182  }
183 
184  xi_init = s_xi0 / s_1;
185  }
186 
187  if (!std::isfinite(xi_init))
188  xi_init = 0.;
189  if (!std::isfinite(th_x_init))
190  th_x_init = 0.;
191 
192  // initial estimate of th_y and vtx_y
193  double y[2]={0}, v_y[2]={0}, L_y[2]={0};
194  unsigned int y_idx = 0;
195  for (const auto &track : tracks) {
196  if (y_idx >= 2) break;
197 
198  auto oit = m_rp_optics_.find(track->getRPId());
199 
200  y[y_idx] = track->getY()*1E-1 - oit->second.s_y_d_vs_xi->Eval(xi_init); // track y: mm --> cm
201  v_y[y_idx] = oit->second.s_v_y_vs_xi->Eval(xi_init);
202  L_y[y_idx] = oit->second.s_L_y_vs_xi->Eval(xi_init);
203 
204  y_idx++;
205  }
206 
207  double vtx_y_init = 0.;
208  double th_y_init = 0.;
209 
210  if (fitVtxY_) {
211  const double det_y = v_y[0] * L_y[1] - L_y[0] * v_y[1];
212  vtx_y_init = (det_y != 0.) ? (L_y[1] * y[0] - L_y[0] * y[1]) / det_y : 0.;
213  th_y_init = (det_y != 0.) ? (v_y[0] * y[1] - v_y[1] * y[0]) / det_y : 0.;
214  }
215  else {
216  vtx_y_init = 0.;
217  th_y_init = (y[1]/L_y[1] + y[0]/L_y[0]) / 2.;
218  }
219 
220  if (!std::isfinite(vtx_y_init))
221  vtx_y_init = 0.;
222  if (!std::isfinite(th_y_init))
223  th_y_init = 0.;
224 
225  unsigned int armId = CTPPSDetId((*tracks.begin())->getRPId()).arm();
226 
227  if (verbosity_)
228  os
229  << "ProtonReconstructionAlgorithm::reconstructFromMultiRP(" << armId << ")" << std::endl
230  << " initial estimate: xi_init = " << xi_init << ", th_x_init = " << th_x_init
231  << ", th_y_init = " << th_y_init << ", vtx_y_init = " << vtx_y_init << "." << std::endl;
232 
233  // minimisation
234  fitter_->Config().ParSettings(0).Set("xi", xi_init, 0.005);
235  fitter_->Config().ParSettings(1).Set("th_x", th_x_init, 2E-6);
236  fitter_->Config().ParSettings(2).Set("th_y", th_y_init, 2E-6);
237  fitter_->Config().ParSettings(3).Set("vtx_y", vtx_y_init, 10E-6);
238 
239  if (!fitVtxY_)
240  fitter_->Config().ParSettings(3).Fix();
241 
242  chiSquareCalculator_->tracks = &tracks;
243  chiSquareCalculator_->m_rp_optics = &m_rp_optics_;
244 
245  fitter_->FitFCN();
246  fitter_->FitFCN(); // second minimisation in case the first one had troubles
247 
248  // extract proton parameters
249  const ROOT::Fit::FitResult& result = fitter_->Result();
250  const double *params = result.GetParams();
251 
252  if (verbosity_)
253  os
254  << " xi=" << params[0] << " +- " << result.Error(0)
255  << ", th_x=" << params[1] << " +-" << result.Error(1)
256  << ", th_y=" << params[2] << " +-" << result.Error(2)
257  << ", vtx_y=" << params[3] << " +-" << result.Error(3)
258  << ", chiSq = " << result.Chi2() << std::endl;
259 
260  // save reco candidate
261  using FP = reco::ForwardProton;
262 
263  const double sign_z = (armId == 0) ? +1. : -1.; // CMS convention
264  const FP::Point vertex(0., params[3], 0.);
265  const double xi = params[0];
266  const double th_x = params[1];
267  const double th_y = params[2];
268  const double cos_th = sqrt(1. - th_x*th_x - th_y*th_y);
269  const double p = lhcInfo.energy() * (1. - xi);
270  const FP::Vector momentum(
271  - p * th_x, // the signs reflect change LHC --> CMS convention
272  + p * th_y,
273  sign_z * p * cos_th
274  );
275  signed int ndf = 2.*tracks.size() - ((fitVtxY_) ? 4. : 3.);
276 
277  map<unsigned int, signed int> index_map = {
278  {(unsigned int) FP::Index::xi, 0},
279  {(unsigned int) FP::Index::th_x, 1},
280  {(unsigned int) FP::Index::th_y, 2},
281  {(unsigned int) FP::Index::vtx_y, ((fitVtxY_) ? 3 : -1)},
282  {(unsigned int) FP::Index::vtx_x, -1},
283  };
284 
286  for (unsigned int i = 0; i < (unsigned int) FP::Index::num_indices; ++i) {
287  signed int fit_i = index_map[i];
288 
289  for (unsigned int j = 0; j < (unsigned int) FP::Index::num_indices; ++j) {
290  signed int fit_j = index_map[j];
291 
292  cm(i, j) = (fit_i >= 0 && fit_j >= 0) ? result.CovMatrix(fit_i, fit_j) : 0.;
293  }
294  }
295 
296  return reco::ForwardProton(result.Chi2(), ndf, vertex, momentum, xi, cm,
297  FP::ReconstructionMethod::multiRP, tracks, result.IsValid());
298 }
std::unique_ptr< ROOT::Fit::Fitter > fitter_
fitter object
ROOT::Math::Plane3D::Vector Vector
Definition: EcalHitMaker.cc:29
math::Error< 5 >::type CovarianceMatrix
std::pair< double, double > Point
Definition: CaloEllipse.h:18
std::map< unsigned int, RPOpticsData > m_rp_optics_
map: RP id –> optics data
std::unique_ptr< ChiSquareCalculator > chiSquareCalculator_
object to calculate chi^2
T sqrt(T t)
Definition: SSEVec.h:18
DecomposeProduct< arg, typename Div::arg > D
Definition: Factorize.h:152
double b
Definition: hdecay.h:120
Base class for CTPPS detector IDs.
Definition: CTPPSDetId.h:32
double a
Definition: hdecay.h:121
float const energy() const
Definition: LHCInfo.cc:192
reco::ForwardProton ProtonReconstructionAlgorithm::reconstructFromSingleRP ( const CTPPSLocalTrackLiteRef track,
const LHCInfo lhcInfo,
std::ostream &  os 
) const

run proton reconstruction using single-RP strategy

Definition at line 302 of file ProtonReconstructionAlgorithm.cc.

References funct::abs(), CTPPSDetId::arm(), LHCInfo::energy(), m_rp_optics_, AlCaHLTBitMon_ParallelJobs::p, funct::pow(), edm::RefVector< C, T, F >::push_back(), mathSSE::sqrt(), verbosity_, and hybridSuperClusters_cfi::xi.

Referenced by CTPPSProtonProducer::produce().

304 {
305  CTPPSDetId rpId(track->getRPId());
306 
307  if (verbosity_)
308  os << "reconstructFromSingleRP(" << rpId.arm()*100 + rpId.station()*10 + rpId.rp() << ")" << std::endl;
309 
310  // make sure optics is available for the track
311  auto oit = m_rp_optics_.find(track->getRPId());
312  if (oit == m_rp_optics_.end())
313  throw cms::Exception("ProtonReconstructionAlgorithm") << "Optics data not available for RP " << track->getRPId()
314  << ", i.e. " << rpId << ".";
315 
316  // rough estimate of xi and th_y from each track
317  const double x_full = track->getX()*1E-1 + oit->second.x0; // conversion mm --> cm
318  const double xi = oit->second.s_xi_vs_x_d->Eval(x_full);
319  const double L_y = oit->second.s_L_y_vs_xi->Eval(xi);
320  const double th_y = track->getY()*1E-1 / L_y; // conversion mm --> cm
321 
322  const double ep_x = 1E-6;
323  const double dxi_dx = (oit->second.s_xi_vs_x_d->Eval(x_full + ep_x) - xi) / ep_x;
324  const double xi_unc = abs(dxi_dx) * track->getXUnc() * 1E-1; // conversion mm --> cm
325 
326  const double ep_xi = 1E-4;
327  const double dL_y_dxi = ( oit->second.s_L_y_vs_xi->Eval(xi + ep_xi) - L_y ) / ep_xi;
328  const double th_y_unc = th_y * sqrt( pow(track->getYUnc() / track->getY(), 2.) + pow(dL_y_dxi * xi_unc / L_y, 2.) );
329 
330  if (verbosity_)
331  os << " xi = " << xi << " +- " << xi_unc << ", th_y = " << th_y << " +- " << th_y_unc << "." << std::endl;
332 
333  using FP = reco::ForwardProton;
334 
335  // save proton candidate
336  const double sign_z = (CTPPSDetId(track->getRPId()).arm() == 0) ? +1. : -1.; // CMS convention
337  const FP::Point vertex(0., 0., 0.);
338  const double cos_th = sqrt(1. - th_y*th_y);
339  const double p = lhcInfo.energy() * (1. - xi);
340  const FP::Vector momentum(0., p * th_y, sign_z * p * cos_th);
341 
343  cm((int)FP::Index::xi, (int)FP::Index::xi) = xi_unc * xi_unc;
344  cm((int)FP::Index::th_y, (int)FP::Index::th_y) = th_y_unc * th_y_unc;
345 
347  trk.push_back( track );
348 
349  return reco::ForwardProton(0., 0, vertex, momentum, xi, cm, FP::ReconstructionMethod::singleRP, trk, true);
350 }
ROOT::Math::Plane3D::Vector Vector
Definition: EcalHitMaker.cc:29
math::Error< 5 >::type CovarianceMatrix
std::pair< double, double > Point
Definition: CaloEllipse.h:18
std::map< unsigned int, RPOpticsData > m_rp_optics_
map: RP id –> optics data
T sqrt(T t)
Definition: SSEVec.h:18
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
uint32_t arm() const
Definition: CTPPSDetId.h:51
Base class for CTPPS detector IDs.
Definition: CTPPSDetId.h:32
float const energy() const
Definition: LHCInfo.cc:192
void push_back(value_type const &ref)
Add a Ref<C, T> to the RefVector.
Definition: RefVector.h:69
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:40
void ProtonReconstructionAlgorithm::release ( )

Definition at line 102 of file ProtonReconstructionAlgorithm.cc.

References initialized_, and m_rp_optics_.

Referenced by init(), and CTPPSProtonProducer::produce().

103 {
104  initialized_ = false;
105 
106  m_rp_optics_.clear();
107 }
std::map< unsigned int, RPOpticsData > m_rp_optics_
map: RP id –> optics data

Member Data Documentation

std::unique_ptr<ChiSquareCalculator> ProtonReconstructionAlgorithm::chiSquareCalculator_
private

object to calculate chi^2

Definition at line 81 of file ProtonReconstructionAlgorithm.h.

Referenced by ProtonReconstructionAlgorithm(), and reconstructFromMultiRP().

std::unique_ptr<ROOT::Fit::Fitter> ProtonReconstructionAlgorithm::fitter_
private

fitter object

Definition at line 78 of file ProtonReconstructionAlgorithm.h.

Referenced by ProtonReconstructionAlgorithm(), and reconstructFromMultiRP().

bool ProtonReconstructionAlgorithm::fitVtxY_
private

Definition at line 45 of file ProtonReconstructionAlgorithm.h.

Referenced by reconstructFromMultiRP().

bool ProtonReconstructionAlgorithm::initialized_
private

Definition at line 47 of file ProtonReconstructionAlgorithm.h.

Referenced by init(), and release().

std::map<unsigned int, RPOpticsData> ProtonReconstructionAlgorithm::m_rp_optics_
private

map: RP id –> optics data

Definition at line 63 of file ProtonReconstructionAlgorithm.h.

Referenced by init(), reconstructFromMultiRP(), reconstructFromSingleRP(), and release().

bool ProtonReconstructionAlgorithm::useImprovedInitialEstimate_
private

Definition at line 46 of file ProtonReconstructionAlgorithm.h.

Referenced by reconstructFromMultiRP().

unsigned int ProtonReconstructionAlgorithm::verbosity_
private