From 56f22d4d5fccf2f986cb747f2c6762883b836f4d Mon Sep 17 00:00:00 2001 From: Sebastian Grimberg Date: Fri, 11 Aug 2023 09:59:58 -0700 Subject: [PATCH] Add custom string->enum parser for JSON values to handle invalid keys and eliminate need for INVALID enums throughout the code --- palace/drivers/transientsolver.cpp | 2 - palace/fem/multigrid.hpp | 3 - palace/linalg/ksp.cpp | 44 ++--- palace/linalg/strumpack.cpp | 2 - palace/main.cpp | 3 - palace/models/lumpedportoperator.cpp | 3 - palace/models/surfacecurrentoperator.cpp | 3 - palace/models/timeoperator.cpp | 3 - palace/utils/configfile.cpp | 203 +++++++++++------------ palace/utils/configfile.hpp | 54 +++--- 10 files changed, 132 insertions(+), 188 deletions(-) diff --git a/palace/drivers/transientsolver.cpp b/palace/drivers/transientsolver.cpp index 9370c2551..270197b91 100644 --- a/palace/drivers/transientsolver.cpp +++ b/palace/drivers/transientsolver.cpp @@ -217,8 +217,6 @@ std::function TransientSolver::GetTimeExcitation(bool dot) const return F{[=](double t) { return pulse_smootherstep(t, data.pulse_tau, delay); }}; } break; - case config::TransientSolverData::ExcitationType::INVALID: - MFEM_ABORT("Unsupported source excitation type!"); } return F{}; } diff --git a/palace/fem/multigrid.hpp b/palace/fem/multigrid.hpp index 188f9164d..31f605e18 100644 --- a/palace/fem/multigrid.hpp +++ b/palace/fem/multigrid.hpp @@ -115,9 +115,6 @@ std::vector> inline ConstructFECollections( case config::LinearSolverData::MultigridCoarsenType::LOGARITHMIC: p = (p + pmin) / 2; break; - case config::LinearSolverData::MultigridCoarsenType::INVALID: - MFEM_ABORT("Invalid coarsening type for p-multigrid levels!"); - break; } } std::reverse(fecs.begin(), fecs.end()); diff --git a/palace/linalg/ksp.cpp b/palace/linalg/ksp.cpp index cc0b87d63..a8b4b15fb 100644 --- a/palace/linalg/ksp.cpp +++ b/palace/linalg/ksp.cpp @@ -64,7 +64,6 @@ std::unique_ptr> ConfigureKrylovSolver(MPI_Comm comm, case config::LinearSolverData::KspType::MINRES: case config::LinearSolverData::KspType::BICGSTAB: case config::LinearSolverData::KspType::DEFAULT: - case config::LinearSolverData::KspType::INVALID: MFEM_ABORT("Unexpected solver type for Krylov solver configuration!"); break; } @@ -73,29 +72,26 @@ std::unique_ptr> ConfigureKrylovSolver(MPI_Comm comm, ksp->SetMaxIter(iodata.solver.linear.max_it); // Configure preconditioning side (only for GMRES). - if (iodata.solver.linear.pc_side_type != config::LinearSolverData::SideType::DEFAULT) + if (iodata.solver.linear.pc_side_type != config::LinearSolverData::SideType::DEFAULT && + type != config::LinearSolverData::KspType::GMRES) { - if (type != config::LinearSolverData::KspType::GMRES) - { - Mpi::Warning( - comm, "Preconditioner side will be ignored for non-GMRES iterative solvers!\n"); - } - else + Mpi::Warning(comm, + "Preconditioner side will be ignored for non-GMRES iterative solvers!\n"); + } + else + { + auto *gmres = static_cast *>(ksp.get()); + switch (iodata.solver.linear.pc_side_type) { - auto *gmres = static_cast *>(ksp.get()); - switch (iodata.solver.linear.pc_side_type) - { - case config::LinearSolverData::SideType::LEFT: - gmres->SetPrecSide(GmresSolver::PrecSide::LEFT); - break; - case config::LinearSolverData::SideType::RIGHT: - gmres->SetPrecSide(GmresSolver::PrecSide::RIGHT); - break; - case config::LinearSolverData::SideType::DEFAULT: - case config::LinearSolverData::SideType::INVALID: - MFEM_ABORT("Unexpected side for configuring preconditioning!"); - break; - } + case config::LinearSolverData::SideType::LEFT: + gmres->SetPrecSide(GmresSolver::PrecSide::LEFT); + break; + case config::LinearSolverData::SideType::RIGHT: + gmres->SetPrecSide(GmresSolver::PrecSide::RIGHT); + break; + case config::LinearSolverData::SideType::DEFAULT: + // Do nothing + break; } } @@ -116,9 +112,6 @@ std::unique_ptr> ConfigureKrylovSolver(MPI_Comm comm, case config::LinearSolverData::OrthogType::CGS2: gmres->SetOrthogonalization(GmresSolver::OrthogType::CGS2); break; - case config::LinearSolverData::OrthogType::INVALID: - MFEM_ABORT("Unexpected orthogonalization type for Krylov solver configuration!"); - break; } } @@ -211,7 +204,6 @@ ConfigurePreconditionerSolver(MPI_Comm comm, const IoData &iodata, #endif break; case config::LinearSolverData::Type::DEFAULT: - case config::LinearSolverData::Type::INVALID: MFEM_ABORT("Unexpected solver type for preconditioner configuration!"); break; } diff --git a/palace/linalg/strumpack.cpp b/palace/linalg/strumpack.cpp index 9073ead71..21b2dc32b 100644 --- a/palace/linalg/strumpack.cpp +++ b/palace/linalg/strumpack.cpp @@ -33,7 +33,6 @@ GetCompressionType(config::LinearSolverData::CompressionType type) return strumpack::CompressionType::ZFP_BLR_HODLR; break; case config::LinearSolverData::CompressionType::NONE: - case config::LinearSolverData::CompressionType::INVALID: return strumpack::CompressionType::NONE; } return strumpack::CompressionType::NONE; // For compiler warning @@ -100,7 +99,6 @@ StrumpackSolverBase::StrumpackSolverBase( this->SetCompressionRelTol(lr_tol); break; case config::LinearSolverData::CompressionType::NONE: - case config::LinearSolverData::CompressionType::INVALID: break; } } diff --git a/palace/main.cpp b/palace/main.cpp index 071a935bd..27c49cd1d 100644 --- a/palace/main.cpp +++ b/palace/main.cpp @@ -176,9 +176,6 @@ int main(int argc, char *argv[]) solver = std::make_unique(iodata, world_root, world_size, num_thread, git_tag); break; - case config::ProblemData::Type::INVALID: - Mpi::Print(world_comm, "Error: Unsupported problem type!\n\n"); - return 1; } // Read the mesh from file, refine, partition, and distribute it. Then nondimensionalize diff --git a/palace/models/lumpedportoperator.cpp b/palace/models/lumpedportoperator.cpp index 34e297eac..e706ee007 100644 --- a/palace/models/lumpedportoperator.cpp +++ b/palace/models/lumpedportoperator.cpp @@ -63,9 +63,6 @@ LumpedPortData::LumpedPortData(const config::LumpedPortData &data, elems.push_back( std::make_unique(elem.direction, attr_marker, h1_fespace)); break; - case config::internal::ElementData::CoordinateSystem::INVALID: - MFEM_ABORT("Unexpected coordinate system for lumped port direction!"); - break; } } diff --git a/palace/models/surfacecurrentoperator.cpp b/palace/models/surfacecurrentoperator.cpp index 14fddaaf7..84e680b8a 100644 --- a/palace/models/surfacecurrentoperator.cpp +++ b/palace/models/surfacecurrentoperator.cpp @@ -32,9 +32,6 @@ SurfaceCurrentData::SurfaceCurrentData(const config::SurfaceCurrentData &data, elems.push_back( std::make_unique(elem.direction, attr_marker, h1_fespace)); break; - case config::internal::ElementData::CoordinateSystem::INVALID: - MFEM_ABORT("Unexpected coordinate system for surface current source direction!"); - break; } } } diff --git a/palace/models/timeoperator.cpp b/palace/models/timeoperator.cpp index 354645ed8..1758c81fb 100644 --- a/palace/models/timeoperator.cpp +++ b/palace/models/timeoperator.cpp @@ -177,9 +177,6 @@ TimeOperator::TimeOperator(const IoData &iodata, SpaceOperator &spaceop, type = mfem::TimeDependentOperator::EXPLICIT; } break; - case config::TransientSolverData::Type::INVALID: - MFEM_ABORT("Invalid transient solver type!"); - break; } // Set up time-dependent operator for 2nd-order curl-curl equation for E. diff --git a/palace/utils/configfile.cpp b/palace/utils/configfile.cpp index 7308e8cb5..5cb31f1b7 100644 --- a/palace/utils/configfile.cpp +++ b/palace/utils/configfile.cpp @@ -7,6 +7,36 @@ #include #include +// This is similar to NLOHMANN_JSON_SERIALIZE_ENUM, but results in an error if an enum +// value corresponding to the string cannot be found. +#define PALACE_JSON_SERIALIZE_ENUM(ENUM_TYPE, ...) \ + template \ + inline void to_json(BasicJsonType &j, const ENUM_TYPE &e) \ + { \ + static_assert(std::is_enum::value, #ENUM_TYPE " must be an enum!"); \ + static const std::pair m[] = __VA_ARGS__; \ + auto it = std::find_if(std::begin(m), std::end(m), \ + [e](const std::pair &ej_pair) \ + { return ej_pair.first == e; }); \ + MFEM_VERIFY(it != std::end(m), \ + "Invalid value for " << #ENUM_TYPE " given when parsing to JSON!"); \ + j = it->second; \ + } \ + template \ + inline void from_json(const BasicJsonType &j, ENUM_TYPE &e) \ + { \ + static_assert(std::is_enum::value, #ENUM_TYPE " must be an enum!"); \ + static const std::pair m[] = __VA_ARGS__; \ + auto it = std::find_if(std::begin(m), std::end(m), \ + [j](const std::pair &ej_pair) \ + { return ej_pair.second == j; }); \ + MFEM_VERIFY(it != std::end(m), \ + "Invalid value (" \ + << j << ") for " \ + << #ENUM_TYPE " given in configuration file when parsing from JSON!"); \ + e = it->first; \ + } + namespace palace::config { @@ -35,10 +65,9 @@ void ParseSymmetricMatrixData(json &mat, const std::string &name, } // Helper for converting string keys to enum for internal::ElementData::CoordinateSystem. -NLOHMANN_JSON_SERIALIZE_ENUM( +PALACE_JSON_SERIALIZE_ENUM( internal::ElementData::CoordinateSystem, - {{internal::ElementData::CoordinateSystem::INVALID, nullptr}, - {internal::ElementData::CoordinateSystem::CARTESIAN, "Cartesian"}, + {{internal::ElementData::CoordinateSystem::CARTESIAN, "Cartesian"}, {internal::ElementData::CoordinateSystem::CYLINDRICAL, "Cylindrical"}}) // Helper function for extracting element data from the configuration file, either from a @@ -54,9 +83,6 @@ void ParseElementData(json &elem, const std::string &name, bool required, // Attempt to parse as an array. data.direction = it->get>(); data.coordinate_system = elem.value("CoordinateSystem", data.coordinate_system); - MFEM_VERIFY(data.coordinate_system != internal::ElementData::CoordinateSystem::INVALID, - "Invalid value for config[\"" - << name << "\"][\"CoordinateSystem\"] in configuration file!"); } else { @@ -183,13 +209,12 @@ std::ostream &operator<<(std::ostream &os, const SymmetricMatrixData &data) } // namespace // Helper for converting string keys to enum for ProblemData::Type. -NLOHMANN_JSON_SERIALIZE_ENUM(ProblemData::Type, - {{ProblemData::Type::INVALID, nullptr}, - {ProblemData::Type::DRIVEN, "Driven"}, - {ProblemData::Type::EIGENMODE, "Eigenmode"}, - {ProblemData::Type::ELECTROSTATIC, "Electrostatic"}, - {ProblemData::Type::MAGNETOSTATIC, "Magnetostatic"}, - {ProblemData::Type::TRANSIENT, "Transient"}}) +PALACE_JSON_SERIALIZE_ENUM(ProblemData::Type, + {{ProblemData::Type::DRIVEN, "Driven"}, + {ProblemData::Type::EIGENMODE, "Eigenmode"}, + {ProblemData::Type::ELECTROSTATIC, "Electrostatic"}, + {ProblemData::Type::MAGNETOSTATIC, "Magnetostatic"}, + {ProblemData::Type::TRANSIENT, "Transient"}}) void ProblemData::SetUp(json &config) { @@ -199,8 +224,6 @@ void ProblemData::SetUp(json &config) MFEM_VERIFY(problem->find("Type") != problem->end(), "Missing config[\"Problem\"][\"Type\"] in configuration file!"); type = problem->at("Type"); // Required - MFEM_VERIFY(type != ProblemData::Type::INVALID, - "Invalid value for config[\"Problem\"][\"Type\"] in configuration file!"); verbose = problem->value("Verbose", verbose); output = problem->value("Output", output); @@ -1373,12 +1396,11 @@ void DrivenSolverData::SetUp(json &solver) } // Helper for converting string keys to enum for EigenSolverData::Type. -NLOHMANN_JSON_SERIALIZE_ENUM(EigenSolverData::Type, - {{EigenSolverData::Type::INVALID, nullptr}, - {EigenSolverData::Type::ARPACK, "ARPACK"}, - {EigenSolverData::Type::SLEPC, "SLEPc"}, - {EigenSolverData::Type::FEAST, "FEAST"}, - {EigenSolverData::Type::DEFAULT, "Default"}}) +PALACE_JSON_SERIALIZE_ENUM(EigenSolverData::Type, + {{EigenSolverData::Type::DEFAULT, "Default"}, + {EigenSolverData::Type::SLEPC, "SLEPc"}, + {EigenSolverData::Type::ARPACK, "ARPACK"}, + {EigenSolverData::Type::FEAST, "FEAST"}}) void EigenSolverData::SetUp(json &solver) { @@ -1396,8 +1418,6 @@ void EigenSolverData::SetUp(json &solver) n = eigenmode->value("N", n); n_post = eigenmode->value("Save", n_post); type = eigenmode->value("Type", type); - MFEM_VERIFY(type != EigenSolverData::Type::INVALID, - "Invalid value for config[\"Eigenmode\"][\"Type\"] in configuration file!"); pep_linear = eigenmode->value("PEPLinear", pep_linear); feast_contour_np = eigenmode->value("ContourNPoints", feast_contour_np); if (type == EigenSolverData::Type::FEAST && feast_contour_np > 1) @@ -1495,17 +1515,14 @@ void MagnetostaticSolverData::SetUp(json &solver) // Helper for converting string keys to enum for TransientSolverData::Type and // TransientSolverData::ExcitationType. -NLOHMANN_JSON_SERIALIZE_ENUM(TransientSolverData::Type, - {{TransientSolverData::Type::INVALID, nullptr}, - {TransientSolverData::Type::GEN_ALPHA, "GeneralizedAlpha"}, - {TransientSolverData::Type::NEWMARK, "NewmarkBeta"}, - {TransientSolverData::Type::CENTRAL_DIFF, - "CentralDifference"}, - {TransientSolverData::Type::DEFAULT, "Default"}}) -NLOHMANN_JSON_SERIALIZE_ENUM( +PALACE_JSON_SERIALIZE_ENUM(TransientSolverData::Type, + {{TransientSolverData::Type::DEFAULT, "Default"}, + {TransientSolverData::Type::GEN_ALPHA, "GeneralizedAlpha"}, + {TransientSolverData::Type::NEWMARK, "NewmarkBeta"}, + {TransientSolverData::Type::CENTRAL_DIFF, "CentralDifference"}}) +PALACE_JSON_SERIALIZE_ENUM( TransientSolverData::ExcitationType, - {{TransientSolverData::ExcitationType::INVALID, nullptr}, - {TransientSolverData::ExcitationType::SINUSOIDAL, "Sinusoidal"}, + {{TransientSolverData::ExcitationType::SINUSOIDAL, "Sinusoidal"}, {TransientSolverData::ExcitationType::GAUSSIAN, "Gaussian"}, {TransientSolverData::ExcitationType::DIFF_GAUSSIAN, "DifferentiatedGaussian"}, {TransientSolverData::ExcitationType::MOD_GAUSSIAN, "ModulatedGaussian"}, @@ -1526,12 +1543,7 @@ void TransientSolverData::SetUp(json &solver) transient->find("TimeStep") != transient->end(), "Missing \"Transient\" solver \"MaxTime\" or \"TimeStep\" in configuration file!"); type = transient->value("Type", type); - MFEM_VERIFY(type != TransientSolverData::Type::INVALID, - "Invalid value for config[\"Transient\"][\"Type\"] in configuration file!"); excitation = transient->at("Excitation"); // Required - MFEM_VERIFY( - excitation != TransientSolverData::ExcitationType::INVALID, - "Invalid value for config[\"Transient\"][\"Excitation\"] in configuration file!"); pulse_f = transient->value("ExcitationFreq", pulse_f); pulse_tau = transient->value("ExcitationWidth", pulse_tau); max_t = transient->at("MaxTime"); // Required @@ -1564,58 +1576,51 @@ void TransientSolverData::SetUp(json &solver) } // Helpers for converting string keys to enum for LinearSolverData::Type, -// LinearSolverData::Ksp, LinearSolverData::SideType, +// LinearSolverData::KspType, LinearSolverData::SideType, // LinearSolverData::MultigridCoarsenType, LinearSolverData::SymFactType, // LinearSolverData::CompressionType, and LinearSolverData::OrthogType. -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::Type, - {{LinearSolverData::Type::INVALID, nullptr}, - {LinearSolverData::Type::AMS, "AMS"}, - {LinearSolverData::Type::BOOMER_AMG, "BoomerAMG"}, - {LinearSolverData::Type::MUMPS, "MUMPS"}, - {LinearSolverData::Type::SUPERLU, "SuperLU"}, - {LinearSolverData::Type::STRUMPACK, "STRUMPACK"}, - {LinearSolverData::Type::STRUMPACK_MP, "STRUMPACK-MP"}, - {LinearSolverData::Type::DEFAULT, "Default"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::KspType, - {{LinearSolverData::KspType::INVALID, nullptr}, - {LinearSolverData::KspType::CG, "CG"}, - {LinearSolverData::KspType::MINRES, "MINRES"}, - {LinearSolverData::KspType::GMRES, "GMRES"}, - {LinearSolverData::KspType::FGMRES, "FGMRES"}, - {LinearSolverData::KspType::BICGSTAB, "BiCGSTAB"}, - {LinearSolverData::KspType::DEFAULT, "Default"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::SideType, - {{LinearSolverData::SideType::INVALID, nullptr}, - {LinearSolverData::SideType::RIGHT, "Right"}, - {LinearSolverData::SideType::LEFT, "Left"}, - {LinearSolverData::SideType::DEFAULT, "Default"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::MultigridCoarsenType, - {{LinearSolverData::MultigridCoarsenType::INVALID, nullptr}, - {LinearSolverData::MultigridCoarsenType::LINEAR, "Linear"}, - {LinearSolverData::MultigridCoarsenType::LOGARITHMIC, - "Logarithmic"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::SymFactType, - {{LinearSolverData::SymFactType::INVALID, nullptr}, - {LinearSolverData::SymFactType::METIS, "METIS"}, - {LinearSolverData::SymFactType::PARMETIS, "ParMETIS"}, - {LinearSolverData::SymFactType::SCOTCH, "Scotch"}, - {LinearSolverData::SymFactType::PTSCOTCH, "PTScotch"}, - {LinearSolverData::SymFactType::DEFAULT, "Default"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::CompressionType, - {{LinearSolverData::CompressionType::INVALID, nullptr}, - {LinearSolverData::CompressionType::NONE, "None"}, - {LinearSolverData::CompressionType::BLR, "BLR"}, - {LinearSolverData::CompressionType::HSS, "HSS"}, - {LinearSolverData::CompressionType::HODLR, "HODLR"}, - {LinearSolverData::CompressionType::ZFP, "ZFP"}, - {LinearSolverData::CompressionType::BLR_HODLR, "BLR-HODLR"}, - {LinearSolverData::CompressionType::ZFP_BLR_HODLR, - "ZFP-BLR-HODLR"}}) -NLOHMANN_JSON_SERIALIZE_ENUM(LinearSolverData::OrthogType, - {{LinearSolverData::OrthogType::INVALID, nullptr}, - {LinearSolverData::OrthogType::MGS, "MGS"}, - {LinearSolverData::OrthogType::CGS, "CGS"}, - {LinearSolverData::OrthogType::CGS2, "CGS2"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::Type, + {{LinearSolverData::Type::DEFAULT, "Default"}, + {LinearSolverData::Type::AMS, "AMS"}, + {LinearSolverData::Type::BOOMER_AMG, "BoomerAMG"}, + {LinearSolverData::Type::MUMPS, "MUMPS"}, + {LinearSolverData::Type::SUPERLU, "SuperLU"}, + {LinearSolverData::Type::STRUMPACK, "STRUMPACK"}, + {LinearSolverData::Type::STRUMPACK_MP, "STRUMPACK-MP"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::KspType, + {{LinearSolverData::KspType::DEFAULT, "Default"}, + {LinearSolverData::KspType::CG, "CG"}, + {LinearSolverData::KspType::MINRES, "MINRES"}, + {LinearSolverData::KspType::GMRES, "GMRES"}, + {LinearSolverData::KspType::FGMRES, "FGMRES"}, + {LinearSolverData::KspType::BICGSTAB, "BiCGSTAB"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::SideType, + {{LinearSolverData::SideType::DEFAULT, "Default"}, + {LinearSolverData::SideType::RIGHT, "Right"}, + {LinearSolverData::SideType::LEFT, "Left"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::MultigridCoarsenType, + {{LinearSolverData::MultigridCoarsenType::LINEAR, "Linear"}, + {LinearSolverData::MultigridCoarsenType::LOGARITHMIC, + "Logarithmic"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::SymFactType, + {{LinearSolverData::SymFactType::DEFAULT, "Default"}, + {LinearSolverData::SymFactType::METIS, "METIS"}, + {LinearSolverData::SymFactType::PARMETIS, "ParMETIS"}, + {LinearSolverData::SymFactType::SCOTCH, "Scotch"}, + {LinearSolverData::SymFactType::PTSCOTCH, "PTScotch"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::CompressionType, + {{LinearSolverData::CompressionType::NONE, "None"}, + {LinearSolverData::CompressionType::BLR, "BLR"}, + {LinearSolverData::CompressionType::HSS, "HSS"}, + {LinearSolverData::CompressionType::HODLR, "HODLR"}, + {LinearSolverData::CompressionType::ZFP, "ZFP"}, + {LinearSolverData::CompressionType::BLR_HODLR, "BLR-HODLR"}, + {LinearSolverData::CompressionType::ZFP_BLR_HODLR, + "ZFP-BLR-HODLR"}}) +PALACE_JSON_SERIALIZE_ENUM(LinearSolverData::OrthogType, + {{LinearSolverData::OrthogType::MGS, "MGS"}, + {LinearSolverData::OrthogType::CGS, "CGS"}, + {LinearSolverData::OrthogType::CGS2, "CGS2"}}) void LinearSolverData::SetUp(json &solver) { @@ -1625,11 +1630,7 @@ void LinearSolverData::SetUp(json &solver) return; } type = linear->value("Type", type); - MFEM_VERIFY(type != LinearSolverData::Type::INVALID, - "Invalid value for config[\"Linear\"][\"Type\"] in configuration file!"); ksp_type = linear->value("KSPType", ksp_type); - MFEM_VERIFY(ksp_type != LinearSolverData::KspType::INVALID, - "Invalid value for config[\"Linear\"][\"KSPType\"] in configuration file!"); tol = linear->value("Tol", tol); max_it = linear->value("MaxIts", max_it); max_size = linear->value("MaxSize", max_size); @@ -1638,9 +1639,6 @@ void LinearSolverData::SetUp(json &solver) // Options related to multigrid mg_max_levels = linear->value("MGMaxLevels", mg_max_levels); mg_coarsen_type = linear->value("MGCoarsenType", mg_coarsen_type); - MFEM_VERIFY( - mg_coarsen_type != LinearSolverData::MultigridCoarsenType::INVALID, - "Invalid value for config[\"Linear\"][\"MGCoarsenType\"] in configuration file!"); mg_legacy_transfer = linear->value("MGLegacyTransfer", mg_legacy_transfer); mg_smooth_aux = linear->value("MGAuxiliarySmoother", mg_smooth_aux); mg_cycle_it = linear->value("MGCycleIts", mg_cycle_it); @@ -1651,33 +1649,18 @@ void LinearSolverData::SetUp(json &solver) pc_mat_lor = linear->value("PCLowOrderRefined", pc_mat_lor); pc_mat_shifted = linear->value("PCMatShifted", pc_mat_shifted); pc_side_type = linear->value("PCSide", pc_side_type); - MFEM_VERIFY(pc_side_type != LinearSolverData::SideType::INVALID, - "Invalid value for config[\"Linear\"][\"PCSide\"] in configuration file!"); - sym_fact_type = linear->value("ColumnOrdering", sym_fact_type); - MFEM_VERIFY( - sym_fact_type != LinearSolverData::SymFactType::INVALID, - "Invalid value for config[\"Linear\"][\"ColumnOrdering\"] in configuration file!"); strumpack_compression_type = linear->value("STRUMPACKCompressionType", strumpack_compression_type); - MFEM_VERIFY(strumpack_compression_type != LinearSolverData::CompressionType::INVALID, - "Invalid value for config[\"Linear\"][\"STRUMPACKCompressionType\"] in " - "configuration file!"); strumpack_lr_tol = linear->value("STRUMPACKCompressionTol", strumpack_lr_tol); strumpack_lossy_precision = linear->value("STRUMPACKLossyPrecision", strumpack_lossy_precision); strumpack_butterfly_l = linear->value("STRUMPACKButterflyLevels", strumpack_butterfly_l); superlu_3d = linear->value("SuperLU3D", superlu_3d); - ams_vector = linear->value("AMSVector", ams_vector); - divfree_tol = linear->value("DivFreeTol", divfree_tol); divfree_max_it = linear->value("DivFreeMaxIts", divfree_max_it); - gs_orthog_type = linear->value("GSOrthogonalization", gs_orthog_type); - MFEM_VERIFY(gs_orthog_type != LinearSolverData::OrthogType::INVALID, - "Invalid value for config[\"Linear\"][\"GSOrthogonalization\"] in " - "configuration file!"); // Cleanup linear->erase("Type"); diff --git a/palace/utils/configfile.hpp b/palace/utils/configfile.hpp index 39ee98341..0b13d6c1d 100644 --- a/palace/utils/configfile.hpp +++ b/palace/utils/configfile.hpp @@ -74,8 +74,7 @@ struct ElementData enum class CoordinateSystem { CARTESIAN, - CYLINDRICAL, - INVALID = -1 + CYLINDRICAL }; CoordinateSystem coordinate_system = CoordinateSystem::CARTESIAN; @@ -95,10 +94,9 @@ struct ProblemData EIGENMODE, ELECTROSTATIC, MAGNETOSTATIC, - TRANSIENT, - INVALID = -1 + TRANSIENT }; - Type type = Type::INVALID; + Type type = Type::DRIVEN; // Level of printing. int verbose = 1; @@ -592,11 +590,10 @@ struct EigenSolverData // Eigenvalue solver type. enum class Type { - ARPACK, - SLEPC, - FEAST, DEFAULT, - INVALID = -1 + SLEPC, + ARPACK, + FEAST }; Type type = Type::DEFAULT; @@ -641,11 +638,10 @@ struct TransientSolverData // Time integration scheme type. enum class Type { + DEFAULT, GEN_ALPHA, NEWMARK, - CENTRAL_DIFF, - DEFAULT, - INVALID = -1 + CENTRAL_DIFF }; Type type = Type::DEFAULT; @@ -657,10 +653,9 @@ struct TransientSolverData DIFF_GAUSSIAN, MOD_GAUSSIAN, RAMP_STEP, - SMOOTH_STEP, - INVALID = -1 + SMOOTH_STEP }; - ExcitationType excitation = ExcitationType::INVALID; + ExcitationType excitation = ExcitationType::SINUSOIDAL; // Excitation parameters: frequency [GHz] and pulse width [ns]. double pulse_f = 0.0; @@ -687,27 +682,25 @@ struct LinearSolverData // Solver type. enum class Type { + DEFAULT, AMS, BOOMER_AMG, MUMPS, SUPERLU, STRUMPACK, - STRUMPACK_MP, - DEFAULT, - INVALID = -1 + STRUMPACK_MP }; Type type = Type::DEFAULT; // Krylov solver type. enum class KspType { + DEFAULT, CG, MINRES, GMRES, FGMRES, - BICGSTAB, - DEFAULT, - INVALID = -1 + BICGSTAB }; KspType ksp_type = KspType::DEFAULT; @@ -730,8 +723,7 @@ struct LinearSolverData enum class MultigridCoarsenType { LINEAR, - LOGARITHMIC, - INVALID = -1 + LOGARITHMIC }; MultigridCoarsenType mg_coarsen_type = MultigridCoarsenType::LOGARITHMIC; @@ -764,10 +756,9 @@ struct LinearSolverData // Choose left or right preconditioning. enum class SideType { - RIGHT, - LEFT, DEFAULT, - INVALID = -1 + RIGHT, + LEFT }; SideType pc_side_type = SideType::DEFAULT; @@ -775,12 +766,11 @@ struct LinearSolverData // direct solvers. enum class SymFactType { + DEFAULT, METIS, PARMETIS, SCOTCH, - PTSCOTCH, - DEFAULT, - INVALID = -1 + PTSCOTCH }; SymFactType sym_fact_type = SymFactType::DEFAULT; @@ -794,8 +784,7 @@ struct LinearSolverData HODLR, ZFP, BLR_HODLR, - ZFP_BLR_HODLR, - INVALID = -1 + ZFP_BLR_HODLR }; CompressionType strumpack_compression_type = CompressionType::NONE; double strumpack_lr_tol = 1.0e-3; @@ -820,8 +809,7 @@ struct LinearSolverData { MGS, CGS, - CGS2, - INVALID = -1 + CGS2 }; OrthogType gs_orthog_type = OrthogType::MGS;