diff --git a/packages/belos/kokkos/example/BlockCGKokkosExFile.cpp b/packages/belos/kokkos/example/BlockCGKokkosExFile.cpp index 69792850b82e..9e48e2a7bb67 100644 --- a/packages/belos/kokkos/example/BlockCGKokkosExFile.cpp +++ b/packages/belos/kokkos/example/BlockCGKokkosExFile.cpp @@ -76,7 +76,6 @@ bool success = true; typedef Teuchos::ScalarTraits SCT; typedef SCT::magnitudeType MT; typedef Belos::KokkosMultiVec MV; - typedef Belos::KokkosCrsOperator OP; typedef Belos::MultiVec KMV; typedef Belos::Operator KOP; typedef Belos::MultiVecTraits MVT; diff --git a/packages/belos/kokkos/example/BlockGmresKokkosExFile.cpp b/packages/belos/kokkos/example/BlockGmresKokkosExFile.cpp index ec56e4f42891..d6e8da8f3caa 100644 --- a/packages/belos/kokkos/example/BlockGmresKokkosExFile.cpp +++ b/packages/belos/kokkos/example/BlockGmresKokkosExFile.cpp @@ -76,7 +76,6 @@ bool success = true; typedef Teuchos::ScalarTraits SCT; typedef SCT::magnitudeType MT; typedef Belos::KokkosMultiVec MV; - typedef Belos::KokkosCrsOperator OP; typedef Belos::MultiVec KMV; typedef Belos::Operator KOP; typedef Belos::MultiVecTraits MVT; diff --git a/packages/belos/src/BelosMinresSolMgr.hpp b/packages/belos/src/BelosMinresSolMgr.hpp index 7bc01bc63077..be756a93e7a5 100644 --- a/packages/belos/src/BelosMinresSolMgr.hpp +++ b/packages/belos/src/BelosMinresSolMgr.hpp @@ -117,7 +117,7 @@ namespace Belos { typedef OperatorTraits OPT; typedef Teuchos::ScalarTraits SCT; typedef typename Teuchos::ScalarTraits::magnitudeType MagnitudeType; - typedef Teuchos::ScalarTraits< MagnitudeType > MT; + typedef Teuchos::ScalarTraits< MagnitudeType > MST; public: @@ -408,7 +408,6 @@ namespace Belos { using Teuchos::rcpFromRef; using Teuchos::EnhancedNumberValidator; typedef MagnitudeType MT; - typedef Teuchos::ScalarTraits MST; // List of parameters accepted by MINRES, and their default values. RCP pl = parameterList ("MINRES"); diff --git a/packages/belos/tpetra/src/BelosTpetraTestFramework.hpp b/packages/belos/tpetra/src/BelosTpetraTestFramework.hpp index e979908f5708..0308395c5adf 100644 --- a/packages/belos/tpetra/src/BelosTpetraTestFramework.hpp +++ b/packages/belos/tpetra/src/BelosTpetraTestFramework.hpp @@ -679,7 +679,6 @@ namespace Belos { typedef local_ordinal_type LO; typedef global_ordinal_type GO; typedef node_type NT; - typedef ::Tpetra::Map map_type; // For a square matrix, we only need a Map for the range of the matrix. RCP pRangeMap = @@ -730,7 +729,6 @@ namespace Belos { typedef typename SparseMatrixType::local_ordinal_type LO; typedef typename SparseMatrixType::global_ordinal_type GO; typedef typename SparseMatrixType::node_type NT; - typedef ::Tpetra::Map map_type; // For a square matrix, we only need a Map for the range of the matrix. RCP pRangeMap = diff --git a/packages/belos/tpetra/src/solvers/Belos_Tpetra_Cg.hpp b/packages/belos/tpetra/src/solvers/Belos_Tpetra_Cg.hpp index 960b7b97aaa5..e2d3d299e764 100644 --- a/packages/belos/tpetra/src/solvers/Belos_Tpetra_Cg.hpp +++ b/packages/belos/tpetra/src/solvers/Belos_Tpetra_Cg.hpp @@ -74,19 +74,19 @@ class Cg: public Krylov { const SolverInput& input) { using std::endl; - using device_type = typename MV::device_type; + using dev_type = typename MV::device_type; using val_type = typename MV::dot_type; - using STS = Kokkos::ArithTraits; - using mag_type = typename STS::mag_type; - using STM = Kokkos::ArithTraits; + using ATS = Kokkos::ArithTraits; + using magnitude_type = typename ATS::mag_type; + using ATM = Kokkos::ArithTraits; - const auto ONE = STS::one (); + const auto ONE = ATS::one (); SolverOutput output {}; // scalars - mag_type PAP; - mag_type alpha; + magnitude_type PAP; + magnitude_type alpha; vec_type P (B.getMap ()); vec_type AP (B.getMap ()); @@ -95,17 +95,17 @@ class Cg: public Krylov { vec_type MR = * (R_MR.getVectorNonConst (1)); // compute initial residual - Kokkos::View r_beta ("results[numVecs]", 2); - mag_type beta_old = STM::zero (); - mag_type r_norm = STM::zero (); - mag_type r_norm_orig = STM::zero (); + Kokkos::View r_beta ("results[numVecs]", 2); + magnitude_type beta_old = ATM::zero (); + magnitude_type r_norm = ATM::zero (); + magnitude_type r_norm_orig = ATM::zero (); A.apply (X, R); R.update (ONE, B, -ONE); if (input.precoSide == "none") { // no preconditioner Tpetra::deep_copy (P, R); - beta_old = STS::real (R.dot (R)); + beta_old = ATS::real (R.dot (R)); r_norm = beta_old; } else { @@ -117,14 +117,14 @@ class Cg: public Krylov { //TODO: idot is used for now. auto req = Tpetra::idot (r_beta, R_MR, R); req->wait (); - r_norm = STS::real (r_beta(0)); - beta_old = STS::real (r_beta(1)); + r_norm = ATS::real (r_beta(0)); + beta_old = ATS::real (r_beta(1)); } r_norm = std::sqrt (r_norm); r_norm_orig = r_norm; // quick-return - mag_type metric = + magnitude_type metric = this->getConvergenceMetric (r_norm, r_norm_orig, input); if (metric <= input.tol) { if (outPtr != nullptr) { @@ -132,14 +132,14 @@ class Cg: public Krylov { << " meets tolerance " << input.tol << endl; } output.absResid = r_norm; - output.relResid = STM::one (); + output.relResid = ATM::one (); output.numIters = 0; output.converged = true; return output; } // main loop - mag_type beta_new = STM::zero (); + magnitude_type beta_new = ATM::zero (); for (int iter = 0; iter < input.maxNumIters; ++iter) { if (outPtr != nullptr) { *outPtr << "Iteration " << (iter+1) << " of " << input.maxNumIters << ":" << endl; @@ -148,13 +148,13 @@ class Cg: public Krylov { } A.apply (P, AP); // AP = A*P - PAP = STS::real (P.dot (AP)); + PAP = ATS::real (P.dot (AP)); if (outPtr != nullptr) { *outPtr << "PAP: " << PAP << endl; } TEUCHOS_TEST_FOR_EXCEPTION - (STS::real (PAP) <= STM::zero (), std::runtime_error, + (ATS::real (PAP) <= ATM::zero (), std::runtime_error, "At iteration " << (iter+1) << " out of " << input.maxNumIters << ", P.dot(AP) = " << PAP << " <= 0. This usually means that " "the matrix A is not symmetric (Hermitian) positive definite."); @@ -168,7 +168,7 @@ class Cg: public Krylov { R.update (static_cast (-alpha), AP, ONE); // R = R - alpha*AP if (input.precoSide == "none") { // no preconditioner - beta_new = STS::real (R.dot (R)); + beta_new = ATS::real (R.dot (R)); r_norm = beta_new; } else { @@ -176,8 +176,8 @@ class Cg: public Krylov { //TODO: idot is used to compute [MR, R]'*[R] for now. auto req = Tpetra::idot (r_beta, R_MR, R); req->wait (); - r_norm = STS::real (r_beta(0)); - beta_new = STS::real (r_beta(1)); + r_norm = ATS::real (r_beta(0)); + beta_new = ATS::real (r_beta(1)); } r_norm = std::sqrt (r_norm); metric = this->getConvergenceMetric (r_norm, r_norm_orig, input); @@ -195,7 +195,7 @@ class Cg: public Krylov { return output; } else if (iter + 1 < input.maxNumIters) { // not last iteration - const mag_type beta = beta_new / beta_old; + const magnitude_type beta = beta_new / beta_old; if (input.precoSide == "none") { P.update (ONE, R, static_cast (beta)); // P += beta*R } diff --git a/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgPipeline.hpp b/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgPipeline.hpp index 822bc3fd111b..a8046d525a58 100644 --- a/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgPipeline.hpp +++ b/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgPipeline.hpp @@ -74,13 +74,13 @@ class CgPipeline : public Krylov { const SolverInput& input) override { using std::endl; - using device_type = typename MV::device_type; + using dev_type = typename MV::device_type; using val_type = typename MV::dot_type; - using STS = Kokkos::ArithTraits; - using mag_type = typename STS::mag_type; - using STM = Kokkos::ArithTraits; + using ATS = Kokkos::ArithTraits; + using magnitude_type = typename ATS::mag_type; + using ATM = Kokkos::ArithTraits; - const auto ONE = STS::one (); + const auto ONE = ATS::one (); SolverOutput output {}; @@ -96,7 +96,7 @@ class CgPipeline : public Krylov { vec_type R2 = * (R_R.getVectorNonConst (1)); // results of [R R]'*[R AR] - Kokkos::View RR_RAR ("results[numVecs]", 2); + Kokkos::View RR_RAR ("results[numVecs]", 2); auto RR_RAR_host = Kokkos::create_mirror_view (RR_RAR); vec_type P (R, Teuchos::Copy); vec_type AP (P.getMap ()); @@ -108,12 +108,12 @@ class CgPipeline : public Krylov { // local vars val_type RAR, PAP; - mag_type alpha = STM::zero (); - mag_type beta = STM::zero (); - mag_type r_norm = STM::zero (); - mag_type r_norm_orig = STM::zero (); - mag_type beta_new = STM::zero (); - mag_type beta_old = STM::zero (); + magnitude_type alpha = ATM::zero (); + magnitude_type beta = ATM::zero (); + magnitude_type r_norm = ATM::zero (); + magnitude_type r_norm_orig = ATM::zero (); + magnitude_type beta_new = ATM::zero (); + magnitude_type beta_old = ATM::zero (); // Initial step if (input.precoSide == "none") { @@ -162,13 +162,13 @@ class CgPipeline : public Krylov { req->wait (); Kokkos::deep_copy (RR_RAR_host, RR_RAR); RAR = RR_RAR_host(1); - beta_new = STS::real (RR_RAR_host(0)); + beta_new = ATS::real (RR_RAR_host(0)); r_norm = std::sqrt( beta_new ); if (iter == 0) { r_norm_orig = r_norm; } - const mag_type metric = + const magnitude_type metric = this->getConvergenceMetric (r_norm, r_norm_orig, input); if (outPtr != nullptr) { *outPtr << ", RAR: " << RAR << ", r_norm: " << r_norm << ", metric: " << metric; @@ -187,8 +187,8 @@ class CgPipeline : public Krylov { } if (iter == 0) { - alpha = beta_new / STS::real (RAR); - beta = STM::zero (); + alpha = beta_new / ATS::real (RAR); + beta = ATM::zero (); } else { // beta @@ -199,14 +199,14 @@ class CgPipeline : public Krylov { // PAP PAP = RAR - beta_new * (beta / alpha); TEUCHOS_TEST_FOR_EXCEPTION - (STS::real (RAR) <= STM::zero (), std::runtime_error, + (ATS::real (RAR) <= ATM::zero (), std::runtime_error, "At iteration " << (iter+1) << " out of " << input.maxNumIters << ", R.dot(AR) = " << RAR << " <= 0. This usually means that the matrix A is not symmetric " "(Hermitian) positive definite."); // alpha - alpha = beta_new / STS::real (PAP); + alpha = beta_new / ATS::real (PAP); } if (outPtr != nullptr) { *outPtr << ", alpha: " << alpha << endl; diff --git a/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgSingleReduce.hpp b/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgSingleReduce.hpp index a93f28f059fe..bc74f08092bc 100644 --- a/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgSingleReduce.hpp +++ b/packages/belos/tpetra/src/solvers/Belos_Tpetra_CgSingleReduce.hpp @@ -74,33 +74,33 @@ class CgSingleReduce: public Krylov { const SolverInput& input) override { using std::endl; - using device_type = typename MV::device_type; - using STS = Teuchos::ScalarTraits; - using mag_type = typename STS::magnitudeType; - using STM = Teuchos::ScalarTraits; + using dev_type = typename MV::device_type; + using ATS = Kokkos::ArithTraits; + using magnitude_type = typename ATS::mag_type; + using ATM = Kokkos::ArithTraits; using dot_type = typename MV::dot_type; - const SC ONE = STS::one (); + const SC ONE = ATS::one (); SolverOutput output {}; // compute initial residual vec_type MR (B.getMap ()); - mag_type beta_old = STM::zero (); + magnitude_type beta_old = ATM::zero (); if (input.precoSide == "none") { - beta_old = STS::real (B.dot (B)); + beta_old = ATS::real (B.dot (B)); } else { M.apply (B, MR); - beta_old = STS::real (B.dot (MR)); + beta_old = ATS::real (B.dot (MR)); } - mag_type r_norm = std::sqrt (beta_old); - mag_type r_norm_orig = r_norm; + magnitude_type r_norm = std::sqrt (beta_old); + magnitude_type r_norm_orig = r_norm; // quick return - mag_type metric = this->getConvergenceMetric (r_norm, r_norm_orig, input); + magnitude_type metric = this->getConvergenceMetric (r_norm, r_norm_orig, input); if (metric <= input.tol) { output.absResid = r_norm; - output.relResid = STM::one (); + output.relResid = ATM::one (); output.numIters = 0; output.converged = true; // R doesn't exist yet, so we don't have to copy R back to B @@ -115,18 +115,18 @@ class CgSingleReduce: public Krylov { vec_type AR = * (R_AR.getVectorNonConst (1)); Tpetra::deep_copy (R, B); // results of [R AR]'*R - mag_type RAR; - Kokkos::View RR_RAR ("results[numVecs]", 2); + magnitude_type RAR; + Kokkos::View RR_RAR ("results[numVecs]", 2); auto RR_RAR_host = Kokkos::create_mirror_view (RR_RAR); vec_type P (R, Teuchos::Copy); vec_type AP (P.getMap ()); // Initial step // AR = A*R - mag_type PAP; + magnitude_type PAP; if (input.precoSide == "none") { A.apply (R, AR); - PAP = STS::real (R.dot (AR)); + PAP = ATS::real (R.dot (AR)); } else { M.apply (R, MR); @@ -140,14 +140,14 @@ class CgSingleReduce: public Krylov { req->wait (); Kokkos::deep_copy (RR_RAR_host, RR_RAR); - beta_old = STS::real (RR_RAR_host(0)); - PAP = STS::real (RR_RAR_host(1)); + beta_old = ATS::real (RR_RAR_host(0)); + PAP = ATS::real (RR_RAR_host(1)); r_norm = std::sqrt (beta_old); } - mag_type alpha = beta_old / PAP; - mag_type beta = STM::zero (); - mag_type beta_new = STM::zero (); + magnitude_type alpha = beta_old / PAP; + magnitude_type beta = ATM::zero (); + magnitude_type beta_new = ATM::zero (); // main loop for (int iter = 0; iter < input.maxNumIters; ++iter) { if (outPtr != nullptr) { @@ -191,8 +191,8 @@ class CgSingleReduce: public Krylov { } // * all-reduce * Kokkos::deep_copy (RR_RAR_host, RR_RAR); - beta_new = STS::real (RR_RAR_host(0)); - RAR = STS::real (RR_RAR_host(1)); + beta_new = ATS::real (RR_RAR_host(0)); + RAR = ATS::real (RR_RAR_host(1)); // convergence check r_norm = std::sqrt( beta_new ); @@ -221,7 +221,7 @@ class CgSingleReduce: public Krylov { // PAP PAP = RAR - beta_new * (beta /alpha); TEUCHOS_TEST_FOR_EXCEPTION - (RAR <= STM::zero (), std::runtime_error, "At iteration " << (iter+1) + (RAR <= ATM::zero (), std::runtime_error, "At iteration " << (iter+1) << " out of " << input.maxNumIters << ", R.dot(AR) = " << RAR << " <= 0. This usually means that the matrix A is not symmetric " "(Hermitian) positive definite."); diff --git a/packages/nox/src-loca/src-lapack/LOCA_BorderedSolver_LAPACKDirectSolve.C b/packages/nox/src-loca/src-lapack/LOCA_BorderedSolver_LAPACKDirectSolve.C index ef3fb28fac44..243626aa03b6 100644 --- a/packages/nox/src-loca/src-lapack/LOCA_BorderedSolver_LAPACKDirectSolve.C +++ b/packages/nox/src-loca/src-lapack/LOCA_BorderedSolver_LAPACKDirectSolve.C @@ -533,18 +533,18 @@ LOCA::BorderedSolver::LAPACKDirectSolve::solve( NOX::Abstract::MultiVector& X, NOX::Abstract::MultiVector::DenseMatrix& Y) const { - bool isZeroF = (F == NULL); - bool isZeroG = (G == NULL); + bool isZeroF2 = (F == NULL); + bool isZeroG2 = (G == NULL); // If F & G are zero, the solution is zero - if (isZeroF && isZeroG) { + if (isZeroF2 && isZeroG2) { X.init(0.0); Y.putScalar(0.0); return NOX::Abstract::Group::Ok; } int numColsRHS; - if (!isZeroF) + if (!isZeroF2) numColsRHS = F->numVectors(); else numColsRHS = G->numCols(); @@ -556,7 +556,7 @@ LOCA::BorderedSolver::LAPACKDirectSolve::solve( // Concatenate F & G into a single matrix NOX::LAPACK::Matrix RHS(N,numColsRHS); - if (isZeroF) { + if (isZeroF2) { for (int j=0; j(F); TEUCHOS_ASSERT(cF != NULL); F_real = cF->getRealMultiVec(); @@ -618,7 +618,7 @@ LOCA::BorderedSolver::LAPACKDirectSolve::solve( // Concatenate F & G into a single matrix NOX::LAPACK::Matrix< std::complex > RHS(N,numColsRHS); - if (isZeroF) { + if (isZeroF2) { for (int j=0; j((*v1)(i), (*v2)(i)); } } - if (isZeroG) { + if (isZeroG2) { for (int j=0; j& global_data, - double perturb) : + double _perturb) : globalData(global_data), - perturb(perturb) + perturb(_perturb) { // assert (perturb>0.0); } diff --git a/packages/nox/src-loca/src/LOCA_MultiContinuation_ArcLengthGroup.C b/packages/nox/src-loca/src/LOCA_MultiContinuation_ArcLengthGroup.C index e144bb697bad..38f0a4d3d568 100644 --- a/packages/nox/src-loca/src/LOCA_MultiContinuation_ArcLengthGroup.C +++ b/packages/nox/src-loca/src/LOCA_MultiContinuation_ArcLengthGroup.C @@ -60,12 +60,12 @@ LOCA::MultiContinuation::ArcLengthGroup::ArcLengthGroup( const Teuchos::RCP& global_data, const Teuchos::RCP& topParams, - const Teuchos::RCP& continuationParams, + const Teuchos::RCP& _continuationParams, const Teuchos::RCP& grp, const Teuchos::RCP& pred, const std::vector& paramIDs) : LOCA::MultiContinuation::ExtendedGroup(global_data, topParams, - continuationParams, + _continuationParams, grp, pred, paramIDs), theta(paramIDs.size(), 1.0), doArcLengthScaling(true), diff --git a/packages/nox/src-loca/src/LOCA_MultiContinuation_NaturalGroup.C b/packages/nox/src-loca/src/LOCA_MultiContinuation_NaturalGroup.C index 503fb69bd72d..5c44c88ceecf 100644 --- a/packages/nox/src-loca/src/LOCA_MultiContinuation_NaturalGroup.C +++ b/packages/nox/src-loca/src/LOCA_MultiContinuation_NaturalGroup.C @@ -56,12 +56,12 @@ LOCA::MultiContinuation::NaturalGroup::NaturalGroup( const Teuchos::RCP& global_data, const Teuchos::RCP& topParams, - const Teuchos::RCP& continuationParams, + const Teuchos::RCP& _continuationParams, const Teuchos::RCP& grp, const Teuchos::RCP& pred, const std::vector& paramIDs) : LOCA::MultiContinuation::ExtendedGroup(global_data, topParams, - continuationParams, + _continuationParams, grp, pred, paramIDs) { bool skip_dfdp = continuationParams->get("Skip Parameter Derivative", true); diff --git a/packages/nox/src-loca/src/LOCA_TurningPoint_MinimallyAugmented_Constraint.C b/packages/nox/src-loca/src/LOCA_TurningPoint_MinimallyAugmented_Constraint.C index 52204891e0a0..c18e872eac59 100644 --- a/packages/nox/src-loca/src/LOCA_TurningPoint_MinimallyAugmented_Constraint.C +++ b/packages/nox/src-loca/src/LOCA_TurningPoint_MinimallyAugmented_Constraint.C @@ -676,10 +676,10 @@ getInitialVectors(NOX::Abstract::Vector& aVec, std::string("Group must implement LOCA::Abstract::TransposeSolveGroup") + std::string(" to compute initial left null vector")); - Teuchos::RCP lsParams = + Teuchos::RCP lsParams2 = parsedParams->getSublist("Linear Solver"); status = - ts_grp->applyJacobianTransposeInverse(*lsParams, (*fdfdp)[1], aVec); + ts_grp->applyJacobianTransposeInverse(*lsParams2, (*fdfdp)[1], aVec); finalStatus = globalData->locaErrorCheck->combineAndCheckReturnTypes( status, diff --git a/packages/nox/src/NOX_Multiphysics_Solver_FixedPointBased.C b/packages/nox/src/NOX_Multiphysics_Solver_FixedPointBased.C index 8ae0e6c40a27..8ed7b0f0e97c 100644 --- a/packages/nox/src/NOX_Multiphysics_Solver_FixedPointBased.C +++ b/packages/nox/src/NOX_Multiphysics_Solver_FixedPointBased.C @@ -223,14 +223,14 @@ NOX::Multiphysics::Solver::FixedPointBased::step() NOX::Abstract::Group& soln = *solnPtr; NOX::StatusTest::Generic& test = *testPtr; - NOX::StatusTest::StatusType status = NOX::StatusTest::Unconverged; + NOX::StatusTest::StatusType status2 = NOX::StatusTest::Unconverged; std::vector >::iterator iter = (*solversVecPtr).begin(); std::vector >::iterator iter_end = (*solversVecPtr).end(); for( int i = 0; iter_end != iter; ++iter, ++i ) { - status = NOX::StatusTest::Unconverged; + status2 = NOX::StatusTest::Unconverged; // Conditionally bring all data needed from other problems to the current one if( SEIDEL == solveType ) @@ -244,7 +244,7 @@ NOX::Multiphysics::Solver::FixedPointBased::step() (*iter)->reset( sameGrp->getX() ); - status = (*iter)->solve(); + status2 = (*iter)->solve(); // Check return status } @@ -254,9 +254,9 @@ NOX::Multiphysics::Solver::FixedPointBased::step() if (rtype != NOX::Abstract::Group::Ok) { utilsPtr->out() << "NOX::Multiphysics::Solver::FixedPointBased::step - unable to compute F" << std::endl; - status = NOX::StatusTest::Failed; + status2 = NOX::StatusTest::Failed; observer->runPostIterate(*this); - return status; + return status2; } // Update iteration count. @@ -276,12 +276,12 @@ NOX::Multiphysics::Solver::FixedPointBased::step() } // Evaluate the current status. - status = test.checkStatus(*this, checkType); + status2 = test.checkStatus(*this, checkType); observer->runPostIterate(*this); // Return status. - return status; + return status2; } NOX::StatusTest::StatusType diff --git a/packages/stratimikos/adapters/belos/test/LOWSFactory/Thyra_Belos_StatusTest_UnitTests.cpp b/packages/stratimikos/adapters/belos/test/LOWSFactory/Thyra_Belos_StatusTest_UnitTests.cpp index 189e4e041d58..5fde3f118145 100644 --- a/packages/stratimikos/adapters/belos/test/LOWSFactory/Thyra_Belos_StatusTest_UnitTests.cpp +++ b/packages/stratimikos/adapters/belos/test/LOWSFactory/Thyra_Belos_StatusTest_UnitTests.cpp @@ -164,7 +164,6 @@ void runGeneralSolveCriteriaBelosStatusTestCase( using Teuchos::toString; typedef ScalarTraits ST; - typedef typename ST::magnitudeType ScalarMag; // A) Set up the linear system diff --git a/packages/stratimikos/doc/parameterList/createValidParameterList.cpp b/packages/stratimikos/doc/parameterList/createValidParameterList.cpp index 7b34c937e297..41c0624147ad 100644 --- a/packages/stratimikos/doc/parameterList/createValidParameterList.cpp +++ b/packages/stratimikos/doc/parameterList/createValidParameterList.cpp @@ -98,12 +98,12 @@ int main(int argc, char* argv[]) if(parse_return != CommandLineProcessor::PARSE_SUCCESSFUL) return parse_return; - // - // Print the XSL header line if requested - // - if (xsl_header_flag ) - out << "\n"; + // + // Print the XSL header line if requested + // + if (xsl_header_flag ) + out << "\n"; // // Obtain the validated ParameterList and write it to the fancy diff --git a/packages/stratimikos/test/galeri_xpetra_driver.cpp b/packages/stratimikos/test/galeri_xpetra_driver.cpp index 4299bbcae979..4a3bc3c53bd9 100644 --- a/packages/stratimikos/test/galeri_xpetra_driver.cpp +++ b/packages/stratimikos/test/galeri_xpetra_driver.cpp @@ -87,7 +87,6 @@ The source code is not MueLu specific and can be used with any Stratimikos strat template int main_(int argc, char *argv[], Teuchos::CommandLineProcessor& clp) { - typedef Teuchos::ScalarTraits STS; typedef Tpetra::Map<> map_type; typedef map_type::local_ordinal_type LocalOrdinal; typedef map_type::global_ordinal_type GlobalOrdinal;