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