From a33b681c0170f9edb3b4b9bac97de4f6dd86ee2d Mon Sep 17 00:00:00 2001 From: Jan Kaspar Date: Fri, 21 Aug 2020 11:36:41 +0200 Subject: [PATCH] Improved verbosity control. --- .../interface/StraightTrackAlignment.h | 3 - .../plugins/PPSFastLocalSimulation.cc | 3 - .../python/ppsStraightTrackAligner_cfi.py | 3 +- Alignment/PPSTrackBased/src/IdealResult.cc | 1 - .../src/JanAlignmentAlgorithm.cc | 252 +++++++++--------- .../src/StraightTrackAlignment.cc | 126 ++++----- Alignment/PPSTrackBased/src/Utilities.cc | 5 +- .../test_with_mc/iterations/template_cfg.py | 1 - .../test/test_with_mc/simple/cfg.py | 1 - .../test_with_mc/statistics/template_cfg.py | 1 - 10 files changed, 201 insertions(+), 195 deletions(-) diff --git a/Alignment/PPSTrackBased/interface/StraightTrackAlignment.h b/Alignment/PPSTrackBased/interface/StraightTrackAlignment.h index c4579572a5fab..64e16343e6cee 100644 --- a/Alignment/PPSTrackBased/interface/StraightTrackAlignment.h +++ b/Alignment/PPSTrackBased/interface/StraightTrackAlignment.h @@ -65,9 +65,6 @@ class StraightTrackAlignment /// verbosity level unsigned int verbosity; - /// verbosity level while factorization - unsigned int factorizationVerbosity; - /// list of RPs for which the alignment parameters shall be optimized std::vector rpIds; diff --git a/Alignment/PPSTrackBased/plugins/PPSFastLocalSimulation.cc b/Alignment/PPSTrackBased/plugins/PPSFastLocalSimulation.cc index 35b63255a0b34..0739d4d10d066 100644 --- a/Alignment/PPSTrackBased/plugins/PPSFastLocalSimulation.cc +++ b/Alignment/PPSTrackBased/plugins/PPSFastLocalSimulation.cc @@ -315,15 +315,12 @@ void PPSFastLocalSimulation::GenerateTrack(unsigned int idx, CLHEP::HepRandomEng Ai = A.Invert(); TVectorD P(3); P = Ai * B; - //printf(" de z = %f, p1 = %f, p2 = %f\n", P(0), P(1), P(2)); double de_z = P(0); CTPPSGeometry::Vector h_glo(ax * de_z + bx, ay * de_z + by, de_z + z0); - //printf(" h_glo: x = %f, y = %f, z = %f\n", h_glo.x(), h_glo.y(), h_glo.z()); // hit in local coordinates CTPPSGeometry::Vector h_loc = geometry->globalToLocal(detId, h_glo); - //printf(" h_loc: c1 = %f, c2 = %f, c3 = %f\n", h_loc.x(), h_loc.y(), h_loc.z()); // strips if (detId.subdetId() == CTPPSDetId::sdTrackingStrip) diff --git a/Alignment/PPSTrackBased/python/ppsStraightTrackAligner_cfi.py b/Alignment/PPSTrackBased/python/ppsStraightTrackAligner_cfi.py index 9f3c6111f9cac..dd85f24a170e7 100644 --- a/Alignment/PPSTrackBased/python/ppsStraightTrackAligner_cfi.py +++ b/Alignment/PPSTrackBased/python/ppsStraightTrackAligner_cfi.py @@ -1,8 +1,7 @@ import FWCore.ParameterSet.Config as cms ppsStraightTrackAligner = cms.EDAnalyzer("PPSStraightTrackAligner", - verbosity = cms.untracked.uint32(0), - factorizationVerbosity = cms.untracked.uint32(0), + verbosity = cms.untracked.uint32(1), # ---------- input and event selection ---------- diff --git a/Alignment/PPSTrackBased/src/IdealResult.cc b/Alignment/PPSTrackBased/src/IdealResult.cc index e85574f184e8e..cbd5c5970225d 100644 --- a/Alignment/PPSTrackBased/src/IdealResult.cc +++ b/Alignment/PPSTrackBased/src/IdealResult.cc @@ -47,7 +47,6 @@ vector IdealResult::analyze() unsigned int IdealResult::solve(const std::vector &constraints, std::map &results, TDirectory *dir) { - printf(">> IdealResult::Solve\n\tvalues in mm and rad\n"); results.clear(); // determine dimension and offsets diff --git a/Alignment/PPSTrackBased/src/JanAlignmentAlgorithm.cc b/Alignment/PPSTrackBased/src/JanAlignmentAlgorithm.cc index 8f685a375fb18..95962b7c9794c 100644 --- a/Alignment/PPSTrackBased/src/JanAlignmentAlgorithm.cc +++ b/Alignment/PPSTrackBased/src/JanAlignmentAlgorithm.cc @@ -1,9 +1,6 @@ /**************************************************************************** -* -* This is a part of TOTEM offline software. * Authors: * Jan Kašpar (jan.kaspar@gmail.com) -* ****************************************************************************/ #include "FWCore/MessageLogger/interface/MessageLogger.h" @@ -164,8 +161,6 @@ void JanAlignmentAlgorithm::feed(const HitCollection &selection, const LocalTrac double hy = hay * hit->z + hby; double R = m(j) - (hx*C + hy*S); // (standard) residual - //printf("%i\t%i\t%i\t%.3f\n", j, id, idx, measVec[j]); - if (buildDiagnosticPlots) { statistics[id].m_dist->Fill(m(j)); @@ -344,7 +339,7 @@ vector JanAlignmentAlgorithm::analyze() } // analyze symmetricity - if (verbosity > 2) + if (verbosity >= 3) { double maxDiff = 0., maxElem = 0.; for (unsigned int i = 0; i < dim; i++) @@ -396,7 +391,7 @@ vector JanAlignmentAlgorithm::analyze() } } -#if 0 +#if DEBUG // print singular vectors if (singularModes.size() > 0) { @@ -430,7 +425,9 @@ vector JanAlignmentAlgorithm::analyze() unsigned int JanAlignmentAlgorithm::solve(const std::vector &constraints, map &results, TDirectory *dir) { - printf(">> JanAlignmentAlgorithm::Solve\n"); + if (verbosity) + printf(">> JanAlignmentAlgorithm::Solve\n"); + results.clear(); // build C matrix @@ -492,114 +489,130 @@ unsigned int JanAlignmentAlgorithm::solve(const std::vector TMatrixD CS_eigVec = CS_eig.GetEigenVectors(); // check regularity of CS matrix - printf("\n* eigen values of CS and S matrices (events = %u)\n", events); - printf(" # CS norm. CS S norm. S\n"); + if (verbosity >= 2) + { + printf("\n* eigen values of CS and S matrices (events = %u)\n", events); + printf(" # CS norm. CS S norm. S\n"); + } + unsigned int singularModeCount = 0; vector weakModeIdx; for (int i = 0; i < CS_eigVal.GetNrows(); i++) { - double CS_nev = CS_eigVal[i]/events; - printf("%4i%+12.2E%+12.2E", i, CS_eigVal[i], CS_nev); + const double CS_nev = CS_eigVal[i]/events; + if (fabs(CS_nev) < singularLimit) - { singularModeCount++; - printf(" (S)"); - } else { - if (fabs(CS_nev) < weakLimit) - { - weakModeIdx.push_back(i); - printf(" (W)"); - } else { - printf(" "); - } - } - if (i < S_eigVal.GetNrows()) + if (verbosity >= 2) { - double S_nev = S_eigVal[i]/events; - printf("%+12.2E%+12.2E", S_eigVal[i], S_nev); - if (fabs(S_nev) < singularLimit) + printf("%4i%+12.2E%+12.2E", i, CS_eigVal[i], CS_nev); + if (fabs(CS_nev) < singularLimit) + { + singularModeCount++; printf(" (S)"); - else - if (fabs(S_nev) < weakLimit) + } else { + if (fabs(CS_nev) < weakLimit) + { + weakModeIdx.push_back(i); printf(" (W)"); - } + } else { + printf(" "); + } + } - printf("\n"); + if (i < S_eigVal.GetNrows()) + { + double S_nev = S_eigVal[i]/events; + printf("%+12.2E%+12.2E", S_eigVal[i], S_nev); + if (fabs(S_nev) < singularLimit) + printf(" (S)"); + else + if (fabs(S_nev) < weakLimit) + printf(" (W)"); + } + + printf("\n"); + } } - // print weak vectors - if (weakModeIdx.size() > 0) + if (verbosity >= 2) { - unsigned int columns = 10; - unsigned int first = 0; - - while (first < weakModeIdx.size()) + // print weak vectors + if (weakModeIdx.size() > 0) { - unsigned int last = first + columns; - if (last >= weakModeIdx.size()) - last = weakModeIdx.size(); - - printf("\n* CS weak modes\n | "); - for (unsigned int i = first; i < last; i++) - printf("%+10.3E ", CS_eigVal[weakModeIdx[i]]); - printf("\n--- | "); - - for (unsigned int i = first; i < last; i++) - printf("---------- "); - printf("\n"); + unsigned int columns = 10; + unsigned int first = 0; - // determine maximum elements - vector maxs; - for (unsigned int i = first; i < last; i++) + while (first < weakModeIdx.size()) { - double max = 0; - for (unsigned int j = 0; j < dim + constraints.size(); j++) + unsigned int last = first + columns; + if (last >= weakModeIdx.size()) + last = weakModeIdx.size(); + + printf("\n* CS weak modes\n | "); + for (unsigned int i = first; i < last; i++) + printf("%+10.3E ", CS_eigVal[weakModeIdx[i]]); + printf("\n--- | "); + + for (unsigned int i = first; i < last; i++) + printf("---------- "); + printf("\n"); + + // determine maximum elements + vector maxs; + for (unsigned int i = first; i < last; i++) { - double v = fabs(CS_eigVec(weakModeIdx[i], j)); - if (v > max) - max = v; + double max = 0; + for (unsigned int j = 0; j < dim + constraints.size(); j++) + { + double v = fabs(CS_eigVec(weakModeIdx[i], j)); + if (v > max) + max = v; + } + maxs.push_back(max); } - maxs.push_back(max); - } - - for (unsigned int j = 0; j < dim + constraints.size(); j++) - { - printf("%3u | ", j); - for (unsigned int i = first; i < last; i++) + + for (unsigned int j = 0; j < dim + constraints.size(); j++) { - double v = CS_eigVec(weakModeIdx[i], j); - if (fabs(v)/maxs[i-first] > 1E-3) - printf("%+10.3E ", v); - else - printf(" . "); + printf("%3u | ", j); + for (unsigned int i = first; i < last; i++) + { + double v = CS_eigVec(weakModeIdx[i], j); + if (fabs(v)/maxs[i-first] > 1E-3) + printf("%+10.3E ", v); + else + printf(" . "); + } + printf("\n"); } - printf("\n"); - } - first = last; - } - } else - printf("\n* CS has no weak modes\n"); + first = last; + } + } else + printf("\n* CS has no weak modes\n"); + } // check the regularity of C^T E - if (E.GetNcols() == C.GetNcols()) + if (verbosity >= 2) { - TMatrixD CTE(C, TMatrixD::kTransposeMult, E); - print(CTE, "* CTE matrix:"); - const double &det = CTE.Determinant(); - printf("\n* det(CTE) = %E, max(CTE) = %E, det(CTE)/max(CTE) = %E\n\tmax(C) = %E, max(E) = %E, det(CTE)/max(C)/max(E) = %E\n", - det, CTE.Max(), det/CTE.Max(), C.Max(), E.Max(), det/C.Max()/E.Max()); - } else - printf(">> JanAlignmentAlgorithm::Solve > WARNING: C matrix has %u, while E matrix %u columns.\n", C.GetNcols(), E.GetNcols()); + if (E.GetNcols() == C.GetNcols()) + { + TMatrixD CTE(C, TMatrixD::kTransposeMult, E); + print(CTE, "* CTE matrix:"); + const double &det = CTE.Determinant(); + printf("\n* det(CTE) = %E, max(CTE) = %E, det(CTE)/max(CTE) = %E\n\tmax(C) = %E, max(E) = %E, det(CTE)/max(C)/max(E) = %E\n", + det, CTE.Max(), det/CTE.Max(), C.Max(), E.Max(), det/C.Max()/E.Max()); + } else { + printf(">> JanAlignmentAlgorithm::Solve > WARNING: C matrix has %u, while E matrix %u columns.\n", C.GetNcols(), E.GetNcols()); + } + } // stop if CS is singular - if (singularModeCount > 0) + if (singularModeCount > 0 && stopOnSingularModes) { - LogProblem("JanAlignmentAlgorithm") << "\n>> JanAlignmentAlgorithm::Solve > ERROR: There are " - << singularModeCount << " singular modes in CS matrix."; - if (stopOnSingularModes) - return 1; + LogProblem("PPS") << "\n>> JanAlignmentAlgorithm::Solve > ERROR: There are " << singularModeCount << " singular modes in CS matrix. Stopping."; + return 1; } // build MV vector @@ -625,25 +638,27 @@ unsigned int JanAlignmentAlgorithm::solve(const std::vector EM2 = CS2I * S0 * CS2I; TMatrixD EMdiff(EM2 - EM); - //Print(EMdiff, "EMdiff"); - double max1 = -1., max2 = -1., maxDiff = -1.; - for (int i = 0; i < EMdiff.GetNrows(); i++) + if (verbosity >= 3) { - for (int j = 0; j < EMdiff.GetNcols(); j++) + double max1 = -1., max2 = -1., maxDiff = -1.; + for (int i = 0; i < EMdiff.GetNrows(); i++) { - if (maxDiff < fabs(EMdiff(i, j))) - maxDiff = fabs(EMdiff(i, j)); + for (int j = 0; j < EMdiff.GetNcols(); j++) + { + if (maxDiff < fabs(EMdiff(i, j))) + maxDiff = fabs(EMdiff(i, j)); - if (max1 < fabs(EM(i, j))) - max1 = fabs(EM(i, j)); - - if (max2 < fabs(EM2(i, j))) - max2 = fabs(EM2(i, j)); + if (max1 < fabs(EM(i, j))) + max1 = fabs(EM(i, j)); + + if (max2 < fabs(EM2(i, j))) + max2 = fabs(EM2(i, j)); + } } - } - printf("EM max = %E, EM2 max = %E, EM2 - EM max = %E\n", max1, max2, maxDiff); + printf("EM max = %E, EM2 max = %E, EM2 - EM max = %E\n", max1, max2, maxDiff); + } // tests TMatrixD &U = CS_eigVec; @@ -652,38 +667,35 @@ unsigned int JanAlignmentAlgorithm::solve(const std::vector //CSEi = UT * CS * U; //Print(CSEi, "CSEi"); - TMatrixD EMEi(EM); EMEi = UT * EM * U; //Print(EMEi, "*EMEi"); - double max = -1.; - for (int i = 0; i < EMEi.GetNrows(); i++) + if (verbosity >= 3) { - for (int j = 0; j < EMEi.GetNcols(); j++) + double max = -1.; + for (int i = 0; i < EMEi.GetNrows(); i++) { - if (max < EMEi(i, j)) - max = EMEi(i, j); + for (int j = 0; j < EMEi.GetNcols(); j++) + { + if (max < EMEi(i, j)) + max = EMEi(i, j); + } } - } - printf("max = %E\n", max); + printf("max = %E\n", max); + } - /* - double th = max / 100; - for (int i = 0; i < EMEi.GetNrows(); i++) - for (int j = 0; j < EMEi.GetNcols(); j++) - if (th < EMEi(i, j)) - printf("element %u, %u: %E\n", i, j, EMEi(i, j)); - */ - // print lambda values - printf("\n* Lambda (from the contribution of singular modes to MV)\n"); - for (unsigned int i = 0; i < constraints.size(); i++) + if (verbosity >= 3) { - printf("\t%u (%25s)\t%+10.1E +- %10.1E\n", i, constraints[i].name.c_str(), + printf("\n* Lambda (from the contribution of singular modes to MV)\n"); + for (unsigned int i = 0; i < constraints.size(); i++) + { + printf("\t%u (%25s)\t%+10.1E +- %10.1E\n", i, constraints[i].name.c_str(), AL[dim+i]*1E3, sqrt(EM[i+dim][i+dim])*1E3); + } } // fill results diff --git a/Alignment/PPSTrackBased/src/StraightTrackAlignment.cc b/Alignment/PPSTrackBased/src/StraightTrackAlignment.cc index c9926b0c134a6..72e8a49704d54 100644 --- a/Alignment/PPSTrackBased/src/StraightTrackAlignment.cc +++ b/Alignment/PPSTrackBased/src/StraightTrackAlignment.cc @@ -104,7 +104,6 @@ void StraightTrackAlignment::RPSetPlots::write() const StraightTrackAlignment::StraightTrackAlignment(const ParameterSet& ps) : verbosity(ps.getUntrackedParameter("verbosity", 0)), - factorizationVerbosity(ps.getUntrackedParameter("factorizationVerbosity", 0)), rpIds(ps.getParameter< vector >("rpIds")), excludePlanes(ps.getParameter< vector >("excludePlanes")), @@ -700,12 +699,15 @@ void StraightTrackAlignment::finish() printf("%30s :%10lu%10lu\n", label.c_str(), it->second, sv); } - printf("\n* hits per plane:\n"); - for (const auto it : selectedHitsPerPlane) + if (verbosity >= 2) { - printf(" "); - printId(it.first); - printf(" : %u\n", it.second); + printf("\n* hits per plane:\n"); + for (const auto it : selectedHitsPerPlane) + { + printf(" "); + printId(it.first); + printf(" : %u\n", it.second); + } } } @@ -724,10 +726,11 @@ void StraightTrackAlignment::finish() if (taskDataFile) taskDataFile->WriteObject(&constraints, "constraints"); - printf("\n>> StraightTrackAlignment::Finish > %lu constraints built\n", constraints.size()); - for (unsigned int i = 0; i < constraints.size(); i++) + if (verbosity) { - printf("\t%25s\n", constraints[i].name.c_str()); + printf("\n>> StraightTrackAlignment::Finish > %lu constraints built\n", constraints.size()); + for (unsigned int i = 0; i < constraints.size(); i++) + printf("\t%25s\n", constraints[i].name.c_str()); } // solve @@ -747,76 +750,77 @@ void StraightTrackAlignment::finish() } // print results - printf("\n>> StraightTrackAlignment::Finish > Print\n"); - - printLineSeparator(results); - printQuantitiesLine(results); - printAlgorithmsLine(results); - - signed int prevRPId = -1; - - for (const auto &dit : task.geometry.getSensorMap()) + if (verbosity) { - // ═ ║ + printf("\n>> StraightTrackAlignment::Finish > Print\n"); - signed int rpId = CTPPSDetId(dit.first).rpId(); - if (rpId != prevRPId) - printLineSeparator(results); - prevRPId = rpId; + printLineSeparator(results); + printQuantitiesLine(results); + printAlgorithmsLine(results); - printId(dit.first); - printf(" ║"); + signed int prevRPId = -1; - for (unsigned int q = 0; q < task.quantityClasses.size(); q++) + for (const auto &dit : task.geometry.getSensorMap()) { - for (unsigned int a = 0; a < results.size(); a++) + signed int rpId = CTPPSDetId(dit.first).rpId(); + if (rpId != prevRPId) + printLineSeparator(results); + prevRPId = rpId; + + printId(dit.first); + printf(" ║"); + + for (unsigned int q = 0; q < task.quantityClasses.size(); q++) { - const auto it = results[a].find(dit.first); - if (it == results[a].end()) + for (unsigned int a = 0; a < results.size(); a++) { + const auto it = results[a].find(dit.first); + if (it == results[a].end()) + { + if (algorithms[a]->hasErrorEstimate()) + printf("%19s", "----"); + else + printf("%8s", "----"); + + if (a + 1 == results.size()) + printf("║"); + else + printf("│"); + + continue; + } + + const auto &ac = it->second; + double v = 0., e = 0.; + switch (task.quantityClasses[q]) + { + case AlignmentTask::qcShR1: v = ac.getShR1(); e = ac.getShR1Unc(); break; + case AlignmentTask::qcShR2: v = ac.getShR2(); e = ac.getShR2Unc(); break; + case AlignmentTask::qcShZ: v = ac.getShZ(); e = ac.getShZUnc(); break; + case AlignmentTask::qcRotZ: v = ac.getRotZ(); e = ac.getRotZUnc(); break; + } + if (algorithms[a]->hasErrorEstimate()) - printf("%19s", "----"); + printf("%+8.1f ± %7.1f", v*1E3, e*1E3); else - printf("%8s", "----"); + printf("%+8.1f", v*1E3); if (a + 1 == results.size()) printf("║"); else printf("│"); - - continue; - } - - const auto &ac = it->second; - double v = 0., e = 0.; - switch (task.quantityClasses[q]) - { - case AlignmentTask::qcShR1: v = ac.getShR1(); e = ac.getShR1Unc(); break; - case AlignmentTask::qcShR2: v = ac.getShR2(); e = ac.getShR2Unc(); break; - case AlignmentTask::qcShZ: v = ac.getShZ(); e = ac.getShZUnc(); break; - case AlignmentTask::qcRotZ: v = ac.getRotZ(); e = ac.getRotZUnc(); break; } - - if (algorithms[a]->hasErrorEstimate()) - printf("%+8.1f ± %7.1f", v*1E3, e*1E3); - else - printf("%+8.1f", v*1E3); - - if (a + 1 == results.size()) - printf("║"); - else - printf("│"); } + + printf("\n"); } - printf("\n"); + printLineSeparator(results); + printAlgorithmsLine(results); + printQuantitiesLine(results); + printLineSeparator(results); } - printLineSeparator(results); - printAlgorithmsLine(results); - printQuantitiesLine(results); - printLineSeparator(results); - // save results as alignment XML files for (unsigned int a = 0; a < results.size(); a++) { @@ -865,12 +869,12 @@ void StraightTrackAlignment::finish() CTPPSRPAlignmentCorrectionsData expandedAlignments; CTPPSRPAlignmentCorrectionsData factoredAlignments; - if (factorizationVerbosity) + if (verbosity) printf(">> Factorizing results of %s algorithm\n", algorithms[a]->getName().c_str()); const bool equalWeights = false; factorRPFromSensorCorrections(cumulativeAlignments, expandedAlignments, factoredAlignments, - task.geometry, equalWeights, factorizationVerbosity); + task.geometry, equalWeights, verbosity); if (!expandedFileNamePrefix.empty()) { diff --git a/Alignment/PPSTrackBased/src/Utilities.cc b/Alignment/PPSTrackBased/src/Utilities.cc index c80e990c41f34..eda51c8a40041 100644 --- a/Alignment/PPSTrackBased/src/Utilities.cc +++ b/Alignment/PPSTrackBased/src/Utilities.cc @@ -215,8 +215,9 @@ void factorRPFromSensorCorrections(const CTPPSRPAlignmentCorrectionsData &inputA const double m_rot_y = s_rot_y / n_sensors; const double m_rot_z = s_rot_z / n_sensors; - printf(" m_sh_x = %.1f um, m_sh_y = %.1f um, m_sh_z = %.1f mm, m_rot_x = %.1f mrad, m_rot_y = %.1f mrad, m_rot_z = %.1f mrad\n", - m_sh_x*1E3, m_sh_y*1E3, m_sh_z, m_rot_x*1E3, m_rot_y*1E3, m_rot_z*1E3); + if (verbosity) + printf(" m_sh_x = %.1f um, m_sh_y = %.1f um, m_sh_z = %.1f mm, m_rot_x = %.1f mrad, m_rot_y = %.1f mrad, m_rot_z = %.1f mrad\n", + m_sh_x*1E3, m_sh_y*1E3, m_sh_z, m_rot_x*1E3, m_rot_y*1E3, m_rot_z*1E3); factoredAlignments.addRPCorrection(rpId, CTPPSRPAlignmentCorrectionData(m_sh_x, m_sh_y, m_sh_z, m_rot_x, m_rot_y, m_rot_z)); diff --git a/Alignment/PPSTrackBased/test/test_with_mc/iterations/template_cfg.py b/Alignment/PPSTrackBased/test/test_with_mc/iterations/template_cfg.py index b35cf700aedad..2c450d705fbf1 100644 --- a/Alignment/PPSTrackBased/test/test_with_mc/iterations/template_cfg.py +++ b/Alignment/PPSTrackBased/test/test_with_mc/iterations/template_cfg.py @@ -50,7 +50,6 @@ process.load("Alignment.PPSTrackBased.ppsStraightTrackAligner_cfi") process.ppsStraightTrackAligner.verbosity = 1 -process.ppsStraightTrackAligner.factorizationVerbosity = 1 process.ppsStraightTrackAligner.tagUVPatternsStrip = cms.InputTag("totemRPUVPatternFinder") process.ppsStraightTrackAligner.tagDiamondHits = cms.InputTag("") diff --git a/Alignment/PPSTrackBased/test/test_with_mc/simple/cfg.py b/Alignment/PPSTrackBased/test/test_with_mc/simple/cfg.py index fb7c7055e08d6..4a452efcb9e06 100644 --- a/Alignment/PPSTrackBased/test/test_with_mc/simple/cfg.py +++ b/Alignment/PPSTrackBased/test/test_with_mc/simple/cfg.py @@ -49,7 +49,6 @@ process.load("Alignment.PPSTrackBased.ppsStraightTrackAligner_cfi") process.ppsStraightTrackAligner.verbosity = 1 -process.ppsStraightTrackAligner.factorizationVerbosity = 1 process.ppsStraightTrackAligner.tagUVPatternsStrip = cms.InputTag("totemRPUVPatternFinder") process.ppsStraightTrackAligner.tagDiamondHits = cms.InputTag("") diff --git a/Alignment/PPSTrackBased/test/test_with_mc/statistics/template_cfg.py b/Alignment/PPSTrackBased/test/test_with_mc/statistics/template_cfg.py index 12c4aac46e0ae..76c373f1f3b22 100644 --- a/Alignment/PPSTrackBased/test/test_with_mc/statistics/template_cfg.py +++ b/Alignment/PPSTrackBased/test/test_with_mc/statistics/template_cfg.py @@ -49,7 +49,6 @@ process.load("Alignment.PPSTrackBased.ppsStraightTrackAligner_cfi") process.ppsStraightTrackAligner.verbosity = 1 -process.ppsStraightTrackAligner.factorizationVerbosity = 1 process.ppsStraightTrackAligner.tagUVPatternsStrip = cms.InputTag("totemRPUVPatternFinder") process.ppsStraightTrackAligner.tagDiamondHits = cms.InputTag("")