FuelCell::ApplicationCore::ApplicationData | Here we handle general data of applications |
BaseBoundaryResponse | |
FuelCellShop::PostProcessing::BoundaryLiquidResponse< dim > | Class used to calculate the boundary liquid flux through the boundaries (GDL) in the MEA model |
FuelCellShop::PostProcessing::BoundaryVaporResponse< dim > | Class used to calculate the boundary vapor flux through the boundaries (GDL) in the MEA model |
FuelCellShop::Kinetics::BaseKinetics | Virtual class used to provide the interface for all kinetic/reaction children |
FuelCellShop::Kinetics::ButlerVolmerKinetics | This class implements a Butler-Volmer kinetic model |
FuelCellShop::Kinetics::DoubleTrapKinetics | This class contains the implementation of the double trap kinetic model as described in the following paper: |
FuelCellShop::Kinetics::DualPathKinetics | This class will contain the implementation of the dual path kinetic kinetic model as developed by Wang et al and described in the following paper: |
FuelCellShop::Kinetics::TafelKinetics | This class defines a simple Tafel kinetic model |
FuelCellShop::Equation::BoundaryType | This structure describes a boundary type of a derived equation class |
FuelCell::ApplicationCore::DAESolver | This class provides an interface to the Fortran 77 code COLDAE |
FuelCell::ApplicationCore::DAEWrapper | This class is to be used as a wrapper for the functions needed in the DAESolver |
FuelCellShop::MicroScale::IonomerAgglomerate | Class that solves an ionomer-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::WaterAgglomerate | Class that solves a water-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::HybridAgglomerate | Class that solves a Hybrid (water/ionomer filled) agglomerate problem in 1D |
SIM::DakotaApplication | This class is used to interface with DAKOTA as an algorithm library |
SIM::DakotaInterface< dim > | Classes used to interface the fuel cell analysis code with DAKOTA (an optimization toolbox) |
FcstUtilities::DatabaseOC | This class is for storing a list of up to 10 parameters and is used as a way of informing the FCSTdatabase class about the model you wish to store/access |
DataPostprocessor | |
FuelCellShop::PostProcessing::HORCurrentDensityDataOut< dim > | Class used to evaluate the HOR current density, overpotential and effectiveness at catalyst layer DoF point in the finite element mesh |
FuelCellShop::PostProcessing::LHS_Pc_DataOut< dim > | |
FuelCellShop::PostProcessing::LiquidVelocityPermeabilityDataOut< dim > | Class used to evaluate the all liquid related the liquid velocity field in all the layers |
FuelCellShop::PostProcessing::ORRCurrentDensityDataOut< dim > | Class used to evaluate the ORR current density, overpotential, effectiveness and the oxygen coverages (when applicable) at catalyst layer DoF point in the finite element mesh |
FuelCellShop::PostProcessing::ORRSOURCEDataOut< dim > | |
FuelCellShop::PostProcessing::OxygenDiffusivityDataOut< dim > | Class used to evaluate the all liquid related the liquid velocity field in all the layers |
FuelCellShop::PostProcessing::PermeabilityDataOut< dim > | Class used to evaluate the ORR current density, overpotential, effectiveness and the oxygen coverages (when applicable) at catalyst layer DoF point in the finite element mesh |
FuelCellShop::PostProcessing::PhaseChangeDataOut< dim > | Class used to evaluate the volumetric condensation and evaporation and the interfacial surface area |
FuelCellShop::PostProcessing::RHSData_KelvinOut< dim > | |
FuelCellShop::PostProcessing::RHSData_KelvinOut_NoTem< dim > | |
FuelCellShop::PostProcessing::RHSDataOut< dim > | |
DataPostprocessorScalar | |
FuelCellShop::PostProcessing::CapillaryPressureDataOut< dim > | Class used to evaluate the capillary pressure at PorousLayer (viz., GDL, MPL and CL) DoF point in the finite element mesh |
FuelCellShop::PostProcessing::MolarFractionDataOut< dim > | Class used to output molar fractions based on the density of each species |
FuelCellShop::PostProcessing::RelativeHumidityDataOut< dim > | Class used to evaluate the relative humidity at PorousLayer (viz., GDL, MPL and CL) DoF point in the finite element mesh |
FuelCellShop::PostProcessing::SaturationDataOut< dim > | Class used to output saturation inside the layer |
FuelCellShop::PostProcessing::SaturationDataOut< dim > | Class used to output saturation inside the layer |
DirectApplicInterface | |
SIM::DakotaDirectInterface< dim > | This class is used to read the input file from Dakota in its original format, use this inforamtion to launch the fuel cell simulator and finally from the data from the fuel cell simulator, write the output to Dakota |
SIM::DakotaLeastSquaresInterface< dim > | This class is used to solve a least-squares parameter estimation problem |
dealii::DoFHandler< int, int > | |
dealii::DoFHandler< dim > | |
FuelCell::ApplicationCore::DoFInfo< dim, spacedim > | Very basic info class only containing information on geometry and degrees of freedom on a mesh entity |
FuelCell::ApplicationCore::DoFInfo< dim > | |
FuelCell::ApplicationCore::IntegrationInfo< dim, FEVALUESBASE > | This class is created for the objects handed to the mesh loops |
FuelCellShop::Equation::EquationFlags | Enumeration for flags used in equation classes to control assembly |
FuelCell::ApplicationCore::Event | Objects of this kind are used to notify interior applications of changes provoked by an outer loop |
SIM::ExperimentalData | Description: Used to read in an array of experimental data with column headers |
FcstUtilities::FCSTdatabase | This class is for interfacing with SQL databases, for the purpose of accessing and storing simulation results |
FcstUtilities::FCSTLogStream | The object FcstUtilities::log should be used throughout OpenFCST for console logging |
dealii::FiniteElement< int, int > | |
Function | |
FuelCell::InitialAndBoundaryData::InitialOrBoundaryDataBase< dim > | This class is a means to make variable initial or boundary data |
FuelCell::InitialAndBoundaryData::ExactSolutionAppIncompressibleFlows< dim > | This class is a means to make the exact solution (if available) |
FuelCell::InitialAndBoundaryData::InitialDataAppIncompressibleFlows< dim > | This class is a means to make variable initial data |
FuelCell::InitialSolution::AppPemfcCapillaryTwoPhaseNIThermalIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
FuelCell::InitialSolution::AppPemfcIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
FuelCell::InitialSolution::AppPemfcNIThermalIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
FuelCell::InitialSolution::AppPemfcTPSaturationIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
FuelCell::InitialSolution::AppReadMeshIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
FuelCell::InitialSolution::AppThermalTestIC< dim > | This class is used when solving the problem using Newton's method to provide an initial solution |
LinearSolvers::GMRESSolver | This class implements GMRES solver |
FuelCellShop::Geometry::GridBase< dim > | FuelCell Geometry information class |
FuelCellShop::Geometry::Agglomerate< dim > | This function generates an agglomerate with a core and a thin film subdomain |
FuelCellShop::Geometry::CathodeMPL< dim > | This function generates a grid for a cathode including gas diffusion, microporous, and catalyst layers |
FuelCellShop::Geometry::GridExternal< dim > | This class imports meshes from dealii supported file types |
FuelCellShop::Geometry::GridTest< dim > | This class treates a test mesh with one element |
FuelCellShop::Geometry::HyperCube< dim > | This function generates a square or cubic mesh |
FuelCellShop::Geometry::PemfcMPL< dim > | This function generates a PEMFC grid including a membrane, gas diffusion, microporous, and catalyst layers |
LinearSolvers::ILUPreconditioner | This class implements ILU preconditioner |
map | |
FuelCellShop::SolutionMap | Convenient storage object for SolutionVariables |
dealii::Mapping< int, int > | |
FuelCell::ApplicationCore::MatrixBlock< MATRIX > | A wrapper around a MATRIX object, storing the coordinates in the global block matrix as well |
FuelCellShop::MicroScale::MicroScaleBase | The base class for micro scale objects in OpenFCST |
FuelCellShop::MicroScale::AgglomerateBase | The base class for agglomerate objects in OpenFCST |
FuelCellShop::MicroScale::IonomerAgglomerateAnalytical | Class that gives the analytical solution to an ionomer-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::IonomerAgglomerateSun | Analytical solution to an ionomer-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::NumericalAgglomerateBase | Base class for numerical agglomerates |
FuelCellShop::MicroScale::IonomerAgglomerate | Class that solves an ionomer-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::WaterAgglomerate | Class that solves a water-filled agglomerate problem in 1D |
FuelCellShop::MicroScale::WaterConicalPoreAgglomerate | Class implementing water pore agglomerate model developed by Ehsan Sadeghi |
FuelCellShop::MicroScale::ICCP | Class that solves solid carbon particle, with Pt surface loading, surrounded by ionomer thin film |
FuelCellShop::MicroScale::PolyAgglomerate | An agglomerate model which considers a combination of agglomerates |
FuelCellShop::MicroScale::MicroSet | |
FuelCell::OperatingConditions | Class used to store, read from file and define the operating conditions for a fuel cell |
FuelCellShop::Equation::OutputType | This structure describes an output type of a derived equation class |
FuelCell::ParametricStudy< dim > | This application is used to perform a parametric study for a given fuel cell model |
FuelCell::PolarizationCurve< dim > | This application is used to compute the polarization curve for a given fuel cell model |
QFrame | |
dealii::ParameterGui::BrowseLineEdit | Special line editor for the parameterGUI |
QItemDelegate | |
dealii::ParameterGui::ParameterDelegate | Implements special delegates for the QTreeWidget class used in the parameterGUI |
QMainWindow | |
FCSTGUI::MainWindow | Of the the FCST parameterGUI |
FuelCellShop::Equation::ReactionHeat | This class is used to compute non-linear reaction heat source terms in a catalyst layer |
FuelCell::Scaling | Class used to store, read from file and define scaling factors to be applied to equations in equation matrix and solutions in solution residual |
SimulationSelector< dim > | This class selects an openFCST application which will run |
SimulatorBuilder< dim > | This class is used to output data or to initialize and launch simulations |
FuelCellShop::SolutionVariable | This structure is used to encapsulate data from constant values and variable solution data that is used in Layer classes to compute effective transport properties |
LinearSolvers::SparseDirectUMFPACKSolver | This class implements an interface to the sparse direct solver UMFPACK, see the link below http://www.cise.ufl.edu/research/sparse/umfpack/ |
FuelCellShop::MicroScale::SphericalAgglomerateGeometry | This class implements methods for calculating geometric parameters of a spherical agglomerate surrounded by a thin ionomer film |
FuelCellShop::MicroScale::AgglomerateBase | The base class for agglomerate objects in OpenFCST |
FuelCellShop::MicroScale::ICCP | Class that solves solid carbon particle, with Pt surface loading, surrounded by ionomer thin film |
Subscriptor | |
FuelCell::ApplicationCore::ApplicationBase | Base class for applications |
FuelCell::ApplicationCore::ApplicationWrapper | This class implements either iterative or time-stepping wrapper of applications |
FuelCell::ApplicationCore::AdaptiveRefinement< dim > | This class is initialized with an application that describes the linearization of the problem that we would like to solve and the nonlinear solver that drives the process (usually a Newton loop) |
FuelCell::ApplicationCore::newtonBase | Base class for all classes performing Newton's iteration |
FuelCell::ApplicationCore::Newton3pp | Application class performing Newton's iteration |
FuelCell::ApplicationCore::NewtonBasic | This class performs basic Newton iterations with a constant weight |
FuelCell::ApplicationCore::NewtonLineSearch | Application class performing a Newton's iteration as described in newtonBase |
FuelCell::ApplicationCore::PicardBase | Base class for all classes performing Picard iterations |
FuelCell::ApplicationCore::Picard | Application class performing a Picard iteration as described in the PicardBase |
FuelCell::ApplicationCore::TransientBase | This is a base class for transient solvers |
FuelCell::ApplicationCore::ThetaScheme | |
FuelCell::ApplicationCore::DoFApplication< dim > | Base class for all linear applications, i.e., all applications requiring Triangulation and DoFHandler classes |
FuelCell::ApplicationCore::BlockMatrixApplication< dim > | Application handling matrices and assembling linear systems of equations |
FuelCell::Application::AppStep3< dim > | This class is used to test the application framework by solving Step-3 of the deal.II finite element libraries |
FuelCell::Application::AppStep8< dim > | This class is used to test the application framework by solving Step-3 of the deal.II finite element libraries |
FuelCell::ApplicationCore::OptimizationBlockMatrixApplication< dim > | Application handling matrices and assembling the linear system to solve the sensitivity equations |
FuelCell::Application::AppCathode< dim > | This class is used to solve a system of equations similar to the one presented in the journal article M |
FuelCell::Application::AppCathodeKG< dim > | This class solves |
FuelCell::Application::AppCompressibleFlows< dim > | This class deals with steady-state compressible and isothermal Kerkhof-Geboers fluid transport equations for a single-phase multi-component case |
FuelCell::Application::AppDiffusion< dim > | The application can be used to simulate a gas flow through a porous media |
FuelCell::Application::AppIncompressibleFlows< dim > | This class deals with steady-state incompressible and isothermal Navier-Stokes fluid transport applications for a single-phase single-component case |
FuelCell::Application::AppOhmic< dim > | The application can be used to simulate a electron transport through a porous media |
FuelCell::Application::AppPemfc< dim > | This class is used to solve the physical pheonoma on a complete membrane electrode assembly |
FuelCell::Application::AppPemfcCapillaryTwoPhaseNIThermal< dim > | |
FuelCell::Application::AppPemfcNIThermal< dim > | This class is used to solve the physical pheonoma on a complete membrane electrode assembly, including non-isothermal effects |
FuelCell::Application::AppPemfcTPSaturation< dim > | This class is used to solve the physical pheonoma on a complete membrane electrode assembly, including non-isothermal and two phase effects |
FuelCell::Application::AppReadMesh< dim > | WHAT DOES THIS APPLICATION DO? |
FuelCell::Application::AppThermalTest< dim > | This class is used to test thermal transport equation (fourier equation) against analytical solutions |
FuelCell::Application::CapillaryTesting< dim > | |
FuelCell::Application::Thermaltesting< dim > | |
FuelCell::ApplicationCore::BlockInfo | A small structure collecting the different BlockIndices of FEVector vectors (for instance, solution) involved in the computations |
FuelCell::ApplicationCore::FEVectors | The data type used in function calls of Application |
FuelCell::SystemManagement | IMPORTANT: Add all new solution variables and equations here ! |
FuelCellShop::Equation::DebugTools::DebugOutput< dim > | |
FuelCellShop::Equation::EquationBase< dim > | This is the base class used for all Equation classes |
FuelCellShop::Equation::CapillaryPressureEquation< dim > | |
FuelCellShop::Equation::CompressibleMultiComponentKGEquationsCoupled< dim > | This class implements the multi-component mass transport equations proposed by Kerkhof-Geboers for fluid transport |
FuelCellShop::Equation::ElectronTransportEquation< dim > | This class deals with Electron Transport Equation |
FuelCellShop::Equation::FicksTransportEquation< dim > | This class deals with Fick's Transport Equation |
FuelCellShop::Equation::IncompressibleSingleComponentNSEquations< dim > | This class deals with Navier-Stokes fluid transport equations |
FuelCellShop::Equation::LambdaTransportEquation< dim > | This class deals with Membrane Water Content Transport Equation |
FuelCellShop::Equation::LiquidPressureEquation< dim > | This class implements a mass conservation equation for liquid transport in a fuel cell porous media |
FuelCellShop::Equation::LiquidSourceEquation< dim > | This class implements a liquid water condensation and evaporation term |
FuelCellShop::Equation::NewFicksTransportEquation< dim > | This class deals with Ficks Transport Equation |
FuelCellShop::Equation::ProtonTransportEquation< dim > | This class deals with Proton Transport Equation |
FuelCellShop::Equation::ReactionSourceTerms< dim > | This class assembles the reaction source terms for all other transport equations, if there's any |
FuelCellShop::Equation::ReactionSourceTermsBase< dim > | This class assembles the reaction source terms for all other transport equations, if there's any |
FuelCellShop::Equation::ReactionSourceTermsKG< dim > | This class assembles the reaction source terms for all other transport equations, if there's any |
FuelCellShop::Equation::SaturationTransportEquation< dim > | This class deals with Liquid Water Saturation Transport Equation |
FuelCellShop::Equation::SorptionSourceTerms< dim > | This class assembles source terms corresponding to sorption/desorption of water inside the catalyst layer |
FuelCellShop::Equation::ThermalTransportEquation< dim > | This class deals with Thermal Transport Equation |
FuelCellShop::Layer::BaseLayer< dim > | Virtual class used to characterize a generic layer interface |
FuelCellShop::Layer::Channel< dim > | This class describes a channel and stores pointers to |
FuelCellShop::Layer::ExperimentalPorousLayer< dim > | This class describes a porous layer and stores pointers to |
FuelCellShop::Layer::MembraneLayer< dim > | Virtual class used to provide the interface for all MembraneLayer children |
FuelCellShop::Layer::NafionMembrane< dim > | This class implements the necessary information for a Nafion membrane |
FuelCellShop::Layer::PorousLayer< dim > | Virtual class used to implement properties that are characteristic of a porous layer |
FuelCellShop::Layer::CatalystLayer< dim > | Virtual class used to provide the interface for all CatalystLayer children |
FuelCellShop::Layer::ConventionalCL< dim > | This class characterizes a catalyst layer and uses this information to compute effective transport properties and interfacial areas for phase change or electrochemical reactions |
FuelCellShop::Layer::HomogeneousCL< dim > | This class characterizes a catalyst layer and uses this information to compute effective transport properties and interfacial areas for phase change or electrochemical reactions |
FuelCellShop::Layer::MultiScaleCL< dim > | This class characterizes a catalyst layer and uses this information to compute effective transport properties and interfacial areas for phase change or electrochemical reactions |
FuelCellShop::Layer::MultiScaleCL< deal_II_dimension > | |
FuelCellShop::Layer::DummyCL< dim > | This class characterizes a macro-homogeneous catalyst layer and should be used in the case of constant effective properties, viz., effective_proton_conductivity , effective_gas_diffusivity , effective_electron_conductivity and effective_thermal_conductivity |
FuelCellShop::Layer::GasDiffusionLayer< dim > | Virtual class used to provide the interface for all GasDiffusionLayer children |
FuelCellShop::Layer::DesignFibrousGDL< dim > | This class defines a GDL made of fibres |
FuelCellShop::Layer::DummyGDL< dim > | This class is used when we want to input the effective properties to the GDL directly, without taking into account the structure of the GDL \ UNDER DEVELOPMENT |
FuelCellShop::Layer::SGL24BA< dim > | This class defines a SGL-24-BA GDL, for which effective transport properties are constant |
FuelCellShop::Layer::MicroPorousLayer< dim > | Virtual class used to provide the interface for all MicroPorousLayer children |
FuelCellShop::Layer::DesignMPL< dim > | This class defines an MPL where effective transport properties are computed using macro-homogeneous correlations to estimate the effective properties of the media |
FuelCellShop::Layer::DummyMPL< dim > | This class defines an MPL with all effective properties given via input file |
FuelCellShop::Layer::SGL24BC< dim > | This class defines a SGL-24-BC MPL, for which effective transport properties are constant |
FuelCellShop::Layer::SolidLayer< dim > | This class is used to represent a solid layer |
FuelCellShop::MicroScale::BasePSD< dim > | Pore Size Distribution |
FuelCellShop::MicroScale::DualPSD< dim > | Dual Pore Size Distribution |
FuelCellShop::MicroScale::HIPSD< dim > | Hydrophilic Pore Size Distribution |
FuelCellShop::MicroScale::HOPSD< dim > | Hydrophobic Pore Size Distribution |
FuelCellShop::MicroScale::NonePSD< dim > | This is a class for the layer does not contain PSD information |
FuelCellShop::PostProcessing::BaseResponse< dim > | Virtual class used to develop a common interface to a set of functions used to evaluate functionals that are obtained at postprocessing |
FuelCellShop::PostProcessing::ElectronOhmicHeatResponse< dim > | Class used to calculate the electronic ohmic heat generated in the electron conducting layers, viz., GDL, MPL and CL |
FuelCellShop::PostProcessing::HORCurrentDensityResponse< dim > | Class used to calculate the current density at the anode catalyst layer |
FuelCellShop::PostProcessing::HORReactionHeatResponse< dim > | Class used to calculate the heat generated due to HOR inside the anode catalyst layer |
FuelCellShop::PostProcessing::MassFluxResponse< dim > | Class used to calculate the total mass flux at a boundary |
FuelCellShop::PostProcessing::ORRCurrentDensityResponse< dim > | Class used to calculate the ORR current density and coverages (if provided in the kinetic model) by the catalyst layer |
FuelCellShop::PostProcessing::ORRReactionHeatResponse< dim > | Class used to calculate the heat generated due to ORR inside the cathode catalyst layer |
FuelCellShop::PostProcessing::PhaseChangeResponse< dim > | Class used to calculate the evaporated liquid water in CCL |
FuelCellShop::PostProcessing::ProtonOhmicHeatResponse< dim > | Class used to calculate the protonic ohmic heat generated in the proton conducting layers, viz., Membrane and CL |
FuelCellShop::PostProcessing::SorptionHeatResponse< dim > | Class used to calculate the heat generated due to sorption of water inside the catalyst layer |
FuelCellShop::PostProcessing::WaterSorptionResponse< dim > | Class used to calculate the amount of water sorbed inside the catalyst layer |
Subscriptor | |
FuelCellShop::Material::BaseMaterial | Virtual class used to provide the interface for all material classes |
FuelCellShop::Material::CatalystBase | This class implements the interface to compute the properties of a "standard" catalyst |
FuelCellShop::Material::Platinum | |
FuelCellShop::Material::CatalystSupportBase | This class implements the interface to compute the properties of a "standard" catalyst support |
FuelCellShop::Material::CarbonBlack | Class characterizing a carbon black support |
FuelCellShop::Material::ExperimentalFluid | This class describes |
FuelCellShop::Material::ExperimentalMultiFluid | This class describes |
FuelCellShop::Material::ExperimentalSolid | This class describes a solid |
FuelCellShop::Material::FiberBase | |
FuelCellShop::Material::CarbonFiber | |
FuelCellShop::Material::GasMixture | This class describes properties of gas mixtures |
FuelCellShop::Material::MaterialPlateBase | Base class for developing bipolar plate materials |
FuelCellShop::Material::MaterialPlateGraphite | Class to compute the properties of graphite used in bipolar plates |
FuelCellShop::Material::PolymerElectrolyteBase | This class implements the interface to compute the properties of a "standard" polymer electrolyte membrane material |
FuelCellShop::Material::Nafion | Class used to store data and provide information regarding the electrolyte |
FuelCellShop::Material::PureGas | This class is a base class for all pure gases used in OpenFCST |
FuelCellShop::Material::Acetone | This class describes properties of pure Acetone |
FuelCellShop::Material::Air | This class describes properties of pure air |
FuelCellShop::Material::Argon | This class describes properties of pure Argon |
FuelCellShop::Material::DummyGas | This class describes properties of a dummy gas, with all properties of 1.0 Use this name in the parameters file if needed |
FuelCellShop::Material::Helium | This class describes properties of pure helium |
FuelCellShop::Material::Hydrogen | This class describes properties of pure hydrogen |
FuelCellShop::Material::Methanol | This class describes properties of pure Methanol |
FuelCellShop::Material::Neon | This class describes properties of pure Neon |
FuelCellShop::Material::Nitrogen | This class describes properties of pure nitrogen |
FuelCellShop::Material::Oxygen | This class describes properties of pure oxygen |
FuelCellShop::Material::WaterVapor | This class describes properties of pure WaterVapor |
FuelCellShop::Material::PureLiquid | Virtual class used to describe different liquids and pure materials for which viscority, diffusivity, etc |
FuelCellShop::Material::LiquidWater | LiquidWater as a publicly derived class of Pureliquid |
FuelCellShop::Material::PureSolid | This class is a base class for all pure solid materials used in FCST |
FuelCellShop::Material::DummySolid | This class describes properties of pure Dummy |
FuelCellShop::Material::Graphite | This class describes properties of pure Poco Graphite |
dealii::Triangulation< int, int > | |
dealii::Triangulation< dim > | |
Units | Class used to convert units using a standard convention |
FuelCellShop::Equation::VariableInfo | This simple structure stores certain information regarding a particular variable for the equation (all of them retrieved from #SystemManagement) |
dealii::ParameterGui::XMLParameterReader | Interface to parse parameters from XML files to a QTreeWidget |
dealii::ParameterGui::XMLParameterWriter | Interface to write parameters stored in a QTreeWidget to a file in XML format |