CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
List of all members | Public Types | Public Member Functions | Protected Member Functions
MuonResiduals6DOFrphiFitter Class Reference

#include <MuonResiduals6DOFrphiFitter.h>

Inheritance diagram for MuonResiduals6DOFrphiFitter:
MuonResidualsFitter

Public Types

enum  {
  kAlignX = 0, kAlignY, kAlignZ, kAlignPhiX,
  kAlignPhiY, kAlignPhiZ, kResidSigma, kResSlopeSigma,
  kAlpha, kResidGamma, kResSlopeGamma, kNPar
}
 
enum  {
  kResid = 0, kResSlope, kPositionX, kPositionY,
  kAngleX, kAngleY, kRedChi2, kPz,
  kPt, kCharge, kNData
}
 
- Public Types inherited from MuonResidualsFitter
enum  {
  kPureGaussian, kPowerLawTails, kROOTVoigt, kGaussPowerTails,
  kPureGaussian2D
}
 
enum  {
  k1DOF, k5DOF, k6DOF, k6DOFrphi,
  kPositionFitter, kAngleFitter, kAngleBfieldFitter
}
 
enum  {
  k1111, k1110, k1100, k1010,
  k0010, k1000, k0100
}
 

Public Member Functions

void correctBField () override
 
bool fit (Alignable *ali) override
 
 MuonResiduals6DOFrphiFitter (int residualsModel, int minHits, int useResiduals, bool weightAlignment=true)
 
 MuonResiduals6DOFrphiFitter (int residualsModel, int minHits, int useResiduals, const CSCGeometry *cscGeometry, bool weightAlignment=true)
 
int ndata () override
 
int npar () override
 
double plot (std::string name, TFileDirectory *dir, Alignable *ali) override
 
TTree * readNtuple (std::string fname, unsigned int endcap, unsigned int station, unsigned int ring, unsigned int chamber, unsigned int preselected=1)
 
double sumofweights () override
 
int type () const override
 
 ~MuonResiduals6DOFrphiFitter () override
 
- Public Member Functions inherited from MuonResidualsFitter
void computeHistogramRangeAndBinning (int which, int &nbins, double &a, double &b)
 
virtual void correctBField (int idx_momentum, int idx_q)
 
TMatrixDSym correlationMatrix ()
 
double covarianceElement (int parNum1, int parNum2)
 
TMatrixDSym covarianceMatrix ()
 
void eraseNotSelectedResiduals ()
 
double errorerror (int parNum)
 
void fiducialCuts (double xMin=-80.0, double xMax=80.0, double yMin=-80.0, double yMax=80.0, bool fidcut1=false)
 
void fill (double *residual)
 
void fix (int parNum, bool dofix=true)
 
bool fixed (int parNum)
 
void histogramChi2GaussianFit (int which, double &fit_mean, double &fit_sigma)
 
double loglikelihood ()
 
 MuonResidualsFitter (int residualsModel, int minHits, int useResiduals, bool weightAlignment=true)
 
int nfixed ()
 
long numResiduals () const
 
long numsegments ()
 
int parNum2parIdx (int parNum)
 
void plotsimple (std::string name, TFileDirectory *dir, int which, double multiplier)
 
void plotweighted (std::string name, TFileDirectory *dir, int which, int whichredchi2, double multiplier)
 
void read (FILE *file, int which=0)
 
std::vector< double * >
::const_iterator 
residuals_begin () const
 
std::vector< double * >
::const_iterator 
residuals_end () const
 
int residualsModel () const
 
std::vector< bool > & selectedResidualsFlags ()
 
void selectPeakResiduals (double nsigma, int nvar, int *vars)
 
void selectPeakResiduals_simple (double nsigma, int nvar, int *vars)
 
void setInitialValue (int parNum, double value)
 
void setPrintLevel (int printLevel)
 
void setStrategy (int strategy)
 
int useRes (int pattern=-1)
 
double value (int parNum)
 
void write (FILE *file, int which=0)
 
virtual ~MuonResidualsFitter ()
 

Protected Member Functions

void inform (TMinuit *tMinuit) override
 
- Protected Member Functions inherited from MuonResidualsFitter
bool dofit (void(*fcn)(int &, double *, double &, double *, int), std::vector< int > &parNum, std::vector< std::string > &parName, std::vector< double > &start, std::vector< double > &step, std::vector< double > &low, std::vector< double > &high)
 
void initialize_table ()
 

Additional Inherited Members

- Protected Attributes inherited from MuonResidualsFitter
double m_center [20]
 
TMatrixDSym m_cov
 
std::vector< double > m_error
 
std::vector< bool > m_fixed
 
double m_loglikelihood
 
int m_minHits
 
std::map< int, double > m_parNum2InitValue
 
std::map< int, int > m_parNum2parIdx
 
int m_printLevel
 
double m_radii [20]
 
std::vector< double * > m_residuals
 
std::vector< bool > m_residuals_ok
 
int m_residualsModel
 
int m_strategy
 
int m_useResiduals
 
std::vector< double > m_value
 
bool m_weightAlignment
 

Detailed Description

$Date: Thu Apr 16 21:29:15 CDT 2009

Revision:
1.5
Author
J. Pivarski - Texas A&M University pivar.nosp@m.ski@.nosp@m.physi.nosp@m.cs.t.nosp@m.amu.e.nosp@m.du

Definition at line 19 of file MuonResiduals6DOFrphiFitter.h.

Member Enumeration Documentation

anonymous enum
anonymous enum

Constructor & Destructor Documentation

MuonResiduals6DOFrphiFitter::MuonResiduals6DOFrphiFitter ( int  residualsModel,
int  minHits,
int  useResiduals,
bool  weightAlignment = true 
)
inline

Definition at line 38 of file MuonResiduals6DOFrphiFitter.h.

tuple weightAlignment
Definition: align_cfg.py:30
MuonResidualsFitter(int residualsModel, int minHits, int useResiduals, bool weightAlignment=true)
list useResiduals
Definition: align_cfg.py:36
MuonResiduals6DOFrphiFitter::MuonResiduals6DOFrphiFitter ( int  residualsModel,
int  minHits,
int  useResiduals,
const CSCGeometry cscGeometry,
bool  weightAlignment = true 
)
inline

Definition at line 42 of file MuonResiduals6DOFrphiFitter.h.

tuple weightAlignment
Definition: align_cfg.py:30
MuonResidualsFitter(int residualsModel, int minHits, int useResiduals, bool weightAlignment=true)
list useResiduals
Definition: align_cfg.py:36
MuonResiduals6DOFrphiFitter::~MuonResiduals6DOFrphiFitter ( )
inlineoverride

Definition at line 47 of file MuonResiduals6DOFrphiFitter.h.

47 {}

Member Function Documentation

void MuonResiduals6DOFrphiFitter::correctBField ( )
overridevirtual
bool MuonResiduals6DOFrphiFitter::fit ( Alignable ali)
overridevirtual

Implements MuonResidualsFitter.

Definition at line 215 of file MuonResiduals6DOFrphiFitter.cc.

References MuonResidualsFitter::dofit(), MuonResidualsFitter::fix(), Alignable::globalPosition(), mps_fire::i, MuonResidualsFitter::initialize_table(), MuonResidualsFitter::k0010, MuonResidualsFitter::k1010, MuonResidualsFitter::k1100, MuonResidualsFitter::k1110, MuonResidualsFitter::k1111, kAlignPhiX, kAlignPhiY, kAlignPhiZ, kAlignX, kAlignZ, kAlpha, MuonResidualsFitter::kPowerLawTails, MuonResidualsFitter::kPureGaussian2D, kResidGamma, kResidSigma, kResSlopeGamma, kResSlopeSigma, MuonResidualsFitter::kROOTVoigt, MuonResiduals6DOFrphiFitter_FCN(), mergeVDriftHistosByStation::name, names, pileupDistInMC::num, funct::pow(), MuonResidualsFitter::residualsModel(), mathSSE::sqrt(), command_line::start, relval_machine::steps, AlCaHLTBitMon_QueryRunRegistry::string, sumofweights(), MuonResidualsFitter::useRes(), PV3DBase< T, PVType, FrameType >::x(), and PV3DBase< T, PVType, FrameType >::y().

Referenced by trackingPlots.Iteration::modules().

215  {
216  //cscGeometry = m_cscGeometry;
217  //cscDetId = CSCDetId(ali->geomDetId().rawId());
218 
219 #ifndef STANDALONE_FITTER
220  csc_R = sqrt(pow(ali->globalPosition().x(), 2) + pow(ali->globalPosition().y(), 2));
221 #else
222  csc_R = 200; // not important what number it is, as we usually not use the DOF where it matters
223 #endif
224 
225  initialize_table(); // if not already initialized
226  sumofweights();
227 
228  double res_std = 0.5;
229  double resslope_std = 0.002;
230 
231  int nums[10] = {kAlignX,
232  kAlignZ,
233  kAlignPhiX,
234  kAlignPhiY,
235  kAlignPhiZ,
236  kResidSigma,
238  kAlpha,
239  kResidGamma,
241  std::string names[10] = {"AlignX",
242  "AlignZ",
243  "AlignPhiX",
244  "AlignPhiY",
245  "AlignPhiZ",
246  "ResidSigma",
247  "ResSlopeSigma",
248  "Alpha",
249  "ResidGamma",
250  "ResSlopeGamma"};
251  double starts[10] = {0., 0., 0., 0., 0., res_std, resslope_std, 0., 0.1 * res_std, 0.1 * resslope_std};
252  double steps[10] = {
253  0.1, 0.1, 0.001, 0.001, 0.001, 0.001 * res_std, 0.001 * resslope_std, 0.001, 0.01 * res_std, 0.01 * resslope_std};
254  double lows[10] = {0., 0., 0., 0., 0., 0., 0., -1., 0., 0.};
255  double highs[10] = {0., 0., 0., 0., 0., 10., 0.1, 1., 0., 0.};
256 
257  std::vector<int> num(nums, nums + 5);
258  std::vector<std::string> name(names, names + 5);
259  std::vector<double> start(starts, starts + 5);
260  std::vector<double> step(steps, steps + 5);
261  std::vector<double> low(lows, lows + 5);
262  std::vector<double> high(highs, highs + 5);
263 
264  bool add_alpha = (residualsModel() == kPureGaussian2D);
265  bool add_gamma = (residualsModel() == kROOTVoigt || residualsModel() == kPowerLawTails);
266 
267  int idx[4], ni = 0;
268  if (useRes() == k1111 || useRes() == k1110 || useRes() == k1010) {
269  for (ni = 0; ni < 2; ni++)
270  idx[ni] = ni + 5;
271  if (add_alpha)
272  idx[ni++] = 7;
273  else if (add_gamma)
274  for (; ni < 4; ni++)
275  idx[ni] = ni + 6;
276  if (!add_alpha)
277  fix(kAlpha);
278  } else if (useRes() == k1100) {
279  idx[ni++] = 5;
280  if (add_gamma)
281  idx[ni++] = 8;
283  fix(kAlpha);
284  } else if (useRes() == k0010) {
285  idx[ni++] = 6;
286  if (add_gamma)
287  idx[ni++] = 9;
288  fix(kResidSigma);
289  fix(kAlpha);
290  }
291  for (int i = 0; i < ni; i++) {
292  num.push_back(nums[idx[i]]);
293  name.push_back(names[idx[i]]);
294  start.push_back(starts[idx[i]]);
295  step.push_back(steps[idx[i]]);
296  low.push_back(lows[idx[i]]);
297  high.push_back(highs[idx[i]]);
298  }
299 
300  return dofit(&MuonResiduals6DOFrphiFitter_FCN, num, name, start, step, low, high);
301 }
T y() const
Definition: PV3DBase.h:60
const std::string names[nVars_]
bool dofit(void(*fcn)(int &, double *, double &, double *, int), std::vector< int > &parNum, std::vector< std::string > &parName, std::vector< double > &start, std::vector< double > &step, std::vector< double > &low, std::vector< double > &high)
T sqrt(T t)
Definition: SSEVec.h:19
void MuonResiduals6DOFrphiFitter_FCN(int &npar, double *gin, double &fval, double *par, int iflag)
void fix(int parNum, bool dofix=true)
int useRes(int pattern=-1)
const PositionType & globalPosition() const
Return the global position of the object.
Definition: Alignable.h:135
step
Definition: StallMonitor.cc:94
T x() const
Definition: PV3DBase.h:59
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
void MuonResiduals6DOFrphiFitter::inform ( TMinuit *  tMinuit)
overrideprotectedvirtual

Implements MuonResidualsFitter.

Definition at line 194 of file MuonResiduals6DOFrphiFitter.cc.

194 { minuit = tMinuit; }
int MuonResiduals6DOFrphiFitter::ndata ( )
inlineoverridevirtual

Implements MuonResidualsFitter.

Definition at line 62 of file MuonResiduals6DOFrphiFitter.h.

References kNData.

int MuonResiduals6DOFrphiFitter::npar ( )
inlineoverridevirtual
double MuonResiduals6DOFrphiFitter::plot ( std::string  name,
TFileDirectory dir,
Alignable ali 
)
overridevirtual

Implements MuonResidualsFitter.

Definition at line 303 of file MuonResiduals6DOFrphiFitter.cc.

References a, cms::cuda::assert(), b, HLT_FULL_cff::chi2, MuonResidualsFitter::errorerror(), mps_fire::i, kAlignPhiX, kAlignPhiY, kAlignPhiZ, kAlignX, kAlignY, kAlignZ, kAlpha, kAngleX, kAngleY, MuonResidualsFitter::kGaussPowerTails, kPositionX, kPositionY, MuonResidualsFitter::kPowerLawTails, MuonResidualsFitter::kPureGaussian, MuonResidualsFitter::kPureGaussian2D, kRedChi2, kResid, kResidGamma, kResidSigma, kResSlope, kResSlopeGamma, kResSlopeSigma, MuonResidualsFitter::kROOTVoigt, AlignableSurface::length(), MuonResidualsFitter::m_weightAlignment, TFileDirectory::make(), MuonResidualsFitter_GaussPowerTails_TF1(), MuonResidualsFitter_powerLawTails_TF1(), MuonResidualsFitter_pureGaussian_TF1(), MuonResidualsFitter_ROOTVoigt_TF1(), ndof, npar(), funct::pow(), alignCSCRings::r, MuonResidualsFitter::residuals_begin(), MuonResidualsFitter::residuals_end(), MuonResidualsFitter::residualsModel(), AlCaHLTBitMon_QueryRunRegistry::string, sumofweights(), Alignable::surface(), MuonResidualsFitter::value(), histoStyle::weight, and AlignableSurface::width().

303  {
304  sumofweights();
305 
306  double mean_residual = 0., mean_resslope = 0.;
307  double mean_trackx = 0., mean_tracky = 0., mean_trackdxdz = 0., mean_trackdydz = 0.;
308  double sum_w = 0.;
309 
310  for (std::vector<double *>::const_iterator rit = residuals_begin(); rit != residuals_end(); ++rit) {
311  const double redchi2 = (*rit)[kRedChi2];
312  double weight = 1. / redchi2;
313  if (!m_weightAlignment)
314  weight = 1.;
315 
316  if (!m_weightAlignment || TMath::Prob(redchi2 * 6, 6) < 0.99) // no spikes allowed
317  {
318  double factor_w = 1. / (sum_w + weight);
319  mean_residual = factor_w * (sum_w * mean_residual + weight * (*rit)[kResid]);
320  mean_resslope = factor_w * (sum_w * mean_resslope + weight * (*rit)[kResSlope]);
321  mean_trackx = factor_w * (sum_w * mean_trackx + weight * (*rit)[kPositionX]);
322  mean_tracky = factor_w * (sum_w * mean_tracky + weight * (*rit)[kPositionY]);
323  mean_trackdxdz = factor_w * (sum_w * mean_trackdxdz + weight * (*rit)[kAngleX]);
324  mean_trackdydz = factor_w * (sum_w * mean_trackdydz + weight * (*rit)[kAngleY]);
325  sum_w += weight;
326  }
327  }
328 
329  std::string name_residual, name_resslope, name_residual_raw, name_resslope_raw, name_residual_cut, name_alpha;
330  std::string name_residual_trackx, name_resslope_trackx;
331  std::string name_residual_tracky, name_resslope_tracky;
332  std::string name_residual_trackdxdz, name_resslope_trackdxdz;
333  std::string name_residual_trackdydz, name_resslope_trackdydz;
334 
335  name_residual = name + "_residual";
336  name_resslope = name + "_resslope";
337  name_residual_raw = name + "_residual_raw";
338  name_resslope_raw = name + "_resslope_raw";
339  name_residual_cut = name + "_residual_cut";
340  name_alpha = name + "_alpha";
341  name_residual_trackx = name + "_residual_trackx";
342  name_resslope_trackx = name + "_resslope_trackx";
343  name_residual_tracky = name + "_residual_tracky";
344  name_resslope_tracky = name + "_resslope_tracky";
345  name_residual_trackdxdz = name + "_residual_trackdxdz";
346  name_resslope_trackdxdz = name + "_resslope_trackdxdz";
347  name_residual_trackdydz = name + "_residual_trackdydz";
348  name_resslope_trackdydz = name + "_resslope_trackdydz";
349 
350  double width = ali->surface().width();
351  double length = ali->surface().length();
352  int bins_residual = 100, bins_resslope = 100;
353  double min_residual = -50., max_residual = 50.;
354  double min_resslope = -50., max_resslope = 50.;
355  double min_trackx = -width / 2., max_trackx = width / 2.;
356  double min_tracky = -length / 2., max_tracky = length / 2.;
357  double min_trackdxdz = -1.5, max_trackdxdz = 1.5;
358  double min_trackdydz = -1.5, max_trackdydz = 1.5;
359 
360  TH1F *hist_residual = dir->make<TH1F>(name_residual.c_str(), "", bins_residual, min_residual, max_residual);
361  TH1F *hist_resslope = dir->make<TH1F>(name_resslope.c_str(), "", bins_resslope, min_resslope, max_resslope);
362  TH1F *hist_residual_raw = dir->make<TH1F>(name_residual_raw.c_str(), "", bins_residual, min_residual, max_residual);
363  TH1F *hist_resslope_raw = dir->make<TH1F>(name_resslope_raw.c_str(), "", bins_resslope, min_resslope, max_resslope);
364  TH1F *hist_residual_cut = dir->make<TH1F>(name_residual_cut.c_str(), "", bins_residual, min_residual, max_residual);
365  TH2F *hist_alpha = dir->make<TH2F>(name_alpha.c_str(), "", 50, min_resslope, max_resslope, 50, -50., 50.);
366 
367  TProfile *hist_residual_trackx =
368  dir->make<TProfile>(name_residual_trackx.c_str(), "", 50, min_trackx, max_trackx, min_residual, max_residual);
369  TProfile *hist_resslope_trackx =
370  dir->make<TProfile>(name_resslope_trackx.c_str(), "", 50, min_trackx, max_trackx, min_resslope, max_resslope);
371  TProfile *hist_residual_tracky =
372  dir->make<TProfile>(name_residual_tracky.c_str(), "", 50, min_tracky, max_tracky, min_residual, max_residual);
373  TProfile *hist_resslope_tracky =
374  dir->make<TProfile>(name_resslope_tracky.c_str(), "", 50, min_tracky, max_tracky, min_resslope, max_resslope);
375  TProfile *hist_residual_trackdxdz = dir->make<TProfile>(
376  name_residual_trackdxdz.c_str(), "", 500, min_trackdxdz, max_trackdxdz, min_residual, max_residual);
377  TProfile *hist_resslope_trackdxdz = dir->make<TProfile>(
378  name_resslope_trackdxdz.c_str(), "", 500, min_trackdxdz, max_trackdxdz, min_resslope, max_resslope);
379  TProfile *hist_residual_trackdydz = dir->make<TProfile>(
380  name_residual_trackdydz.c_str(), "", 500, min_trackdydz, max_trackdydz, min_residual, max_residual);
381  TProfile *hist_resslope_trackdydz = dir->make<TProfile>(
382  name_resslope_trackdydz.c_str(), "", 500, min_trackdydz, max_trackdydz, min_resslope, max_resslope);
383 
384  hist_residual_trackx->SetAxisRange(-10., 10., "Y");
385  hist_resslope_trackx->SetAxisRange(-10., 10., "Y");
386  hist_residual_tracky->SetAxisRange(-10., 10., "Y");
387  hist_resslope_tracky->SetAxisRange(-10., 10., "Y");
388  hist_residual_trackdxdz->SetAxisRange(-10., 10., "Y");
389  hist_resslope_trackdxdz->SetAxisRange(-10., 10., "Y");
390  hist_residual_trackdydz->SetAxisRange(-10., 10., "Y");
391  hist_resslope_trackdydz->SetAxisRange(-10., 10., "Y");
392 
393  name_residual += "_fit";
394  name_resslope += "_fit";
395  name_alpha += "_fit";
396  name_residual_trackx += "_fit";
397  name_resslope_trackx += "_fit";
398  name_residual_tracky += "_fit";
399  name_resslope_tracky += "_fit";
400  name_residual_trackdxdz += "_fit";
401  name_resslope_trackdxdz += "_fit";
402  name_residual_trackdydz += "_fit";
403  name_resslope_trackdydz += "_fit";
404 
405  TF1 *fit_residual = nullptr;
406  TF1 *fit_resslope = nullptr;
408  fit_residual = new TF1(name_residual.c_str(), MuonResidualsFitter_pureGaussian_TF1, min_residual, max_residual, 3);
409  fit_residual->SetParameters(
410  sum_of_weights * (max_residual - min_residual) / bins_residual, 10. * value(kAlignX), 10. * value(kResidSigma));
411  const double er_res[3] = {0., 10. * errorerror(kAlignX), 10. * errorerror(kResidSigma)};
412  fit_residual->SetParErrors(er_res);
413  fit_resslope = new TF1(name_resslope.c_str(), MuonResidualsFitter_pureGaussian_TF1, min_resslope, max_resslope, 3);
414  fit_resslope->SetParameters(sum_of_weights * (max_resslope - min_resslope) / bins_resslope,
415  1000. * value(kAlignPhiY),
416  1000. * value(kResSlopeSigma));
417  const double er_resslope[3] = {0., 1000. * errorerror(kAlignPhiY), 1000. * errorerror(kResSlopeSigma)};
418  fit_resslope->SetParErrors(er_resslope);
419  } else if (residualsModel() == kPowerLawTails) {
420  fit_residual = new TF1(name_residual.c_str(), MuonResidualsFitter_powerLawTails_TF1, min_residual, max_residual, 4);
421  fit_residual->SetParameters(sum_of_weights * (max_residual - min_residual) / bins_residual,
422  10. * value(kAlignX),
423  10. * value(kResidSigma),
424  10. * value(kResidGamma));
425  fit_resslope = new TF1(name_resslope.c_str(), MuonResidualsFitter_powerLawTails_TF1, min_resslope, max_resslope, 4);
426  fit_resslope->SetParameters(sum_of_weights * (max_resslope - min_resslope) / bins_resslope,
427  1000. * value(kAlignPhiY),
428  1000. * value(kResSlopeSigma),
429  1000. * value(kResSlopeGamma));
430  } else if (residualsModel() == kROOTVoigt) {
431  fit_residual = new TF1(name_residual.c_str(), MuonResidualsFitter_ROOTVoigt_TF1, min_residual, max_residual, 4);
432  fit_residual->SetParameters(sum_of_weights * (max_residual - min_residual) / bins_residual,
433  10. * value(kAlignX),
434  10. * value(kResidSigma),
435  10. * value(kResidGamma));
436  fit_resslope = new TF1(name_resslope.c_str(), MuonResidualsFitter_ROOTVoigt_TF1, min_resslope, max_resslope, 4);
437  fit_resslope->SetParameters(sum_of_weights * (max_resslope - min_resslope) / bins_resslope,
438  1000. * value(kAlignPhiY),
439  1000. * value(kResSlopeSigma),
440  1000. * value(kResSlopeGamma));
441  } else if (residualsModel() == kGaussPowerTails) {
442  fit_residual =
443  new TF1(name_residual.c_str(), MuonResidualsFitter_GaussPowerTails_TF1, min_residual, max_residual, 3);
444  fit_residual->SetParameters(
445  sum_of_weights * (max_residual - min_residual) / bins_residual, 10. * value(kAlignX), 10. * value(kResidSigma));
446  fit_resslope =
447  new TF1(name_resslope.c_str(), MuonResidualsFitter_GaussPowerTails_TF1, min_resslope, max_resslope, 3);
448  fit_resslope->SetParameters(sum_of_weights * (max_resslope - min_resslope) / bins_resslope,
449  1000. * value(kAlignPhiY),
450  1000. * value(kResSlopeSigma));
451  } else {
452  assert(false);
453  }
454 
455  fit_residual->SetLineColor(2);
456  fit_residual->SetLineWidth(2);
457  fit_residual->Write();
458  fit_resslope->SetLineColor(2);
459  fit_resslope->SetLineWidth(2);
460  fit_resslope->Write();
461 
462  TF1 *fit_alpha = new TF1(name_alpha.c_str(), "[0] + x*[1]", min_resslope, max_resslope);
463  double a = 10. * value(kAlignX), b = 10. * value(kAlpha) / 1000.;
464  if (residualsModel() == kPureGaussian2D) {
465  double sx = 10. * value(kResidSigma), sy = 1000. * value(kResSlopeSigma), r = value(kAlpha);
466  a = mean_residual;
467  b = 0.;
468  if (sx != 0.) {
469  b = 1. / (sy / sx * r);
470  a = -b * mean_resslope;
471  }
472  }
473  fit_alpha->SetParameters(a, b);
474  fit_alpha->SetLineColor(2);
475  fit_alpha->SetLineWidth(2);
476  fit_alpha->Write();
477 
478  TProfile *fit_residual_trackx = dir->make<TProfile>(name_residual_trackx.c_str(), "", 100, min_trackx, max_trackx);
479  TProfile *fit_resslope_trackx = dir->make<TProfile>(name_resslope_trackx.c_str(), "", 100, min_trackx, max_trackx);
480  TProfile *fit_residual_tracky = dir->make<TProfile>(name_residual_tracky.c_str(), "", 100, min_tracky, max_tracky);
481  TProfile *fit_resslope_tracky = dir->make<TProfile>(name_resslope_tracky.c_str(), "", 100, min_tracky, max_tracky);
482  TProfile *fit_residual_trackdxdz =
483  dir->make<TProfile>(name_residual_trackdxdz.c_str(), "", 500, min_trackdxdz, max_trackdxdz);
484  TProfile *fit_resslope_trackdxdz =
485  dir->make<TProfile>(name_resslope_trackdxdz.c_str(), "", 500, min_trackdxdz, max_trackdxdz);
486  TProfile *fit_residual_trackdydz =
487  dir->make<TProfile>(name_residual_trackdydz.c_str(), "", 500, min_trackdydz, max_trackdydz);
488  TProfile *fit_resslope_trackdydz =
489  dir->make<TProfile>(name_resslope_trackdydz.c_str(), "", 500, min_trackdydz, max_trackdydz);
490 
491  fit_residual_trackx->SetLineColor(2);
492  fit_residual_trackx->SetLineWidth(2);
493  fit_resslope_trackx->SetLineColor(2);
494  fit_resslope_trackx->SetLineWidth(2);
495  fit_residual_tracky->SetLineColor(2);
496  fit_residual_tracky->SetLineWidth(2);
497  fit_resslope_tracky->SetLineColor(2);
498  fit_resslope_tracky->SetLineWidth(2);
499  fit_residual_trackdxdz->SetLineColor(2);
500  fit_residual_trackdxdz->SetLineWidth(2);
501  fit_resslope_trackdxdz->SetLineColor(2);
502  fit_resslope_trackdxdz->SetLineWidth(2);
503  fit_residual_trackdydz->SetLineColor(2);
504  fit_residual_trackdydz->SetLineWidth(2);
505  fit_resslope_trackdydz->SetLineColor(2);
506  fit_resslope_trackdydz->SetLineWidth(2);
507 
508  name_residual_trackx += "line";
509  name_resslope_trackx += "line";
510  name_residual_tracky += "line";
511  name_resslope_tracky += "line";
512  name_residual_trackdxdz += "line";
513  name_resslope_trackdxdz += "line";
514  name_residual_trackdydz += "line";
515  name_resslope_trackdydz += "line";
516 
517  TF1 *fitline_residual_trackx = new TF1(name_residual_trackx.c_str(), residual_trackx_TF1, min_trackx, max_trackx, 12);
518  TF1 *fitline_resslope_trackx = new TF1(name_resslope_trackx.c_str(), resslope_trackx_TF1, min_trackx, max_trackx, 12);
519  TF1 *fitline_residual_tracky = new TF1(name_residual_tracky.c_str(), residual_tracky_TF1, min_tracky, max_tracky, 12);
520  TF1 *fitline_resslope_tracky = new TF1(name_resslope_tracky.c_str(), resslope_tracky_TF1, min_tracky, max_tracky, 12);
521  TF1 *fitline_residual_trackdxdz =
522  new TF1(name_residual_trackdxdz.c_str(), residual_trackdxdz_TF1, min_trackdxdz, max_trackdxdz, 12);
523  TF1 *fitline_resslope_trackdxdz =
524  new TF1(name_resslope_trackdxdz.c_str(), resslope_trackdxdz_TF1, min_trackdxdz, max_trackdxdz, 12);
525  TF1 *fitline_residual_trackdydz =
526  new TF1(name_residual_trackdydz.c_str(), residual_trackdydz_TF1, min_trackdydz, max_trackdydz, 12);
527  TF1 *fitline_resslope_trackdydz =
528  new TF1(name_resslope_trackdydz.c_str(), resslope_trackdydz_TF1, min_trackdydz, max_trackdydz, 12);
529 
530  std::vector<TF1 *> fitlines;
531  fitlines.push_back(fitline_residual_trackx);
532  fitlines.push_back(fitline_resslope_trackx);
533  fitlines.push_back(fitline_residual_tracky);
534  fitlines.push_back(fitline_resslope_tracky);
535  fitlines.push_back(fitline_residual_trackdxdz);
536  fitlines.push_back(fitline_resslope_trackdxdz);
537  fitlines.push_back(fitline_residual_trackdydz);
538  fitlines.push_back(fitline_resslope_trackdydz);
539 
540  double fitparameters[12] = {value(kAlignX),
541  value(kAlignY),
542  value(kAlignZ),
543  value(kAlignPhiX),
544  value(kAlignPhiY),
545  value(kAlignPhiZ),
546  mean_trackx,
547  mean_tracky,
548  mean_trackdxdz,
549  mean_trackdydz,
550  value(kAlpha),
551  mean_resslope};
553  fitparameters[10] = 0.;
554 
555  for (std::vector<TF1 *>::const_iterator itr = fitlines.begin(); itr != fitlines.end(); itr++) {
556  (*itr)->SetParameters(fitparameters);
557  (*itr)->SetLineColor(2);
558  (*itr)->SetLineWidth(2);
559  (*itr)->Write();
560  }
561 
562  for (std::vector<double *>::const_iterator resiter = residuals_begin(); resiter != residuals_end(); ++resiter) {
563  const double resid = (*resiter)[kResid];
564  const double resslope = (*resiter)[kResSlope];
565  const double positionX = (*resiter)[kPositionX];
566  const double positionY = (*resiter)[kPositionY];
567  const double angleX = (*resiter)[kAngleX];
568  const double angleY = (*resiter)[kAngleY];
569  const double redchi2 = (*resiter)[kRedChi2];
570  double weight = 1. / redchi2;
571  if (!m_weightAlignment)
572  weight = 1.;
573 
574  if (!m_weightAlignment || TMath::Prob(redchi2 * 6, 6) < 0.99) { // no spikes allowed
575  hist_alpha->Fill(1000. * resslope, 10. * resid);
576 
577  double coeff = value(kAlpha);
579  coeff = 0.;
580  double geom_resid = getResidual(value(kAlignX),
581  value(kAlignY),
582  value(kAlignZ),
583  value(kAlignPhiX),
584  value(kAlignPhiY),
585  value(kAlignPhiZ),
586  positionX,
587  positionY,
588  angleX,
589  angleY,
590  effectiveR(positionX, positionY),
591  coeff,
592  resslope);
593  hist_residual->Fill(10. * (resid - geom_resid + value(kAlignX)), weight);
594  hist_residual_trackx->Fill(positionX, 10. * resid, weight);
595  hist_residual_tracky->Fill(positionY, 10. * resid, weight);
596  hist_residual_trackdxdz->Fill(angleX, 10. * resid, weight);
597  hist_residual_trackdydz->Fill(angleY, 10. * resid, weight);
598  fit_residual_trackx->Fill(positionX, 10. * geom_resid, weight);
599  fit_residual_tracky->Fill(positionY, 10. * geom_resid, weight);
600  fit_residual_trackdxdz->Fill(angleX, 10. * geom_resid, weight);
601  fit_residual_trackdydz->Fill(angleY, 10. * geom_resid, weight);
602 
603  double geom_resslope = getResSlope(value(kAlignX),
604  value(kAlignY),
605  value(kAlignZ),
606  value(kAlignPhiX),
607  value(kAlignPhiY),
608  value(kAlignPhiZ),
609  positionX,
610  positionY,
611  angleX,
612  angleY,
613  effectiveR(positionX, positionY));
614  hist_resslope->Fill(1000. * (resslope - geom_resslope + value(kAlignPhiY)), weight);
615  hist_resslope_trackx->Fill(positionX, 1000. * resslope, weight);
616  hist_resslope_tracky->Fill(positionY, 1000. * resslope, weight);
617  hist_resslope_trackdxdz->Fill(angleX, 1000. * resslope, weight);
618  hist_resslope_trackdydz->Fill(angleY, 1000. * resslope, weight);
619  fit_resslope_trackx->Fill(positionX, 1000. * geom_resslope, weight);
620  fit_resslope_tracky->Fill(positionY, 1000. * geom_resslope, weight);
621  fit_resslope_trackdxdz->Fill(angleX, 1000. * geom_resslope, weight);
622  fit_resslope_trackdydz->Fill(angleY, 1000. * geom_resslope, weight);
623  }
624 
625  hist_residual_raw->Fill(10. * resid);
626  hist_resslope_raw->Fill(1000. * resslope);
627  if (fabs(resslope) < 0.005)
628  hist_residual_cut->Fill(10. * resid);
629  }
630 
631  double chi2 = 0.;
632  double ndof = 0.;
633  for (int i = 1; i <= hist_residual->GetNbinsX(); i++) {
634  double xi = hist_residual->GetBinCenter(i);
635  double yi = hist_residual->GetBinContent(i);
636  double yerri = hist_residual->GetBinError(i);
637  double yth = fit_residual->Eval(xi);
638  if (yerri > 0.) {
639  chi2 += pow((yth - yi) / yerri, 2);
640  ndof += 1.;
641  }
642  }
643  for (int i = 1; i <= hist_resslope->GetNbinsX(); i++) {
644  double xi = hist_resslope->GetBinCenter(i);
645  double yi = hist_resslope->GetBinContent(i);
646  double yerri = hist_resslope->GetBinError(i);
647  double yth = fit_resslope->Eval(xi);
648  if (yerri > 0.) {
649  chi2 += pow((yth - yi) / yerri, 2);
650  ndof += 1.;
651  }
652  }
653  ndof -= npar();
654 
655  return (ndof > 0. ? chi2 / ndof : -1.);
656 }
align::Scalar width() const
std::vector< double * >::const_iterator residuals_begin() const
Double_t MuonResidualsFitter_powerLawTails_TF1(Double_t *xvec, Double_t *par)
double value(int parNum)
assert(be >=bs)
Double_t MuonResidualsFitter_GaussPowerTails_TF1(Double_t *xvec, Double_t *par)
T * make(const Args &...args) const
make new ROOT object
const AlignableSurface & surface() const
Return the Surface (global position and orientation) of the object.
Definition: Alignable.h:132
Double_t MuonResidualsFitter_pureGaussian_TF1(Double_t *xvec, Double_t *par)
align::Scalar length() const
double errorerror(int parNum)
double b
Definition: hdecay.h:118
double a
Definition: hdecay.h:119
std::vector< double * >::const_iterator residuals_end() const
int weight
Definition: histoStyle.py:51
Double_t MuonResidualsFitter_ROOTVoigt_TF1(Double_t *xvec, Double_t *par)
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
TTree * MuonResiduals6DOFrphiFitter::readNtuple ( std::string  fname,
unsigned int  endcap,
unsigned int  station,
unsigned int  ring,
unsigned int  chamber,
unsigned int  preselected = 1 
)

Definition at line 658 of file MuonResiduals6DOFrphiFitter.cc.

References MuonResidualsFitter::MuonAlignmentTreeRow::angle_x, MuonResidualsFitter::MuonAlignmentTreeRow::angle_y, cms::cuda::assert(), validate-o2o-wbm::f, MuonResidualsFitter::fill(), mps_fire::i, kAngleX, kAngleY, kCharge, kNData, kPositionX, kPositionY, kPt, kPz, kRedChi2, kResid, kResSlope, MuonResidualsFitter::MuonAlignmentTreeRow::pos_x, MuonResidualsFitter::MuonAlignmentTreeRow::pos_y, MuonResidualsFitter::MuonAlignmentTreeRow::pt, MuonResidualsFitter::MuonAlignmentTreeRow::pz, MuonResidualsFitter::MuonAlignmentTreeRow::q, alignCSCRings::r, MuonResidualsFitter::MuonAlignmentTreeRow::res_slope_x, MuonResidualsFitter::MuonAlignmentTreeRow::res_x, submitPVValidationJobs::t, and groupFilesInBlocks::tt.

663  {
664  TFile *f = new TFile(fname.c_str());
665  TTree *t = (TTree *)f->Get("mual_ttree");
666 
667  // Create new temporary file
668  TFile *tmpf = new TFile("small_tree_fit.root", "recreate");
669  assert(tmpf != nullptr);
670 
671  // filter the tree (temporarily lives in the new file)
672  TTree *tt = t->CopyTree(Form("!is_dt && is_plus==%d && ring_wheel==%d && station==%d && sector==%d && select==%d",
673  2 - endcap,
674  station,
675  ring,
676  chamber,
677  (bool)preselected));
678 
679  MuonAlignmentTreeRow r;
680  tt->SetBranchAddress("res_x", &r.res_x);
681  tt->SetBranchAddress("res_slope_x", &r.res_slope_x);
682  tt->SetBranchAddress("pos_x", &r.pos_x);
683  tt->SetBranchAddress("pos_y", &r.pos_y);
684  tt->SetBranchAddress("angle_x", &r.angle_x);
685  tt->SetBranchAddress("angle_y", &r.angle_y);
686  tt->SetBranchAddress("pz", &r.pz);
687  tt->SetBranchAddress("pt", &r.pt);
688  tt->SetBranchAddress("q", &r.q);
689 
690  Long64_t nentries = tt->GetEntries();
691  for (Long64_t i = 0; i < nentries; i++) {
692  tt->GetEntry(i);
693  double *rdata = new double[MuonResiduals6DOFrphiFitter::kNData];
694  rdata[kResid] = r.res_x;
695  rdata[kResSlope] = r.res_slope_x;
696  rdata[kPositionX] = r.pos_x;
697  rdata[kPositionY] = r.pos_y;
698  rdata[kAngleX] = r.angle_x;
699  rdata[kAngleY] = r.angle_y;
700  rdata[kRedChi2] = 0.1;
701  rdata[kPz] = r.pz;
702  rdata[kPt] = r.pt;
703  rdata[kCharge] = r.q;
704  fill(rdata);
705  }
706  delete f;
707  //delete tmpf;
708  return tt;
709 }
void fill(double *residual)
assert(be >=bs)
string fname
main script
double MuonResiduals6DOFrphiFitter::sumofweights ( )
overridevirtual

Implements MuonResidualsFitter.

Definition at line 196 of file MuonResiduals6DOFrphiFitter.cc.

References kRedChi2, MuonResidualsFitter::m_weightAlignment, MuonResidualsFitter::residuals_begin(), and MuonResidualsFitter::residuals_end().

Referenced by fit(), and plot().

196  {
197  sum_of_weights = 0.;
198  number_of_hits = 0.;
199  weight_alignment = m_weightAlignment;
200  for (std::vector<double *>::const_iterator resiter = residuals_begin(); resiter != residuals_end(); ++resiter) {
201  if (m_weightAlignment) {
202  double redchi2 = (*resiter)[kRedChi2];
203  if (TMath::Prob(redchi2 * 6, 6) < 0.99) { // no spikes allowed
204  sum_of_weights += 1. / redchi2;
205  number_of_hits += 1.;
206  }
207  } else {
208  sum_of_weights += 1.;
209  number_of_hits += 1.;
210  }
211  }
212  return sum_of_weights;
213 }
std::vector< double * >::const_iterator residuals_begin() const
std::vector< double * >::const_iterator residuals_end() const
int MuonResiduals6DOFrphiFitter::type ( ) const
inlineoverridevirtual