| 
    Finite Volume Solver
    prototype
    
   A framework to build finite volume solvers for the AG Klein at the Freie Universität Berlin. 
   | 
 
The amrex namespace. More...
Namespaces | |
| cutcell | |
Classes | |
| class | AxialSourceTerm | 
| struct | CartesianGridGeometry | 
| struct | CompressibleAdvectionAdvectiveFluxes | 
| class | CompressibleAdvectionIntegratorContext | 
| struct | FluxMethodAdapter | 
| class | Geometry | 
| class | GriddingAlgorithm | 
| This class modifies and initializes a PatchLevel in a PatchHierarchy.  More... | |
| struct | IgniteDetonationOptions | 
| class | IgniteDetonation | 
| class | IntegratorContext | 
| This class is used by the HypebrolicSplitLevelIntegrator and delegates AMR related tasks to the AMReX library.  More... | |
| struct | PatchHierarchyOptions | 
| struct | DataDescription | 
| The DataDescription class contains all information which is neccessary to describe the complete and conservative state data of an equation.  More... | |
| struct | PatchLevel | 
| The PatchLevel represents a distributed grid containing plain simulation data without a ghost cell layer.  More... | |
| class | PatchHierarchy | 
| The PatchHierarchy holds simulation data on multiple refinement levels.  More... | |
| class | Reconstruction | 
| struct | NoReconstruction | 
| struct | ScopeGuard | 
| struct | ForwardIntegrator | 
| struct | MakeViewImpl | 
| struct | BK19LevelIntegratorOptions | 
| struct | BK19PhysicalParameters | 
| class | BK19LevelIntegrator | 
| struct | WriteBK19Plotfile | 
| class | DebugSnapshot | 
| This class stores debug data for a debug output for a single hierarchy state.  More... | |
| class | DebugSnapshotProxy | 
| This class is a possibly empty handle to a existing DebugSnapshotProxy.  More... | |
| class | DebugStorage | 
| This class stores a list of snapshots and returns proxy objects to those.  More... | |
| class | DebugOutput | 
| This output method enables a debug storage and manages its output in every time step.  More... | |
| class | WriteHdf5 | 
| class | PlotfileOutput | 
| class | ConstantBox | 
| class | GradientDetector | 
| struct | TagAllOf | 
| class | TagBuffer | 
| class | BoundaryConditionRef | 
| This class references a BoundaryCondition object and acts as an adapter such that it is enabled to be used as an AMReX boundary condition.  More... | |
| struct | BoundarySet | 
| This class manages a list of boundary conditions which get applied in the order in which they are stored.  More... | |
| struct | ConstantBoundary | 
| struct | GenericPressureValveBoundaryOptions | 
| struct | ChangeTOpened_ReducedModelDemo | 
| struct | ChangeTOpened_Klein | 
| struct | IsBlockedIfLargePressure | 
| class | GenericPressureValveBoundary | 
| struct | PressureValveBoundary_ReducedModelDemo | 
| struct | PressureValveBoundary_Klein | 
| struct | IsentropicPressureBoundaryOptions | 
| class | IsentropicPressureBoundary | 
| This boundary models an isentropic pressure expansion for the one-dimensional ideal gas equations for mixtures.  More... | |
| class | IsentropicPressureExpansion | 
| This boundary models an isentropic pressure expansion for the one-dimensional ideal gas equations for mixtures.  More... | |
| struct | MassflowBoundaryOptions | 
| class | MassflowBoundary | 
| This boundary models an inflow boundary with constant mean mass flow.  More... | |
| struct | PressureValveOptions | 
| struct | PressureValve | 
| class | PressureValveBoundary | 
| class | ReflectiveBoundary | 
| struct | TransmissiveBoundary | 
| This class copies the inner grid values to the boundary.  More... | |
| class | AxiSymmetricSourceTerm | 
| class | LogProbesOutput | 
| struct | BlockEntry | 
| struct | BlockConnection | 
| class | MultiBlockBoundary | 
| struct | MultiBlockBoundaryBase | 
| struct | MultiBlockBoundaryWrapper | 
| class | AnyMultiBlockBoundary | 
| struct | MultiBlockBoundary2 | 
| class | MultiBlockGriddingAlgorithm | 
| class | MultiBlockGriddingAlgorithm2 | 
| class | MultiBlockIgniteDetonation | 
| class | MultiBlockIntegratorContext | 
| class | MultiBlockIntegratorContext2 | 
| class | MultiBlockKineticSouceTerm | 
| This class manages multiple kinetic source terms which are associated to independend one-dimensional domains.  More... | |
| class | MultiBlockLevelIntegrator | 
| class | MultiBlockPlotfileOutput | 
| class | MultiBlockPlotfileOutput2 | 
| class | MultiBlockSourceTerm | 
| This class manages multiple kinetic source terms which are associated to independend one-dimensional domains.  More... | |
| class | MultiWriteHdf5 | 
| class | MultiWriteHdf52 | 
Typedefs | |
| template<typename T , typename... Args> | |
| using | ComputeStableDt_t = decltype(std::declval< T >().ComputeStableDt(std::declval< Args >()...)) | 
| template<typename T , typename... Args> | |
| using | ComputeNumericFluxes_t = decltype(std::declval< T >().ComputeNumericFluxes(std::declval< Args >()...)) | 
| using | AnyInitialData = ::fub::AnyInitialData< GriddingAlgorithm > | 
| using | AnyTaggingMethod = ::fub::AnyTaggingMethod< GriddingAlgorithm > | 
| using | AnyBoundaryCondition = ::fub::AnyBoundaryCondition< GriddingAlgorithm > | 
| using | HyperbolicMethod = ::fub::HyperbolicMethod< IntegratorContext > | 
Enumerations | |
| enum class | PressureValveState { open_air , open_fuel , closed } | 
Functions | |
| template<typename InitialValue , typename BinaryOp > | |
| void | AccumulateState (const ::amrex::MultiFab &mf, const ::amrex::Box &box, InitialValue &&init, BinaryOp &&binary_op) | 
| template<typename Equation > | |
| void | AverageState (Complete< Equation > &state, const ::amrex::MultiFab &mf, const ::amrex::Geometry &, const ::amrex::Box &box) | 
| template<typename Equation > | |
| void | AverageState (Conservative< Equation > &state, const ::amrex::MultiFab &mf, const ::amrex::Geometry &, const ::amrex::Box &box) | 
| ::amrex::Geometry | GetCoarseGeometry (const CartesianGridGeometry &grid_geometry) | 
| ::amrex::RealBox | DomainAroundCenter (const ::amrex::RealArray &x, const ::amrex::RealArray &rx) | 
| ::amrex::Box | BoxWhichContains (const ::amrex::RealBox &xbox, const ::amrex::Geometry &geom) | 
| template<typename GriddingAlgorithm > | |
| int | FindLevel (const ::amrex::Geometry &geom, const GriddingAlgorithm &gridding) | 
| template<typename FM > | |
| FluxMethodAdapter (const FM &fm) -> FluxMethodAdapter< execution::OpenMpSimdTag, FM > | |
| template<typename Tag , typename FM > | |
| FluxMethodAdapter (Tag, const FM &fm) -> FluxMethodAdapter< Tag, FM > | |
| template<typename F > | |
| void | ForEachIndex (const ::amrex::Box &box, F function) | 
| template<typename F > | |
| void | ForEachIndex (const ::amrex::Box &box, int n_components, F function) | 
| ::amrex::Box | GetInnerBox (const ::amrex::Box &box, int side, Direction dir, int width) | 
| double | GetMeanValueInBox (const ::amrex::MultiFab &data, const ::amrex::Box &box, int component) | 
| template<typename Equation > | |
| DataDescription | MakeDataDescription (const Equation &equation) | 
| template<typename Equation > | |
| void | WritePlotFile (const std::string plotfilename, const fub::amrex::PatchHierarchy &hier, const Equation &equation) | 
| template<int Rank> | |
| void | WritePlotFile (const std::string plotfilename, const fub::amrex::PatchHierarchy &hier, const IdealGasMix< Rank > &equation) | 
| void | WriteCheckpointFile (const std::string checkpointname, const fub::amrex::PatchHierarchy &hier) | 
| PatchHierarchy | ReadCheckpointFile (const std::string &checkpointname, DataDescription desc, const CartesianGridGeometry &geometry, const PatchHierarchyOptions &options) | 
| void | WriteMatlabData (std::ostream &out, const ::amrex::FArrayBox &fab, const fub::IdealGasMix< 1 > &eq, const ::amrex::Geometry &geom) | 
| void | WriteMatlabData (std::ostream &out, const ::amrex::FArrayBox &fab, const fub::IdealGasMix< 3 > &eq, const ::amrex::Geometry &geom) | 
| std::vector< double > | GatherStates (const PatchHierarchy &hierarchy, basic_mdspan< const double, extents< AMREX_SPACEDIM, dynamic_extent >> xs, MPI_Comm comm) | 
| void | WriteTubeData (const std::string &filename, const PatchHierarchy &hierarchy, const IdealGasMix< 1 > &eq, fub::Duration time_point, std::ptrdiff_t cycle_number, MPI_Comm comm) | 
| void | WriteToHDF5 (const std::string &name, const ::amrex::FArrayBox &fab, const ::amrex::Geometry &geom, Duration time_point, std::ptrdiff_t cycle) noexcept | 
| template<typename Equation > | |
| Reconstruction (const Equation &eq) -> Reconstruction< execution::OpenMpSimdTag, Equation > | |
| template<typename Tag , typename Equation > | |
| Reconstruction (Tag, const Equation &eq) -> Reconstruction< Tag, Equation > | |
| ForwardIntegrator () -> ForwardIntegrator< execution::OpenMpSimdTag > | |
| ForwardIntegrator< execution::OpenMpSimdTag > | EulerForwardTimeIntegrator () | 
| std::array< std::ptrdiff_t, AMREX_SPACEDIM > | AsArray (const ::amrex::IntVect &vec) | 
| template<int Rank> | |
| IndexBox< Rank > | AsIndexBox (const ::amrex::Box &box) | 
| template<typename T > | |
| mdspan< T, AMREX_SPACEDIM+1 > | MakeMdSpan (::amrex::BaseFab< T > &fab) | 
| Creates a mdspan which views all components of a mutable Fab.  More... | |
| template<typename T > | |
| PatchDataView< T, AMREX_SPACEDIM+1 > | MakePatchDataView (::amrex::BaseFab< T > &fab) | 
| template<typename T > | |
| mdspan< T, AMREX_SPACEDIM > | MakeMdSpan (::amrex::BaseFab< T > &fab, int component) | 
| Creates a mdspan which views the specified component of a mutable Fab.  More... | |
| template<typename T > | |
| PatchDataView< T, AMREX_SPACEDIM > | MakePatchDataView (::amrex::BaseFab< T > &fab, int component) | 
| template<typename T > | |
| mdspan< const T, AMREX_SPACEDIM+1 > | MakeMdSpan (const ::amrex::BaseFab< T > &fab) | 
| Creates a mdspan which views all components of a const Fab.  More... | |
| template<typename T > | |
| PatchDataView< const T, AMREX_SPACEDIM+1 > | MakePatchDataView (const ::amrex::BaseFab< T > &fab) | 
| template<typename T > | |
| mdspan< const T, AMREX_SPACEDIM > | MakeMdSpan (const ::amrex::BaseFab< T > &fab, int component) | 
| Creates a mdspan which views the specified component of a const Fab.  More... | |
| template<typename T > | |
| PatchDataView< const T, AMREX_SPACEDIM > | MakePatchDataView (const ::amrex::BaseFab< T > &fab, int component) | 
| template<typename T > | |
| PatchDataView< const T, AMREX_SPACEDIM, layout_stride > | MakePatchDataView (const ::amrex::BaseFab< T > &fab, int component, const ::amrex::Box &box) | 
| template<typename T > | |
| PatchDataView< T, AMREX_SPACEDIM, layout_stride > | MakePatchDataView (::amrex::BaseFab< T > &fab, int component, const ::amrex::Box &box) | 
| template<typename State , typename T , typename Equation > | |
| auto | MakeView (const PatchDataView< T, AMREX_SPACEDIM+1 > &fab, const Equation &equation) | 
| template<typename State , typename Equation > | |
| auto | MakeView (::amrex::FArrayBox &fab, const Equation &equation) | 
| template<typename State , typename Equation > | |
| auto | MakeView (const ::amrex::FArrayBox &fab, const Equation &equation) | 
| template<typename State , typename Equation > | |
| auto | MakeView (::amrex::FArrayBox &fab, const Equation &eq, const IndexBox< Equation::Rank()> &box) | 
| template<typename State , typename Equation > | |
| auto | MakeView (const ::amrex::FArrayBox &fab, const Equation &eq, const IndexBox< Equation::Rank()> &box) | 
| template<typename State , typename FAB , typename Equation > | |
| auto | MakeView (FAB &&fab, const Equation &eq, const ::amrex::Box &box) | 
| std::array<::amrex::Box, 2 > | GetCellsAndFacesInStencilRange (const ::amrex::Box &cell_tilebox, const ::amrex::Box &face_validbox, int stencil_width, Direction dir) | 
| void | RecomputeAdvectiveFluxes (const IndexMapping< CompressibleAdvection< 2 >> &index, std::array<::amrex::MultiFab, 2 > &Pv_faces, ::amrex::MultiFab &Pv_cells, const ::amrex::MultiFab &scratch, const ::amrex::Periodicity &periodicity) | 
| void | WriteRawField (const std::string &path, const std::string &name, const ::amrex::MultiFab &data, int level) | 
| bool | operator!= (const DebugSnapshotProxy &p1, const DebugSnapshotProxy &p2) noexcept | 
| Returns true if both proxy objects point to different snapshots.  More... | |
| template<typename Eq , typename... Ps> | |
| GradientDetector (const Eq &eq, const std::pair< Ps, double > &... ps) -> GradientDetector< Eq, Ps... > | |
| template<int Rank> | |
| ::amrex::IntVect | GetGradientGrowVector () | 
| template<typename Equation , typename InflowFunction > | |
| PressureValveBoundary_ReducedModelDemo (const Equation &, KineticState< Equation >, InflowFunction, const GenericPressureValveBoundaryOptions &) -> PressureValveBoundary_ReducedModelDemo< Equation, InflowFunction > | |
| template<typename Equation , typename InflowFunction > | |
| PressureValveBoundary_ReducedModelDemo (const Equation &, KineticState< Equation >, InflowFunction) -> PressureValveBoundary_ReducedModelDemo< Equation, InflowFunction > | |
| template<typename Equation , typename InflowFunction > | |
| PressureValveBoundary_Klein (const Equation &, KineticState< Equation >, InflowFunction, const GenericPressureValveBoundaryOptions &) -> PressureValveBoundary_Klein< Equation, InflowFunction > | |
| template<typename Equation , typename InflowFunction > | |
| PressureValveBoundary_Klein (const Equation &, KineticState< Equation >, InflowFunction) -> PressureValveBoundary_Klein< Equation, InflowFunction > | |
| std::array< std::ptrdiff_t, 1 > | MapToSrc (const std::array< std::ptrdiff_t, 1 > &dest, const ::amrex::Geometry &geom, int side, Direction dir) | 
| template<typename EulerEquation > | |
| void | ExpandState (EulerEquation &eq, Complete< EulerEquation > &dest, const Complete< EulerEquation > &src, double pressure_dest, double efficiency) | 
| template<typename Equation > | |
| ReflectiveBoundary (const Equation &, Direction, int) -> ReflectiveBoundary< execution::SequentialTag, Equation > | |
| template<typename Tag , typename Equation > | |
| ReflectiveBoundary (Tag, const Equation &, Direction, int) -> ReflectiveBoundary< Tag, Equation > | |
| template<typename TubeEquation , typename PlenumEquation > | |
| void | ReduceStateDimension (TubeEquation &tube_equation, Complete< TubeEquation > &dest, PlenumEquation &, const Conservative< PlenumEquation > &src) | 
| template<typename PlenumEquation , typename TubeEquation > | |
| void | EmbedState (PlenumEquation &plenum_equation, Complete< PlenumEquation > &dest, TubeEquation &, const Conservative< TubeEquation > &src) | 
| template<typename Tag , typename F > | |
| void | ForEachFab (Tag, const ::amrex::FabArrayBase &fabarray, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename Tag , typename F > | |
| void | ForEachFab (Tag, const ::amrex::BoxArray &ba, const ::amrex::DistributionMapping &dm, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (execution::OpenMpTag, const ::amrex::FabArrayBase &fabarray, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (execution::OpenMpTag, const ::amrex::BoxArray &ba, const ::amrex::DistributionMapping &dm, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (execution::OpenMpSimdTag, const ::amrex::FabArrayBase &fabarray, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (const ::amrex::FabArrayBase &fabarray, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (execution::OpenMpSimdTag, const ::amrex::BoxArray &ba, const ::amrex::DistributionMapping &dm, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
| template<typename F > | |
| void | ForEachFab (const ::amrex::BoxArray &ba, const ::amrex::DistributionMapping &dm, F function) | 
| Iterate through all local FArrayBox objects in a MultiFab.  More... | |
Variables | |
| template<typename Tag > | |
| ForwardIntegrator< Tag > | EulerForwardTimeIntegrator (Tag) | 
The amrex namespace.
The cutcell namespace.
| using fub::amrex::AnyBoundaryCondition = typedef ::fub::AnyBoundaryCondition<GriddingAlgorithm> | 
| using fub::amrex::AnyInitialData = typedef ::fub::AnyInitialData<GriddingAlgorithm> | 
| using fub::amrex::AnyTaggingMethod = typedef ::fub::AnyTaggingMethod<GriddingAlgorithm> | 
| using fub::amrex::ComputeNumericFluxes_t = typedef decltype(std::declval<T>().ComputeNumericFluxes(std::declval<Args>()...)) | 
| using fub::amrex::ComputeStableDt_t = typedef decltype(std::declval<T>().ComputeStableDt(std::declval<Args>()...)) | 
| using fub::amrex::HyperbolicMethod = typedef ::fub::HyperbolicMethod<IntegratorContext> | 
      
  | 
  strong | 
| void fub::amrex::AccumulateState | ( | const ::amrex::MultiFab & | mf, | 
| const ::amrex::Box & | box, | ||
| InitialValue && | init, | ||
| BinaryOp && | binary_op | ||
| ) | 
| std::array<std::ptrdiff_t, AMREX_SPACEDIM> fub::amrex::AsArray | ( | const ::amrex::IntVect & | vec | ) | 
| IndexBox<Rank> fub::amrex::AsIndexBox | ( | const ::amrex::Box & | box | ) | 
| void fub::amrex::AverageState | ( | Complete< Equation > & | state, | 
| const ::amrex::MultiFab & | mf, | ||
| const ::amrex::Geometry & | , | ||
| const ::amrex::Box & | box | ||
| ) | 
| void fub::amrex::AverageState | ( | Conservative< Equation > & | state, | 
| const ::amrex::MultiFab & | mf, | ||
| const ::amrex::Geometry & | , | ||
| const ::amrex::Box & | box | ||
| ) | 
| ::amrex::Box fub::amrex::BoxWhichContains | ( | const ::amrex::RealBox & | xbox, | 
| const ::amrex::Geometry & | geom | ||
| ) | 
| ::amrex::RealBox fub::amrex::DomainAroundCenter | ( | const ::amrex::RealArray & | x, | 
| const ::amrex::RealArray & | rx | ||
| ) | 
| void fub::amrex::EmbedState | ( | PlenumEquation & | plenum_equation, | 
| Complete< PlenumEquation > & | dest, | ||
| TubeEquation & | , | ||
| const Conservative< TubeEquation > & | src | ||
| ) | 
      
  | 
  inline | 
| void fub::amrex::ExpandState | ( | EulerEquation & | eq, | 
| Complete< EulerEquation > & | dest, | ||
| const Complete< EulerEquation > & | src, | ||
| double | pressure_dest, | ||
| double | efficiency | ||
| ) | 
| int fub::amrex::FindLevel | ( | const ::amrex::Geometry & | geom, | 
| const GriddingAlgorithm & | gridding | ||
| ) | 
| fub::amrex::FluxMethodAdapter | ( | const FM & | fm | ) | -> FluxMethodAdapter< execution::OpenMpSimdTag, FM > | 
| fub::amrex::FluxMethodAdapter | ( | Tag | , | 
| const FM & | fm | ||
| ) | -> FluxMethodAdapter< Tag, FM > | 
| void fub::amrex::ForEachIndex | ( | const ::amrex::Box & | box, | 
| F | function | ||
| ) | 
| void fub::amrex::ForEachIndex | ( | const ::amrex::Box & | box, | 
| int | n_components, | ||
| F | function | ||
| ) | 
| std::vector<double> fub::amrex::GatherStates | ( | const PatchHierarchy & | hierarchy, | 
| basic_mdspan< const double, extents< AMREX_SPACEDIM, dynamic_extent >> | xs, | ||
| MPI_Comm | comm | ||
| ) | 
| std::array<::amrex::Box, 2> fub::amrex::GetCellsAndFacesInStencilRange | ( | const ::amrex::Box & | cell_tilebox, | 
| const ::amrex::Box & | face_validbox, | ||
| int | stencil_width, | ||
| Direction | dir | ||
| ) | 
| ::amrex::Geometry fub::amrex::GetCoarseGeometry | ( | const CartesianGridGeometry & | grid_geometry | ) | 
| ::amrex::IntVect fub::amrex::GetGradientGrowVector | ( | ) | 
| ::amrex::Box fub::amrex::GetInnerBox | ( | const ::amrex::Box & | box, | 
| int | side, | ||
| Direction | dir, | ||
| int | width | ||
| ) | 
| double fub::amrex::GetMeanValueInBox | ( | const ::amrex::MultiFab & | data, | 
| const ::amrex::Box & | box, | ||
| int | component | ||
| ) | 
| fub::amrex::GradientDetector | ( | const Eq & | eq, | 
| const std::pair< Ps, double > &... | ps | ||
| ) | -> GradientDetector< Eq, Ps... > | 
| DataDescription fub::amrex::MakeDataDescription | ( | const Equation & | equation | ) | 
| mdspan<T, AMREX_SPACEDIM + 1> fub::amrex::MakeMdSpan | ( | ::amrex::BaseFab< T > & | fab | ) | 
Creates a mdspan which views all components of a mutable Fab.
| [in] | fab | The Fab which owns the data. | 
| mdspan<T, AMREX_SPACEDIM> fub::amrex::MakeMdSpan | ( | ::amrex::BaseFab< T > & | fab, | 
| int | component | ||
| ) | 
Creates a mdspan which views the specified component of a mutable Fab.
| [in] | fab | The Fab which owns the data. | 
| mdspan<const T, AMREX_SPACEDIM + 1> fub::amrex::MakeMdSpan | ( | const ::amrex::BaseFab< T > & | fab | ) | 
Creates a mdspan which views all components of a const Fab.
| [in] | fab | The Fab which owns the data. | 
| mdspan<const T, AMREX_SPACEDIM> fub::amrex::MakeMdSpan | ( | const ::amrex::BaseFab< T > & | fab, | 
| int | component | ||
| ) | 
Creates a mdspan which views the specified component of a const Fab.
| [in] | fab | The Fab which owns the data. | 
| PatchDataView<T, AMREX_SPACEDIM + 1> fub::amrex::MakePatchDataView | ( | ::amrex::BaseFab< T > & | fab | ) | 
| PatchDataView<T, AMREX_SPACEDIM> fub::amrex::MakePatchDataView | ( | ::amrex::BaseFab< T > & | fab, | 
| int | component | ||
| ) | 
| PatchDataView<T, AMREX_SPACEDIM, layout_stride> fub::amrex::MakePatchDataView | ( | ::amrex::BaseFab< T > & | fab, | 
| int | component, | ||
| const ::amrex::Box & | box | ||
| ) | 
| PatchDataView<const T, AMREX_SPACEDIM + 1> fub::amrex::MakePatchDataView | ( | const ::amrex::BaseFab< T > & | fab | ) | 
| PatchDataView<const T, AMREX_SPACEDIM> fub::amrex::MakePatchDataView | ( | const ::amrex::BaseFab< T > & | fab, | 
| int | component | ||
| ) | 
| PatchDataView<const T, AMREX_SPACEDIM, layout_stride> fub::amrex::MakePatchDataView | ( | const ::amrex::BaseFab< T > & | fab, | 
| int | component, | ||
| const ::amrex::Box & | box | ||
| ) | 
| auto fub::amrex::MakeView | ( | ::amrex::FArrayBox & | fab, | 
| const Equation & | eq, | ||
| const IndexBox< Equation::Rank()> & | box | ||
| ) | 
| auto fub::amrex::MakeView | ( | ::amrex::FArrayBox & | fab, | 
| const Equation & | equation | ||
| ) | 
| auto fub::amrex::MakeView | ( | const ::amrex::FArrayBox & | fab, | 
| const Equation & | eq, | ||
| const IndexBox< Equation::Rank()> & | box | ||
| ) | 
| auto fub::amrex::MakeView | ( | const ::amrex::FArrayBox & | fab, | 
| const Equation & | equation | ||
| ) | 
| auto fub::amrex::MakeView | ( | const PatchDataView< T, AMREX_SPACEDIM+1 > & | fab, | 
| const Equation & | equation | ||
| ) | 
| auto fub::amrex::MakeView | ( | FAB && | fab, | 
| const Equation & | eq, | ||
| const ::amrex::Box & | box | ||
| ) | 
      
  | 
  inline | 
      
  | 
  inlinenoexcept | 
Returns true if both proxy objects point to different snapshots.
| fub::amrex::PressureValveBoundary_Klein | ( | const Equation & | , | 
| KineticState< Equation > | , | ||
| InflowFunction | |||
| ) | -> PressureValveBoundary_Klein< Equation, InflowFunction > | 
| fub::amrex::PressureValveBoundary_Klein | ( | const Equation & | , | 
| KineticState< Equation > | , | ||
| InflowFunction | , | ||
| const GenericPressureValveBoundaryOptions & | |||
| ) | -> PressureValveBoundary_Klein< Equation, InflowFunction > | 
| fub::amrex::PressureValveBoundary_ReducedModelDemo | ( | const Equation & | , | 
| KineticState< Equation > | , | ||
| InflowFunction | |||
| ) | -> PressureValveBoundary_ReducedModelDemo< Equation, InflowFunction > | 
| fub::amrex::PressureValveBoundary_ReducedModelDemo | ( | const Equation & | , | 
| KineticState< Equation > | , | ||
| InflowFunction | , | ||
| const GenericPressureValveBoundaryOptions & | |||
| ) | -> PressureValveBoundary_ReducedModelDemo< Equation, InflowFunction > | 
| PatchHierarchy fub::amrex::ReadCheckpointFile | ( | const std::string & | checkpointname, | 
| DataDescription | desc, | ||
| const CartesianGridGeometry & | geometry, | ||
| const PatchHierarchyOptions & | options | ||
| ) | 
| void fub::amrex::RecomputeAdvectiveFluxes | ( | const IndexMapping< CompressibleAdvection< 2 >> & | index, | 
| std::array<::amrex::MultiFab, 2 > & | Pv_faces, | ||
| ::amrex::MultiFab & | Pv_cells, | ||
| const ::amrex::MultiFab & | scratch, | ||
| const ::amrex::Periodicity & | periodicity | ||
| ) | 
| fub::amrex::Reconstruction | ( | const Equation & | eq | ) | -> Reconstruction< execution::OpenMpSimdTag, Equation > | 
| fub::amrex::Reconstruction | ( | Tag | , | 
| const Equation & | eq | ||
| ) | -> Reconstruction< Tag, Equation > | 
| void fub::amrex::ReduceStateDimension | ( | TubeEquation & | tube_equation, | 
| Complete< TubeEquation > & | dest, | ||
| PlenumEquation & | , | ||
| const Conservative< PlenumEquation > & | src | ||
| ) | 
| fub::amrex::ReflectiveBoundary | ( | Tag | , | 
| const Equation & | , | ||
| Direction | , | ||
| int | |||
| ) | -> ReflectiveBoundary< Tag, Equation > | 
| void fub::amrex::WriteCheckpointFile | ( | const std::string | checkpointname, | 
| const fub::amrex::PatchHierarchy & | hier | ||
| ) | 
| void fub::amrex::WriteMatlabData | ( | std::ostream & | out, | 
| const ::amrex::FArrayBox & | fab, | ||
| const fub::IdealGasMix< 1 > & | eq, | ||
| const ::amrex::Geometry & | geom | ||
| ) | 
| void fub::amrex::WriteMatlabData | ( | std::ostream & | out, | 
| const ::amrex::FArrayBox & | fab, | ||
| const fub::IdealGasMix< 3 > & | eq, | ||
| const ::amrex::Geometry & | geom | ||
| ) | 
| void fub::amrex::WritePlotFile | ( | const std::string | plotfilename, | 
| const fub::amrex::PatchHierarchy & | hier, | ||
| const Equation & | equation | ||
| ) | 
| void fub::amrex::WritePlotFile | ( | const std::string | plotfilename, | 
| const fub::amrex::PatchHierarchy & | hier, | ||
| const IdealGasMix< Rank > & | equation | ||
| ) | 
| void fub::amrex::WriteRawField | ( | const std::string & | path, | 
| const std::string & | name, | ||
| const ::amrex::MultiFab & | data, | ||
| int | level | ||
| ) | 
      
  | 
  noexcept | 
| void fub::amrex::WriteTubeData | ( | const std::string & | filename, | 
| const PatchHierarchy & | hierarchy, | ||
| const IdealGasMix< 1 > & | eq, | ||
| fub::Duration | time_point, | ||
| std::ptrdiff_t | cycle_number, | ||
| MPI_Comm | comm | ||
| ) | 
| ForwardIntegrator<Tag> fub::amrex::EulerForwardTimeIntegrator(Tag) | ( | Tag | ) |