class
InputDeckInputDeck : Control< specialized to Inciter >, see Types.h,.
Contents
The stack is a tagged tuple, a hierarchical heterogeneous data structure where all parsed information is stored.
Base classes
-
template<class List>class tk::TaggedTuple
- Tagged tuple, allowing tag-based access.
Public types
- using keywords = brigand::set<kw::title, kw::nstep, kw::term, kw::t0, kw::dt, kw::ttyi, kw::transport, kw::end, kw::shear_diff, kw::slot_cyl, kw::problem, kw::field_output, kw::refined, kw::interval_iter, kw::interval_time, kw::time_range, kw::partitioning, kw::algorithm, kw::rcb, kw::rib, kw::hsfc, kw::phg, kw::inciter, kw::ncomp, kw::nmat, kw::pde_diffusivity, kw::pde_lambda, kw::pde_u0, kw::bc_dirichlet, kw::sideset, kw::compflow, kw::multimat, kw::ic, kw::box, kw::lua, kw::materialid, kw::mass, kw::density, kw::velocity, kw::position, kw::acceleration, kw::fntype, kw::fn, kw::move, kw::initiate, kw::impulse, kw::linear, kw::pressure, kw::energy, kw::energy_content, kw::temperature, kw::xmin, kw::xmax, kw::ymin, kw::ymax, kw::zmin, kw::zmax, kw::txt_float_format, kw::txt_float_default, kw::txt_float_fixed, kw::txt_float_scientific, kw::precision, kw::diagnostics, kw::history_output, kw::mesh, kw::filename, kw::location, kw::orientation, kw::reference, kw::couple, kw::material, kw::id, kw::eos, kw::stiffenedgas, kw::jwl, kw::mat_gamma, kw::mat_pstiff, kw::mat_mu, kw::mat_cv, kw::mat_k, kw::npar, kw::physics, kw::advection, kw::advdiff, kw::navierstokes, kw::euler, kw::veleq, kw::user_defined, kw::vortical_flow, kw::pde_alpha, kw::pde_beta, kw::pde_p0, kw::ctau, kw::cfl, kw::dvcfl, kw::vortmult, kw::mj, kw::elem, kw::node, kw::depvar, kw::outvar, kw::outvar_density, kw::outvar_xmomentum, kw::outvar_ymomentum, kw::outvar_zmomentum, kw::outvar_specific_total_energy, kw::outvar_volumetric_total_energy, kw::outvar_xvelocity, kw::outvar_yvelocity, kw::outvar_zvelocity, kw::outvar_pressure, kw::outvar_material_indicator, kw::outvar_analytic, kw::nl_energy_growth, kw::pde_betax, kw::pde_betay, kw::pde_betaz, kw::pde_ce, kw::pde_kappa, kw::pde_r0, kw::rayleigh_taylor, kw::taylor_green, kw::filetype, kw::exodusii, kw::root, kw::error, kw::l2, kw::linf, kw::fct, kw::fctclip, kw::fcteps, kw::sysfct, kw::sysfctvar, kw::pelocal_reorder, kw::operator_reorder, kw::steady_state, kw::residual, kw::rescomp, kw::amr, kw::ale, kw::smoother, kw::laplace, kw::helmholtz, kw::meshvelocity, kw::meshvel_maxit, kw::meshvel_tolerance, kw::mesh_motion, kw::meshforce, kw::none, kw::sine, kw::fluid, kw::amr_t0ref, kw::amr_dtref, kw::amr_dtref_uniform, kw::amr_dtfreq, kw::amr_initial, kw::amr_uniform, kw::amr_uniform_derefine, kw::amr_initial_conditions, kw::amr_coords, kw::amr_error, kw::amr_jump, kw::amr_hessian, kw::amr_refvar, kw::amr_tolref, kw::amr_tolderef, kw::amr_edgelist, kw::amr_xminus, kw::amr_xplus, kw::amr_yminus, kw::amr_yplus, kw::amr_zminus, kw::amr_zplus, kw::pref, kw::pref_indicator, kw::pref_spectral_decay, kw::pref_non_conformity, kw::pref_ndofmax, kw::pref_tolref, kw::scheme, kw::diagcg, kw::alecg, kw::dg, kw::p0p1, kw::dgp1, kw::dgp2, kw::pdg, kw::flux, kw::laxfriedrichs, kw::hllc, kw::upwind, kw::ausm, kw::hll, kw::limiter, kw::cweight, kw::nolimiter, kw::wenop1, kw::superbeep1, kw::vertexbasedp1, kw::prelax, kw::prelax_timescale, kw::intsharp, kw::intsharp_param, kw::bc_sym, kw::bc_inlet, kw::bc_outlet, kw::bc_farfield, kw::bc_extrapolate, kw::bc_timedep, kw::bc_stag, kw::bc_skip, kw::sponge, kw::point, kw::radius, kw::gauss_hump, kw::rotated_sod_shocktube, kw::cyl_advect, kw::cyl_vortex, kw::shedding_flow, kw::sod_shocktube, kw::sedov_blastwave, kw::interface_advection, kw::gauss_hump_compflow, kw::waterair_shocktube, kw::shock_hebubble, kw::underwater_ex>
- Inciter input deck keywords.
-
using ignore = CmdLine::
ignore - Set of tags to ignore when printing this InputDeck.
Constructors, destructors, conversion operators
Pack/Unpack: Serialize InputDeck object for Charm++
- void pup(PUP::er& p)
- Pack/Unpack serialize member function.
- auto outsets() const -> std::set<int>
-
auto outvars(tk::
Centering c) const -> std::set<OutVar> - auto outvar_aliases() const -> std::map<std::string, std::string>
- auto mesh() const -> std::vector<std::string>
- Extract list of mesh filenames (each assigned to a solver)
- auto depvar() const -> std::vector<char>
- Extract list of dependent variables (each configuring a solver)
-
template<class eq, class sbc>auto specialBC(std::size_t system) -> std::tuple<std::vector<tk::
real>, std::vector<tk:: real>> - void operator|(PUP::er& p, InputDeck& i)
- Pack/Unpack serialize operator|.
Typedef documentation
using inciter:: ctr:: InputDeck:: keywords = brigand::set<kw::title, kw::nstep, kw::term, kw::t0, kw::dt, kw::ttyi, kw::transport, kw::end, kw::shear_diff, kw::slot_cyl, kw::problem, kw::field_output, kw::refined, kw::interval_iter, kw::interval_time, kw::time_range, kw::partitioning, kw::algorithm, kw::rcb, kw::rib, kw::hsfc, kw::phg, kw::inciter, kw::ncomp, kw::nmat, kw::pde_diffusivity, kw::pde_lambda, kw::pde_u0, kw::bc_dirichlet, kw::sideset, kw::compflow, kw::multimat, kw::ic, kw::box, kw::lua, kw::materialid, kw::mass, kw::density, kw::velocity, kw::position, kw::acceleration, kw::fntype, kw::fn, kw::move, kw::initiate, kw::impulse, kw::linear, kw::pressure, kw::energy, kw::energy_content, kw::temperature, kw::xmin, kw::xmax, kw::ymin, kw::ymax, kw::zmin, kw::zmax, kw::txt_float_format, kw::txt_float_default, kw::txt_float_fixed, kw::txt_float_scientific, kw::precision, kw::diagnostics, kw::history_output, kw::mesh, kw::filename, kw::location, kw::orientation, kw::reference, kw::couple, kw::material, kw::id, kw::eos, kw::stiffenedgas, kw::jwl, kw::mat_gamma, kw::mat_pstiff, kw::mat_mu, kw::mat_cv, kw::mat_k, kw::npar, kw::physics, kw::advection, kw::advdiff, kw::navierstokes, kw::euler, kw::veleq, kw::user_defined, kw::vortical_flow, kw::pde_alpha, kw::pde_beta, kw::pde_p0, kw::ctau, kw::cfl, kw::dvcfl, kw::vortmult, kw::mj, kw::elem, kw::node, kw::depvar, kw::outvar, kw::outvar_density, kw::outvar_xmomentum, kw::outvar_ymomentum, kw::outvar_zmomentum, kw::outvar_specific_total_energy, kw::outvar_volumetric_total_energy, kw::outvar_xvelocity, kw::outvar_yvelocity, kw::outvar_zvelocity, kw::outvar_pressure, kw::outvar_material_indicator, kw::outvar_analytic, kw::nl_energy_growth, kw::pde_betax, kw::pde_betay, kw::pde_betaz, kw::pde_ce, kw::pde_kappa, kw::pde_r0, kw::rayleigh_taylor, kw::taylor_green, kw::filetype, kw::exodusii, kw::root, kw::error, kw::l2, kw::linf, kw::fct, kw::fctclip, kw::fcteps, kw::sysfct, kw::sysfctvar, kw::pelocal_reorder, kw::operator_reorder, kw::steady_state, kw::residual, kw::rescomp, kw::amr, kw::ale, kw::smoother, kw::laplace, kw::helmholtz, kw::meshvelocity, kw::meshvel_maxit, kw::meshvel_tolerance, kw::mesh_motion, kw::meshforce, kw::none, kw::sine, kw::fluid, kw::amr_t0ref, kw::amr_dtref, kw::amr_dtref_uniform, kw::amr_dtfreq, kw::amr_initial, kw::amr_uniform, kw::amr_uniform_derefine, kw::amr_initial_conditions, kw::amr_coords, kw::amr_error, kw::amr_jump, kw::amr_hessian, kw::amr_refvar, kw::amr_tolref, kw::amr_tolderef, kw::amr_edgelist, kw::amr_xminus, kw::amr_xplus, kw::amr_yminus, kw::amr_yplus, kw::amr_zminus, kw::amr_zplus, kw::pref, kw::pref_indicator, kw::pref_spectral_decay, kw::pref_non_conformity, kw::pref_ndofmax, kw::pref_tolref, kw::scheme, kw::diagcg, kw::alecg, kw::dg, kw::p0p1, kw::dgp1, kw::dgp2, kw::pdg, kw::flux, kw::laxfriedrichs, kw::hllc, kw::upwind, kw::ausm, kw::hll, kw::limiter, kw::cweight, kw::nolimiter, kw::wenop1, kw::superbeep1, kw::vertexbasedp1, kw::prelax, kw::prelax_timescale, kw::intsharp, kw::intsharp_param, kw::bc_sym, kw::bc_inlet, kw::bc_outlet, kw::bc_farfield, kw::bc_extrapolate, kw::bc_timedep, kw::bc_stag, kw::bc_skip, kw::sponge, kw::point, kw::radius, kw::gauss_hump, kw::rotated_sod_shocktube, kw::cyl_advect, kw::cyl_vortex, kw::shedding_flow, kw::sod_shocktube, kw::sedov_blastwave, kw::interface_advection, kw::gauss_hump_compflow, kw::waterair_shocktube, kw::shock_hebubble, kw::underwater_ex>
Inciter input deck keywords.
Function documentation
void inciter:: ctr:: InputDeck:: pup(PUP::er& p)
Pack/Unpack serialize member function.
Parameters | |
---|---|
p in/out | Charm++'s PUP::er serializer object reference |
std::set<int> inciter:: ctr:: InputDeck:: outsets() const
Returns | Unique set of surface side set ids along which user wants to save solution field variables |
---|
Extract surface side set ids along which user wants to save solution
std::set<OutVar> inciter:: ctr:: InputDeck:: outvars(tk:: Centering c) const
Parameters | |
---|---|
c in | Extract variables only with this centering |
Returns | Unique set of field output variable names user wants |
Extract field output variable names the user wants to save
std::map<std::string, std::string> inciter:: ctr:: InputDeck:: outvar_aliases() const
Returns | Map of field output variable names and alias for all output variables the user configured |
---|
Extract field output variable names and aliases the user configured
template<class eq, class sbc>
std::tuple<std::vector<tk:: real>, std::vector<tk:: real>> inciter:: ctr:: InputDeck:: specialBC(std::size_t system)
Template parameters | |
---|---|
eq | PDE type to query |
sbc | Special BC type to query, e.g., stagnation, skip |
Parameters | |
system in | Equation system id |
Returns | Vectors configuring the special points and their radii |
Query special point BC configuration