Nektar++
|
Classes | |
class | Advection |
An abstract base class encapsulating the concept of advection of a vector field. More... | |
class | Advection3DHomogeneous1D |
class | AdvectionFR |
class | AdvectionNonConservative |
class | AdvectionSystem |
A base class for PDEs which include an advection component. More... | |
class | AdvectionWeakDG |
struct | ALEBase |
struct | ALEFixed |
class | ALEHelper |
struct | ALERotate |
struct | ALETranslate |
class | Coupling |
class | CouplingCwipi |
class | CouplingFile |
class | Diffusion |
class | Diffusion3DHomogeneous1D |
class | DiffusionIP |
class | DiffusionLDG |
class | DiffusionLFR |
class | DiffusionLFRNS |
class | Driver |
Base class for the development of solvers. More... | |
class | DriverAdaptive |
Base class for the adaptive polynomial order driver. More... | |
class | DriverArnoldi |
Base class for the development of solvers. More... | |
class | DriverArpack |
Base class for the development of solvers. More... | |
class | DriverModifiedArnoldi |
class | DriverParallelInTime |
Base class for the development of parallel-in-time solvers. More... | |
class | DriverParareal |
Base class for the development of solvers. More... | |
class | DriverPFASST |
Base class for the development of solvers. More... | |
class | DriverStandard |
Base class for the development of solvers. More... | |
class | DriverSteadyState |
class | EquationSystem |
A base class for describing how to solve specific equations. More... | |
class | EvaluatePoints |
class | FileFieldInterpolator |
class | FileSolution |
This class is the base class for Navier Stokes problems. More... | |
class | Filter |
class | FilterAeroForces |
class | FilterAverageFields |
class | FilterBodyFittedVelocity |
class | FilterCheckpoint |
class | FilterEnergy |
class | FilterEnergy1D |
Filter for one-dimensional energy spectrum. More... | |
class | FilterError |
class | FilterFieldConvert |
class | FilterHistoryPoints |
class | FilterIntegral |
class | FilterLagrangianPoints |
class | FilterMaxMinFields |
class | FilterMean |
class | FilterModalEnergy |
class | FilterMovingAverage |
class | FilterPython |
class | FilterReynoldsStresses |
Append Reynolds stresses to the average fields. More... | |
class | FilterThresholdMax |
class | FilterThresholdMin |
class | FluidInterface |
class | Forcing |
Defines a forcing term to be explicitly applied. More... | |
class | ForcingAbsorption |
class | ForcingBody |
class | ForcingCFSSyntheticEddy |
class | ForcingIncNSSyntheticEddy |
class | ForcingMovingReferenceFrame |
class | ForcingNoise |
class | ForcingProgrammatic |
class | ForcingSyntheticEddy |
class | FrameTransform |
class | HomoRSScalar |
Wrapper class for Riemann solver scalars. More... | |
class | HomoRSVector |
Wrapper class for Riemann solver scalars. More... | |
class | MMFSystem |
A base class for PDEs which include an advection component. More... | |
class | MobilePoint |
class | Newmark_BetaSolver |
class | RiemannSolver |
The RiemannSolver class provides an abstract interface under which solvers for various Riemann problems can be implemented. More... | |
class | SessionFunction |
class | StationaryPoints |
class | StatLagrangianPoints |
class | UnsteadySystem |
Base class for unsteady solvers. More... | |
class | UpwindSolver |
Upwind scheme Riemann solver. More... | |
Typedefs | |
typedef std::shared_ptr< Advection > | AdvectionSharedPtr |
A shared pointer to an Advection object. More... | |
typedef LibUtilities::NekFactory< std::string, Advection, std::string > | AdvectionFactory |
Datatype of the NekFactory used to instantiate classes derived from the Advection class. More... | |
typedef std::function< void(const Array< OneD, Array< OneD, NekDouble > > &, Array< OneD, Array< OneD, Array< OneD, NekDouble > > > &)> | AdvectionFluxVecCB |
typedef std::shared_ptr< AdvectionSystem > | AdvectionSystemSharedPtr |
Shared pointer to an AdvectionSystem class. More... | |
typedef std::shared_ptr< ALEBase > | ALEBaseShPtr |
typedef std::shared_ptr< ALEFixed > | ALEFixedShPtr |
typedef std::shared_ptr< ALETranslate > | ALETranslateShPtr |
typedef std::shared_ptr< ALERotate > | ALERotateShPtr |
typedef std::function< void(Array< OneD, Array< OneD, NekDouble > > &interpField, Array< OneD, Array< OneD, NekDouble > > &distCoords)> | SendCallbackType |
typedef std::vector< std::pair< std::string, std::string > > | SummaryList |
typedef std::shared_ptr< SessionFunction > | SessionFunctionSharedPtr |
typedef std::shared_ptr< Diffusion > | DiffusionSharedPtr |
A shared pointer to an EquationSystem object. More... | |
typedef LibUtilities::NekFactory< std::string, Diffusion, std::string > | DiffusionFactory |
Datatype of the NekFactory used to instantiate classes derived from the Diffusion class. More... | |
typedef std::function< void(const Array< OneD, Array< OneD, NekDouble > > &, const TensorOfArray3D< NekDouble > &, TensorOfArray3D< NekDouble > &)> | DiffusionFluxVecCB |
typedef std::function< void(const Array< OneD, Array< OneD, NekDouble > > &, TensorOfArray3D< NekDouble > &, TensorOfArray3D< NekDouble > &)> | DiffusionFluxVecCBNS |
typedef std::function< void(const Array< OneD, Array< OneD, NekDouble > > &, const Array< OneD, Array< OneD, NekDouble > > &, Array< OneD, Array< OneD, NekDouble > > &)> | DiffusionFluxPenaltyNS |
typedef std::function< void(const Array< OneD, const Array< OneD, NekDouble > > &, const Array< OneD, const Array< OneD, Array< OneD, NekDouble > > > &, NekDouble, const Array< OneD, const Array< OneD, NekDouble > > &, const Array< OneD, const Array< OneD, Array< OneD, NekDouble > > > &)> | FunctorDerivBndCond |
typedef std::function< void(const int, const Array< OneD, Array< OneD, NekDouble > > &, const TensorOfArray3D< NekDouble > &, TensorOfArray3D< NekDouble > &, Array< OneD, int > &, const Array< OneD, Array< OneD, NekDouble > > &)> | DiffusionFluxCons |
typedef std::function< void(const int, const Array< OneD, Array< OneD, NekDouble > > &, const Array< OneD, Array< OneD, NekDouble > > &, TensorOfArray3D< NekDouble > &, Array< OneD, int > &, const Array< OneD, Array< OneD, NekDouble > > &)> | DiffusionSymmFluxCons |
typedef std::function< void(Array< OneD, Array< OneD, NekDouble > > &)> | SpecialBndTreat |
typedef std::shared_ptr< DiffusionLFRNS > | DiffusionLFRNSSharedPtr |
typedef std::shared_ptr< Driver > | DriverSharedPtr |
A shared pointer to a Driver object. More... | |
typedef LibUtilities::NekFactory< std::string, Driver, const LibUtilities::SessionReaderSharedPtr &, const SpatialDomains::MeshGraphSharedPtr & > | DriverFactory |
Datatype of the NekFactory used to instantiate classes derived from the Driver class. More... | |
typedef Array< OneD, Array< OneD, Array< OneD, NekDouble > > > | SDCarray |
typedef std::shared_ptr< EquationSystem > | EquationSystemSharedPtr |
A shared pointer to an EquationSystem object. More... | |
typedef LibUtilities::NekFactory< std::string, EquationSystem, const LibUtilities::SessionReaderSharedPtr &, const SpatialDomains::MeshGraphSharedPtr & > | EquationSystemFactory |
Datatype of the NekFactory used to instantiate classes derived from the EquationSystem class. More... | |
typedef std::shared_ptr< MobilePoint > | MobilePointSharedPtr |
typedef std::shared_ptr< StationaryPoints > | StationaryPointsSharedPtr |
typedef std::shared_ptr< Filter > | FilterSharedPtr |
A shared pointer to a Driver object. More... | |
typedef LibUtilities::NekFactory< std::string, Filter, const LibUtilities::SessionReaderSharedPtr &, const std::shared_ptr< EquationSystem > &, const std::map< std::string, std::string > & > | FilterFactory |
Datatype of the NekFactory used to instantiate classes derived from the Driver class. More... | |
typedef std::shared_ptr< FilterAeroForces > | FilterAeroForcesSharedPtr |
typedef LibUtilities::NekFactory< std::string, Forcing, const LibUtilities::SessionReaderSharedPtr &, const std::weak_ptr< EquationSystem > &, const Array< OneD, MultiRegions::ExpListSharedPtr > &, const unsigned int &, const TiXmlElement * > | ForcingFactory |
Declaration of the forcing factory. More... | |
typedef std::shared_ptr< MMFSystem > | MMFSystemSharedPtr |
typedef std::function< const Array< OneD, const NekDouble > &()> | RSScalarFuncType |
typedef std::function< const Array< OneD, const Array< OneD, NekDouble > > &()> | RSVecFuncType |
typedef std::function< NekDouble()> | RSParamFuncType |
typedef std::shared_ptr< RiemannSolver > | RiemannSolverSharedPtr |
A shared pointer to an EquationSystem object. More... | |
typedef LibUtilities::NekFactory< std::string, RiemannSolver, const LibUtilities::SessionReaderSharedPtr & > | RiemannSolverFactory |
Datatype of the NekFactory used to instantiate classes derived from the RiemannSolver class. More... | |
typedef std::shared_ptr< FileFieldInterpolator > | FileFieldInterpolatorSharedPtr |
Enumerations | |
enum | ProblemType { eCompressible , eIncompressible , eOthers } |
enum | SurfaceType { ePlane , eSphere , eTRSphere , eIrregular , eNonconvex , eCube , SIZE_SurfaceType } |
enum | BoundaryCopyType { eDirichlet , eNeumann , eFwdEQBwd , eFwdEQNegBwd , SIZE_BoundaryCopyType } |
enum | UpwindType { eNotSet , eAverage , eLaxFriedrich , eUpwind , eRusanov , eHLL , eHLLC , SIZE_UpwindType } |
enum | TestMaxwellType { eMaxwell1D , eTestMaxwell2DPEC , eTestMaxwell2DPECAVGFLUX , eTestMaxwell2DPMC , eMaxwell3D , eScatField1D , eScatField2D , eScatField3D , eTotField1D , eTotField2D , eTotField3D , eMaxwellSphere , eELF2DSurface , SIZE_TestMaxwellType } |
enum | PolType { eTransMagnetic , eTransElectric , SIZE_PolType } |
enum | IncType { ePlaneWave , ePlaneWaveImag , eCylindricalWave , SIZE_IncType } |
enum | EvolutionOperatorType { eNonlinear , eDirect , eAdjoint , eTransientGrowth , eSkewSymmetric , eAdaptiveSFD } |
Functions | |
AdvectionFactory & | GetAdvectionFactory () |
Gets the factory for initialising advection objects. More... | |
CouplingFactory & | GetCouplingFactory () |
Declaration of the Coupling factory singleton. More... | |
void | AddSummaryItem (SummaryList &l, const std::string &name, const std::string &value) |
Adds a summary item to the summary info list. More... | |
void | AddSummaryItem (SummaryList &l, const std::string &name, const int &value) |
Adds a summary item to the summary info list. More... | |
void | AddSummaryItem (SummaryList &l, const std::string &name, const NekDouble &value) |
Adds a summary item to the summary info list. More... | |
DiffusionFactory & | GetDiffusionFactory () |
DriverFactory & | GetDriverFactory () |
EquationSystemFactory & | GetEquationSystemFactory () |
FilterFactory & | GetFilterFactory () |
static void | RollOver (Array< OneD, Array< OneD, Array< OneD, NekDouble > > > &data) |
static int | BinaryWrite (std::ofstream &ofile, std::string str) |
static int | OutputTec360_binary (const std::string filename, const std::vector< std::string > &variables, const std::vector< int > &rawN, std::vector< Array< OneD, NekDouble > > &data, int isdouble) |
std::string | parse_python_exception () |
Temporarily stolen from boost examples. More... | |
py::list | ArrayOneDToPyList (const Array< OneD, const MultiRegions::ExpListSharedPtr > &pFields) |
ForcingFactory & | GetForcingFactory () |
Declaration of the forcing factory singleton. More... | |
RiemannSolverFactory & | GetRiemannSolverFactory () |
template<class T , typename = typename std::enable_if< std::is_floating_point<T>::value || tinysimd::is_vector_floating_point<T>::value>::type> | |
void | rotateToNormalKernel (T *in, T *rotMat, T *out) |
template<class T , typename = typename std::enable_if< std::is_floating_point<T>::value || tinysimd::is_vector_floating_point<T>::value>::type> | |
void | rotateFromNormalKernel (T *in, T *rotMat, T *out) |
Variables | |
SOLVER_UTILS_EXPORT typedef std::shared_ptr< Coupling > | CouplingSharedPtr |
SOLVER_UTILS_EXPORT typedef LibUtilities::NekFactory< std::string, Coupling, MultiRegions::ExpListSharedPtr > | CouplingFactory |
Declaration of the Coupling factory. More... | |
SOLVER_UTILS_EXPORT typedef std::shared_ptr< Forcing > | ForcingSharedPtr |
A shared pointer to an EquationSystem object. More... | |
SOLVER_UTILS_EXPORT typedef std::shared_ptr< ForcingProgrammatic > | ForcingProgrammaticSharedPtr |
A shared pointer to an EquationSystem object. More... | |
static std::map< std::string, SendCallbackType > | SendCallbackMap |
static SessionFunctionSharedPtr | NullSessionFunction |
const char *const | SurfaceTypeMap [] |
const char *const | BoundaryCopyTypeMap [] |
const char *const | UpwindTypeMap [] |
const char *const | TestMaxwellTypeMap [] |
const char *const | PolTypeMap [] |
const char *const | IncTypeMap [] |
typedef LibUtilities::NekFactory<std::string, Advection, std::string> Nektar::SolverUtils::AdvectionFactory |
Datatype of the NekFactory used to instantiate classes derived from the Advection class.
Definition at line 59 of file Advection.h.
typedef std::function<void(const Array<OneD, Array<OneD, NekDouble>> &, Array<OneD, Array<OneD, Array<OneD, NekDouble>>> &)> Nektar::SolverUtils::AdvectionFluxVecCB |
Defines a callback function type which evaluates the flux vector \( F(u) \) in a conservative advection of the form \( \nabla\cdot F(u) \).
Definition at line 70 of file Advection.h.
typedef std::shared_ptr<Advection> Nektar::SolverUtils::AdvectionSharedPtr |
A shared pointer to an Advection object.
Definition at line 54 of file Advection.h.
typedef std::shared_ptr<AdvectionSystem> Nektar::SolverUtils::AdvectionSystemSharedPtr |
Shared pointer to an AdvectionSystem class.
Definition at line 92 of file AdvectionSystem.h.
typedef std::shared_ptr<ALEBase> Nektar::SolverUtils::ALEBaseShPtr |
Definition at line 48 of file ALEHelper.h.
typedef std::shared_ptr<ALEFixed> Nektar::SolverUtils::ALEFixedShPtr |
Definition at line 157 of file ALEHelper.h.
typedef std::shared_ptr<ALERotate> Nektar::SolverUtils::ALERotateShPtr |
Definition at line 159 of file ALEHelper.h.
typedef std::shared_ptr<ALETranslate> Nektar::SolverUtils::ALETranslateShPtr |
Definition at line 158 of file ALEHelper.h.
typedef LibUtilities::NekFactory<std::string, Diffusion, std::string> Nektar::SolverUtils::DiffusionFactory |
Datatype of the NekFactory used to instantiate classes derived from the Diffusion class.
Definition at line 60 of file Diffusion.h.
typedef std::function<void( const int, const Array<OneD, Array<OneD, NekDouble>> &, const TensorOfArray3D<NekDouble> &, TensorOfArray3D<NekDouble> &, Array<OneD, int> &, const Array<OneD, Array<OneD, NekDouble>> &)> Nektar::SolverUtils::DiffusionFluxCons |
Parameter list meaning: 1st: nvariables 2nd: nspaceDimension 3rd: field conservative variables 4th: Devrivatives of field conservative varialbes 5th: nonzero flux index array, optional 6th: normal vectors optional
a null pointer need to be passed for optional parameters
Definition at line 110 of file Diffusion.h.
typedef std::function<void(const Array<OneD, Array<OneD, NekDouble>> &, const Array<OneD, Array<OneD, NekDouble>> &, Array<OneD, Array<OneD, NekDouble>> &)> Nektar::SolverUtils::DiffusionFluxPenaltyNS |
Definition at line 76 of file Diffusion.h.
typedef std::function<void(const Array<OneD, Array<OneD, NekDouble>> &, const TensorOfArray3D<NekDouble> &, TensorOfArray3D<NekDouble> &)> Nektar::SolverUtils::DiffusionFluxVecCB |
Definition at line 66 of file Diffusion.h.
typedef std::function<void(const Array<OneD, Array<OneD, NekDouble>> &, TensorOfArray3D<NekDouble> &, TensorOfArray3D<NekDouble> &)> Nektar::SolverUtils::DiffusionFluxVecCBNS |
Definition at line 71 of file Diffusion.h.
typedef std::shared_ptr<DiffusionLFRNS> Nektar::SolverUtils::DiffusionLFRNSSharedPtr |
Definition at line 185 of file DiffusionLFRNS.h.
typedef std::shared_ptr<Diffusion> Nektar::SolverUtils::DiffusionSharedPtr |
A shared pointer to an EquationSystem object.
Definition at line 55 of file Diffusion.h.
typedef std::function<void( const int, const Array<OneD, Array<OneD, NekDouble>> &, const Array<OneD, Array<OneD, NekDouble>> &, TensorOfArray3D<NekDouble> &, Array<OneD, int> &, const Array<OneD, Array<OneD, NekDouble>> &)> Nektar::SolverUtils::DiffusionSymmFluxCons |
Parameter list meaning: 1st: nvariables 2nd: nspaceDimension 3rd: trace conservative variables for Diffusion Flux Jacobian 4th: trace conservative variables( usually the jump of trace value) 5th: trace symmetric flux 6th: nonzero flux index array, optional
a null pointer need to be passed for optional parameters
Definition at line 127 of file Diffusion.h.
typedef LibUtilities::NekFactory<std::string, Driver, const LibUtilities::SessionReaderSharedPtr &, const SpatialDomains::MeshGraphSharedPtr &> Nektar::SolverUtils::DriverFactory |
typedef std::shared_ptr<Driver> Nektar::SolverUtils::DriverSharedPtr |
typedef LibUtilities::NekFactory<std::string, EquationSystem, const LibUtilities::SessionReaderSharedPtr &, const SpatialDomains::MeshGraphSharedPtr &> Nektar::SolverUtils::EquationSystemFactory |
Datatype of the NekFactory used to instantiate classes derived from the EquationSystem class.
Definition at line 71 of file EquationSystem.h.
typedef std::shared_ptr<EquationSystem> Nektar::SolverUtils::EquationSystemSharedPtr |
A shared pointer to an EquationSystem object.
Definition at line 65 of file EquationSystem.h.
typedef std::shared_ptr<FileFieldInterpolator> Nektar::SolverUtils::FileFieldInterpolatorSharedPtr |
Definition at line 51 of file FileSolution.h.
typedef std::shared_ptr<FilterAeroForces> Nektar::SolverUtils::FilterAeroForcesSharedPtr |
Definition at line 153 of file FilterAeroForces.h.
typedef LibUtilities::NekFactory<std::string, Filter, const LibUtilities::SessionReaderSharedPtr &, const std::shared_ptr<EquationSystem> &, const std::map<std::string, std::string> &> Nektar::SolverUtils::FilterFactory |
typedef std::shared_ptr<Filter> Nektar::SolverUtils::FilterSharedPtr |
typedef LibUtilities::NekFactory< std::string, Forcing, const LibUtilities::SessionReaderSharedPtr &, const std::weak_ptr<EquationSystem> &, const Array<OneD, MultiRegions::ExpListSharedPtr> &, const unsigned int &, const TiXmlElement *> Nektar::SolverUtils::ForcingFactory |
typedef std::function<void( const Array<OneD, const Array<OneD, NekDouble>> &, const Array<OneD, const Array<OneD, Array<OneD, NekDouble>>> &, NekDouble, const Array<OneD, const Array<OneD, NekDouble>> &, const Array<OneD, const Array<OneD, Array<OneD, NekDouble>>> &)> Nektar::SolverUtils::FunctorDerivBndCond |
Parameter list meaning: 1st: field conservative variables 2th: Devrivatives of field conservative varialbes 3rd: the current time for time-dependent boundary 4th: Fwd of field conservative variables optional 5th: Fwd of Devrivatives(2nd) optional
a null pointer need to be passed for optional parameters
Definition at line 93 of file Diffusion.h.
typedef std::shared_ptr<MMFSystem> Nektar::SolverUtils::MMFSystemSharedPtr |
Definition at line 381 of file MMFSystem.h.
typedef std::shared_ptr<MobilePoint> Nektar::SolverUtils::MobilePointSharedPtr |
Definition at line 54 of file EvaluatePoints.h.
typedef LibUtilities::NekFactory<std::string, RiemannSolver, const LibUtilities::SessionReaderSharedPtr &> Nektar::SolverUtils::RiemannSolverFactory |
Datatype of the NekFactory used to instantiate classes derived from the RiemannSolver class.
Definition at line 207 of file RiemannSolver.h.
typedef std::shared_ptr<RiemannSolver> Nektar::SolverUtils::RiemannSolverSharedPtr |
A shared pointer to an EquationSystem object.
Definition at line 202 of file RiemannSolver.h.
typedef std::function<NekDouble()> Nektar::SolverUtils::RSParamFuncType |
Definition at line 55 of file RiemannSolver.h.
typedef std::function<const Array<OneD, const NekDouble> &()> Nektar::SolverUtils::RSScalarFuncType |
Definition at line 52 of file RiemannSolver.h.
typedef std::function<const Array<OneD, const Array<OneD, NekDouble> > &()> Nektar::SolverUtils::RSVecFuncType |
Definition at line 54 of file RiemannSolver.h.
Definition at line 45 of file DriverPFASST.h.
typedef std::function<void(Array<OneD, Array<OneD, NekDouble>> &interpField, Array<OneD, Array<OneD, NekDouble>> &distCoords)> Nektar::SolverUtils::SendCallbackType |
Definition at line 180 of file CouplingCwipi.h.
typedef std::shared_ptr<SessionFunction> Nektar::SolverUtils::SessionFunctionSharedPtr |
Definition at line 152 of file SessionFunction.h.
typedef std::function<void(Array<OneD, Array<OneD, NekDouble>> &)> Nektar::SolverUtils::SpecialBndTreat |
Parameter list meaning: 1rd: trace conservative variables
Definition at line 134 of file Diffusion.h.
typedef std::shared_ptr<StationaryPoints> Nektar::SolverUtils::StationaryPointsSharedPtr |
Definition at line 55 of file EvaluatePoints.h.
typedef std::vector<std::pair<std::string, std::string> > Nektar::SolverUtils::SummaryList |
Enumerator | |
---|---|
eDirichlet | |
eNeumann | |
eFwdEQBwd | |
eFwdEQNegBwd | |
SIZE_BoundaryCopyType | Length of enum list. |
Definition at line 58 of file MMFSystem.h.
Enumerator | |
---|---|
eNonlinear | |
eDirect | |
eAdjoint | |
eTransientGrowth | |
eSkewSymmetric | |
eAdaptiveSFD |
Definition at line 37 of file SolverUtils.hpp.
Enumerator | |
---|---|
ePlaneWave | |
ePlaneWaveImag | |
eCylindricalWave | |
SIZE_IncType |
Definition at line 128 of file MMFSystem.h.
Enumerator | |
---|---|
eTransMagnetic | |
eTransElectric | |
SIZE_PolType |
Definition at line 116 of file MMFSystem.h.
Enumerator | |
---|---|
eCompressible | |
eIncompressible | |
eOthers |
Definition at line 43 of file FilterMaxMinFields.h.
Enumerator | |
---|---|
ePlane | |
eSphere | |
eTRSphere | |
eIrregular | |
eNonconvex | |
eCube | |
SIZE_SurfaceType |
Definition at line 43 of file MMFSystem.h.
Definition at line 90 of file MMFSystem.h.
Definition at line 74 of file MMFSystem.h.
SOLVER_UTILS_EXPORT void Nektar::SolverUtils::AddSummaryItem | ( | SummaryList & | l, |
const std::string & | name, | ||
const int & | value | ||
) |
Adds a summary item to the summary info list.
Definition at line 54 of file Misc.cpp.
References CellMLToNektar.pycml::name.
SOLVER_UTILS_EXPORT void Nektar::SolverUtils::AddSummaryItem | ( | SummaryList & | l, |
const std::string & | name, | ||
const NekDouble & | value | ||
) |
Adds a summary item to the summary info list.
Definition at line 60 of file Misc.cpp.
References CellMLToNektar.pycml::format, and CellMLToNektar.pycml::name.
SOLVER_UTILS_EXPORT void Nektar::SolverUtils::AddSummaryItem | ( | SummaryList & | l, |
const std::string & | name, | ||
const std::string & | value | ||
) |
Adds a summary item to the summary info list.
Adds an item to a SummaryList
Definition at line 47 of file Misc.cpp.
References CellMLToNektar.pycml::name.
Referenced by Nektar::SolverUtils::EquationSystem::SessionSummary(), Nektar::Helmholtz::v_GenerateSummary(), Nektar::MMFAdvection::v_GenerateSummary(), Nektar::Poisson::v_GenerateSummary(), Nektar::Projection::v_GenerateSummary(), Nektar::SteadyAdvectionDiffusionReaction::v_GenerateSummary(), Nektar::UnsteadyAdvection::v_GenerateSummary(), Nektar::UnsteadyAdvectionDiffusion::v_GenerateSummary(), Nektar::UnsteadyViscousBurgers::v_GenerateSummary(), Nektar::CompressibleFlowSystem::v_GenerateSummary(), Nektar::MMFDiffusion::v_GenerateSummary(), Nektar::CoupledLinearNS::v_GenerateSummary(), Nektar::SmoothedProfileMethod::v_GenerateSummary(), Nektar::VelocityCorrectionScheme::v_GenerateSummary(), Nektar::VCSImplicit::v_GenerateSummary(), Nektar::VCSWeakPressure::v_GenerateSummary(), Nektar::LinearElasticSystem::v_GenerateSummary(), Nektar::MMFMaxwell::v_GenerateSummary(), Nektar::LinearSWE::v_GenerateSummary(), Nektar::MMFSWE::v_GenerateSummary(), Nektar::NonlinearSWE::v_GenerateSummary(), Nektar::ShallowWaterSystem::v_GenerateSummary(), Nektar::SolverUtils::MMFSystem::v_GenerateSummary(), Nektar::SolverUtils::UnsteadySystem::v_GenerateSummary(), Nektar::UnsteadyDiffusion::v_GenerateSummary(), Nektar::CellModelAlievPanfilov::v_GenerateSummary(), Nektar::CourtemancheRamirezNattel98::v_GenerateSummary(), Nektar::FentonKarma::v_GenerateSummary(), Nektar::CellModelFitzHughNagumo::v_GenerateSummary(), Nektar::Fox02::v_GenerateSummary(), Nektar::LuoRudy91::v_GenerateSummary(), Nektar::PanditGilesDemir03::v_GenerateSummary(), Nektar::TenTusscher06::v_GenerateSummary(), Nektar::Winslow99::v_GenerateSummary(), and Nektar::Monodomain::v_GenerateSummary().
|
inline |
Definition at line 123 of file FilterPython.cpp.
Referenced by Nektar::SolverUtils::FilterPython::v_Finalise(), Nektar::SolverUtils::FilterPython::v_Initialise(), and Nektar::SolverUtils::FilterPython::v_Update().
|
static |
Definition at line 153 of file FilterLagrangianPoints.cpp.
Referenced by OutputTec360_binary().
SOLVER_UTILS_EXPORT AdvectionFactory & Nektar::SolverUtils::GetAdvectionFactory | ( | ) |
Gets the factory for initialising advection objects.
Definition at line 43 of file Advection.cpp.
Referenced by Nektar::SolverUtils::Advection3DHomogeneous1D::Advection3DHomogeneous1D(), Nektar::CompressibleFlowSystem::InitAdvection(), Nektar::SolverUtils::EquationSystem::SessionSummary(), Nektar::PulseWavePropagation::v_InitObject(), Nektar::ImageWarpingSystem::v_InitObject(), Nektar::IncNavierStokes::v_InitObject(), Nektar::APE::v_InitObject(), Nektar::LEE::v_InitObject(), Nektar::EigenValuesAdvection::v_InitObject(), Nektar::MMFAdvection::v_InitObject(), Nektar::UnsteadyAdvection::v_InitObject(), Nektar::UnsteadyInviscidBurgers::v_InitObject(), Nektar::LinearSWE::v_InitObject(), and Nektar::NonlinearSWE::v_InitObject().
SOLVER_UTILS_EXPORT CouplingFactory & Nektar::SolverUtils::GetCouplingFactory | ( | ) |
Declaration of the Coupling factory singleton.
Definition at line 42 of file Coupling.cpp.
References CouplingFactory.
Referenced by Nektar::AcousticSystem::v_InitObject(), and Nektar::Dummy::v_InitObject().
SOLVER_UTILS_EXPORT DiffusionFactory & Nektar::SolverUtils::GetDiffusionFactory | ( | ) |
Definition at line 39 of file Diffusion.cpp.
Referenced by Nektar::ArtificialDiffusion::ArtificialDiffusion(), Nektar::SolverUtils::Diffusion3DHomogeneous1D::Diffusion3DHomogeneous1D(), Nektar::NavierStokesCFE::InitObject_Explicit(), Nektar::SolverUtils::EquationSystem::SessionSummary(), Nektar::UnsteadyAdvectionDiffusion::v_InitObject(), Nektar::UnsteadyDiffusion::v_InitObject(), and Nektar::UnsteadyViscousBurgers::v_InitObject().
SOLVER_UTILS_EXPORT DriverFactory & Nektar::SolverUtils::GetDriverFactory | ( | ) |
Definition at line 66 of file Driver.cpp.
Referenced by Nektar::VortexWaveInteraction::ExecuteStreak(), Nektar::VortexWaveInteraction::ExecuteWave(), and main().
SOLVER_UTILS_EXPORT EquationSystemFactory & Nektar::SolverUtils::GetEquationSystemFactory | ( | ) |
Definition at line 99 of file EquationSystem.cpp.
Referenced by EquationSystem_Create(), Nektar::VortexWaveInteraction::ExecuteRoll(), Nektar::VortexWaveInteraction::ExecuteStreak(), Nektar::SolverUtils::DriverParallelInTime::SetParallelInTimeEquationSystem(), Nektar::SolverUtils::Driver::v_InitObject(), and Nektar::VortexWaveInteraction::VortexWaveInteraction().
SOLVER_UTILS_EXPORT FilterFactory & Nektar::SolverUtils::GetFilterFactory | ( | ) |
Definition at line 39 of file Filters/Filter.cpp.
Referenced by export_Filter(), Filter_Create(), Nektar::SolverUtils::FilterPython::FilterPython(), and Nektar::SolverUtils::UnsteadySystem::v_InitObject().
SOLVER_UTILS_EXPORT ForcingFactory & Nektar::SolverUtils::GetForcingFactory | ( | ) |
Declaration of the forcing factory singleton.
Definition at line 42 of file Forcing.cpp.
Referenced by Nektar::VortexWaveInteraction::ExecuteRoll(), and Nektar::SolverUtils::Forcing::Load().
SOLVER_UTILS_EXPORT RiemannSolverFactory & Nektar::SolverUtils::GetRiemannSolverFactory | ( | ) |
Retrieves the singleton instance of the Riemann solver factory.
Definition at line 63 of file RiemannSolver.cpp.
Referenced by Nektar::CompressibleFlowSystem::InitAdvection(), Nektar::PulseWavePropagation::v_InitObject(), Nektar::ImageWarpingSystem::v_InitObject(), Nektar::APE::v_InitObject(), Nektar::LEE::v_InitObject(), Nektar::EigenValuesAdvection::v_InitObject(), Nektar::MMFAdvection::v_InitObject(), Nektar::UnsteadyAdvection::v_InitObject(), Nektar::UnsteadyAdvectionDiffusion::v_InitObject(), Nektar::UnsteadyInviscidBurgers::v_InitObject(), Nektar::UnsteadyViscousBurgers::v_InitObject(), Nektar::LinearSWE::v_InitObject(), and Nektar::NonlinearSWE::v_InitObject().
|
static |
Definition at line 166 of file FilterLagrangianPoints.cpp.
References BinaryWrite(), and CellMLToNektar.cellml_metadata::p.
Referenced by Nektar::SolverUtils::StatLagrangianPoints::v_OutputData().
std::string Nektar::SolverUtils::parse_python_exception | ( | ) |
Temporarily stolen from boost examples.
Definition at line 47 of file FilterPython.cpp.
Referenced by Nektar::SolverUtils::FilterPython::FilterPython(), Nektar::SolverUtils::FilterPython::v_Finalise(), Nektar::SolverUtils::FilterPython::v_Initialise(), and Nektar::SolverUtils::FilterPython::v_Update().
|
static |
Definition at line 89 of file FilterLagrangianPoints.cpp.
Referenced by Nektar::SolverUtils::StatLagrangianPoints::v_TimeAdvance().
|
inline |
Definition at line 227 of file RiemannSolver.h.
Referenced by Nektar::RoeSolverSIMD::v_Solve().
|
inline |
Definition at line 213 of file RiemannSolver.h.
Referenced by Nektar::RoeSolverSIMD::v_Solve().
const char* const Nektar::SolverUtils::BoundaryCopyTypeMap[] |
Definition at line 67 of file MMFSystem.h.
SOLVER_UTILS_EXPORT typedef LibUtilities::NekFactory< std::string, Coupling, MultiRegions::ExpListSharedPtr> Nektar::SolverUtils::CouplingFactory |
Declaration of the Coupling factory.
Definition at line 50 of file Coupling.h.
Referenced by GetCouplingFactory().
SOLVER_UTILS_EXPORT typedef std::shared_ptr<Coupling> Nektar::SolverUtils::CouplingSharedPtr |
Definition at line 45 of file Coupling.h.
Referenced by Nektar::SolverUtils::CouplingCwipi::create(), and Nektar::SolverUtils::CouplingFile::create().
SOLVER_UTILS_EXPORT typedef std::shared_ptr<ForcingProgrammatic> Nektar::SolverUtils::ForcingProgrammaticSharedPtr |
A shared pointer to an EquationSystem object.
Definition at line 53 of file ForcingProgrammatic.h.
SOLVER_UTILS_EXPORT typedef std::shared_ptr<Forcing> Nektar::SolverUtils::ForcingSharedPtr |
A shared pointer to an EquationSystem object.
Definition at line 53 of file Forcing.h.
Referenced by Nektar::SolverUtils::ForcingAbsorption::create(), Nektar::SolverUtils::ForcingBody::create(), Nektar::SolverUtils::ForcingMovingReferenceFrame::create(), Nektar::SolverUtils::ForcingNoise::create(), Nektar::SolverUtils::ForcingProgrammatic::create(), Nektar::SolverUtils::ForcingSyntheticEddy::create(), Nektar::SolverUtils::ForcingCFSSyntheticEddy::create(), Nektar::SolverUtils::ForcingIncNSSyntheticEddy::create(), Nektar::ForcingAxiSymmetric::create(), Nektar::ForcingQuasi1D::create(), Nektar::ForcingMovingBody::create(), and Nektar::ForcingStabilityCoupledLNS::create().
const char* const Nektar::SolverUtils::IncTypeMap[] |
Definition at line 136 of file MMFSystem.h.
Referenced by Nektar::MMFMaxwell::v_GenerateSummary(), and Nektar::MMFMaxwell::v_InitObject().
|
static |
Definition at line 153 of file SessionFunction.h.
const char* const Nektar::SolverUtils::PolTypeMap[] |
Definition at line 123 of file MMFSystem.h.
Referenced by Nektar::MMFMaxwell::v_GenerateSummary(), and Nektar::MMFMaxwell::v_InitObject().
|
static |
Definition at line 182 of file CouplingCwipi.h.
Referenced by Nektar::SolverUtils::CouplingCwipi::InterpCallback(), and Nektar::SolverUtils::CouplingCwipi::SetupSend().
const char* const Nektar::SolverUtils::SurfaceTypeMap[] |
Definition at line 54 of file MMFSystem.h.
Referenced by Nektar::SolverUtils::MMFSystem::MMFInitObject(), and Nektar::SolverUtils::MMFSystem::v_GenerateSummary().
const char* const Nektar::SolverUtils::TestMaxwellTypeMap[] |
Definition at line 108 of file MMFSystem.h.
Referenced by Nektar::MMFMaxwell::v_GenerateSummary(), and Nektar::MMFMaxwell::v_InitObject().
const char* const Nektar::SolverUtils::UpwindTypeMap[] |
Definition at line 86 of file MMFSystem.h.
Referenced by Nektar::SolverUtils::MMFSystem::MMFInitObject().