|
|
| | CapillaryPressureEquation (FuelCell::SystemManagement &system_management, boost::shared_ptr< FuelCell::ApplicationCore::ApplicationData > data=boost::shared_ptr< FuelCell::ApplicationCore::ApplicationData >()) |
| | Constructor. More...
|
| |
| virtual | ~CapillaryPressureEquation () |
| | Destructor. More...
|
| |
| virtual void | declare_parameters (ParameterHandler ¶m) const |
| | Declare parameters. More...
|
| |
| virtual void | initialize (ParameterHandler ¶m) |
| | Initialize parameters. More...
|
| |
|
| virtual void | assemble_cell_matrix (FuelCell::ApplicationCore::MatrixVector &cell_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local cell matrix. More...
|
| |
| virtual void | assemble_cell_residual (FuelCell::ApplicationCore::FEVector &cell_rhs, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local cell residual. More...
|
| |
| virtual void | assemble_bdry_matrix (FuelCell::ApplicationCore::MatrixVector &bdry_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local boundary matrix. More...
|
| |
| virtual void | assemble_bdry_residual (FuelCell::ApplicationCore::FEVector &bdry_rhs, const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local boundary residual. More...
|
| |
|
| virtual void | print_equation_info () const |
| | The function prints out the equation's info. More...
|
| |
| double | get_kevap () const |
| | Returns evaporation rate constant, . More...
|
| |
| double | get_kcond () const |
| | Returns condensation rate constant, . More...
|
| |
| const couplings_map & | get_internal_cell_couplings () const |
| | This function returns internal_cell_couplings of a derived equation class. More...
|
| |
| const couplings_map & | get_internal_flux_couplings () const |
| | This function returns internal_flux_couplings (DG FEM only) of a derived equation class. More...
|
| |
const
component_materialID_value_map & | get_component_materialID_value () const |
| | This function returns component_materialID_value of a derived equation class. More...
|
| |
const
component_boundaryID_value_map & | get_component_boundaryID_value () const |
| | This function returns component_boundaryID_value of a derived equation class. More...
|
| |
| const std::vector< BoundaryType > & | get_boundary_types () const |
| | This function returns boundary_types of a derived equation class. More...
|
| |
const std::vector< std::vector
< BoundaryType > > & | get_multi_boundary_types () const |
| | This function returns multi_boundary_types of a derived equation class. More...
|
| |
| const std::vector< OutputType > & | get_output_types () const |
| | This function returns output_types of a derived equation class. More...
|
| |
const std::vector< std::vector
< OutputType > > & | get_multi_output_types () const |
| | This function returns multi_output_types of a derived equation class. More...
|
| |
| const std::string & | get_equation_name () const |
| | This function returns equation_name of a derived equation class. More...
|
| |
| const std::vector< unsigned int > & | get_matrix_block_indices () const |
| | This function returns matrix_block_indices of a derived equation class. More...
|
| |
| const std::vector< unsigned int > & | get_residual_indices () const |
| | This function returns residual_indices of a derived equation class. More...
|
| |
|
|
| virtual void | make_assemblers_generic_constant_data () |
| | This function computes Local CG FEM based assemblers - constant data (generic). More...
|
| |
| virtual void | make_assemblers_cell_constant_data (const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info) |
| | This function computes Local CG FEM based assemblers - constant data (cell) and allocates the memory for shape functions, shape function gradients, and JxW_cell in Local CG FEM based assemblers - variable data (cell) . More...
|
| |
| virtual void | make_assemblers_bdry_constant_data (const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info) |
| | This function computes Local CG FEM based assemblers - constant data (boundary) and allocates the memory for shape functions, normal_vectors, and JxW_bdry in Local CG FEM based assemblers - variable data (boundary) . More...
|
| |
| virtual void | make_assemblers_cell_variable_data (const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | This function computes Local CG FEM based assemblers - variable data (cell) . More...
|
| |
| virtual void | make_assemblers_bdry_variable_data (const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | This function computes Local CG FEM based assemblers - variable data (boundary) . More...
|
| |
|
| virtual void | make_internal_cell_couplings () |
| | This function fills out internal_cell_couplings. More...
|
| |
| virtual void | make_boundary_types () |
| | This function fills out boundary_types. More...
|
| |
| virtual void | make_output_types () |
| | This function fills out output_types. More...
|
| |
| | EquationBase (FuelCell::SystemManagement &sys_management, boost::shared_ptr< FuelCell::ApplicationCore::ApplicationData > data=boost::shared_ptr< FuelCell::ApplicationCore::ApplicationData >()) |
| | Constructor. More...
|
| |
| virtual | ~EquationBase () |
| | Destructor. More...
|
| |
| virtual void | set_parameters (const std::vector< std::string > &name_dvar, const std::vector< double > &value_dvar, ParameterHandler ¶m) |
| | Set parameters using the parameter file, in order to run parametric/optimization studies. More...
|
| |
| void | select_cell_assemblers (const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | This routine is used to select the make_assembly routines that need to be called inside assemble_cell_matrix to compute. More...
|
| |
| virtual void | make_internal_flux_couplings () |
| | This function fills out internal_flux_couplings (DG FEM only) of a derived equation class. More...
|
| |
| virtual void | make_component_materialID_value () |
| | This function fills out component_materialID_value of a derived equation class. More...
|
| |
| virtual void | make_component_boundaryID_value () |
| | This function fills out component_boundaryID_value of a derived equation class. More...
|
| |
| virtual void | make_multi_boundary_types () |
| | This function fills out multi_boundary_types of a derived equation class. More...
|
| |
| virtual void | make_multi_output_types () |
| | This function fills out multi_output_types of a derived equation class. More...
|
| |
| virtual void | make_matrix_block_indices () |
| | This function is only needed to provide the last argument to dealII_to_appframe. More...
|
| |
| virtual void | make_residual_indices () |
| | This function is only needed to provide the last argument to dealII_to_appframe. More...
|
| |
| virtual void | assemble_cell_Jacobian_matrix (FuelCell::ApplicationCore::MatrixVector &cell_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble the local Jacobian Matrix for Non-Linear problems. More...
|
| |
| virtual void | assemble_bdry_Jacobian_matrix (FuelCell::ApplicationCore::MatrixVector &bdry_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local Jacobian boundary matrix for Non-Linear problems. More...
|
| |
| virtual void | assemble_cell_linear_matrix (FuelCell::ApplicationCore::MatrixVector &cell_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble the local cell matrix for Linear problems. More...
|
| |
| virtual void | assemble_cell_residual_rhs (FuelCell::ApplicationCore::FEVector &cell_residual, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local cell RHS for nonlinear problems. More...
|
| |
| virtual void | assemble_cell_linear_rhs (FuelCell::ApplicationCore::FEVector &cell_residual, const typename FuelCell::ApplicationCore::DoFApplication< dim >::CellInfo &cell_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local cell RHS for Linear problems. More...
|
| |
| virtual void | assemble_bdry_linear_matrix (FuelCell::ApplicationCore::MatrixVector &bdry_matrices, const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local boundary matrix for linear problems. More...
|
| |
| virtual void | assemble_bdry_linear_rhs (FuelCell::ApplicationCore::FEVector &bdry_residual, const typename FuelCell::ApplicationCore::DoFApplication< dim >::FaceInfo &bdry_info, FuelCellShop::Layer::BaseLayer< dim > *const layer) |
| | Assemble local boundary RHS for linear problems. More...
|
| |
| void | standard_to_block_wise (FullMatrix< double > &target) const |
| | This function changes the order of dealii::FullMatrix<double> target from standard to block-wise. More...
|
| |
| void | standard_to_block_wise (Vector< double > &target) const |
| | This function changes the order of dealii::Vector<double> target from standard to block-wise. More...
|
| |
| void | dealII_to_appframe (FuelCell::ApplicationCore::MatrixVector &dst, const FullMatrix< double > &src, const std::vector< unsigned int > &matrix_block_indices) const |
| | This function converts the standard ordered structure dealii::FullMatrix<double> src into the block-wise ordered structure FuelCell::ApplicationCore::MatrixVector dst. More...
|
| |
| void | dealII_to_appframe (FuelCell::ApplicationCore::FEVector &dst, const Vector< double > &src, const std::vector< unsigned int > &residual_indices) const |
| | This function converts the standard ordered structure dealii::Vector<double> src into the block-wise ordered structure FuelCell::ApplicationCore::FEVector dst. More...
|
| |
| bool | belongs_to_boundary (const unsigned int &tria_boundary_id, const unsigned int ¶m_boundary_id) const |
| | This function returns true if a boundary indicator of an external face on the triangulation coincides with a boundary indicator defined in the parameters file of a derived equation class. More...
|
| |
| void | print_caller_name (const std::string &caller_name) const |
| | This function is used to print out the name of another function that has been declared in the scope of this class, but not yet been implemented. More...
|
| |
|
| std::map< unsigned int, double > | capillary_pressure_current_flux_map |
| |
| bool | cell_residual_counter |
| | Counter set to TRUE when cell_residual is being assembled. More...
|
| |
| unsigned int | last_iter_cell |
| | Variable used to store the index in cell_info->global_data of the previous Newton solution The solution at the previous iteration is used to compute cell_matrix and cell_residual. More...
|
| |
| unsigned int | last_iter_bdry |
| |
| double | T_constant |
| | This tempearture is used when not solving temperature as the solution variable. More...
|
| |
|
| VariableInfo | p_liquid_water |
| | VariableInfo structure corresponding to "liquid_water_saturation". More...
|
| |
| VariableInfo | x_water |
| | VariableInfo structure corresponding to "water_molar_fraction". More...
|
| |
| VariableInfo | t_rev |
| | VariableInfo structure corresponding to "temperature_of_REV". More...
|
| |
| unsigned int | fickswater_blockindex_xwater |
| | Block index for "water_molar_fraction" corresponding to "Ficks Transport Equation - water". More...
|
| |
| unsigned int | fickswater_blockindex_pliquid |
| | Block index for "liquid_water_saturation" corresponding to "Ficks Transport Equation - water". More...
|
| |
| unsigned int | fickswater_blockindex_trev |
| | Block index for "temperature_of_REV" corresponding to "Ficks Transport Equation - water". More...
|
| |
| unsigned int | thermal_blockindex_xwater |
| | Block index for "water_molar_fraction" corresponding to "Thermal Transport Equation". More...
|
| |
| unsigned int | thermal_blockindex_pliquid |
| | Block index for "liquid_water_saturation" corresponding to "Thermal Transport Equation". More...
|
| |
| unsigned int | thermal_blockindex_trev |
| | Block index for "temperature_of_REV" corresponding to "Thermal Transport Equation". More...
|
| |
| double | M_water |
| | Molar weight of water in grams/mole. More...
|
| |
| double | k_e |
| | Evaporation rate constant, . More...
|
| |
| double | k_c |
| | Condensation rate constant, . More...
|
| |
| double | p_channel_GDL |
| | The boundary condition term which indicates the capillary pressure in the channel. More...
|
| |
| double | rho_l |
| | Density of liquid water, . More...
|
| |
| double | k_sat |
| |
| double | k_sat_bdry |
| |
|
| double | p_cell |
| | Total pressure in the cell. More...
|
| |
| std::vector< double > | area_lv_cell |
| | Interfacial surface area per unit volume, , at all quadrature points in the cell. More...
|
| |
| std::vector< double > | darea_lv_dp_cell |
| | , at all quadrature points in the cell. More...
|
| |
| std::vector< Tensor< 2, dim > > | rhok_mu_cell |
| | , at all quadrature points in the cell. More...
|
| |
| std::vector< Tensor< 2, dim > > | rhok_mu_cell_bdry |
| |
| std::vector< Tensor< 2, dim > > | rho_mu_dk_dp_cell |
| |
| std::vector< Tensor< 2, dim > > | dT_rhok_mu_cell |
| |
std::vector< std::vector
< double > > | phi_p_cell |
| | shape functions. More...
|
| |
std::vector< std::vector
< double > > | phi_p_cell_bdry |
| |
std::vector< std::vector
< double > > | phi_xwater_cell |
| | shape functions. More...
|
| |
std::vector< std::vector
< double > > | phi_T_cell |
| | shape functions. More...
|
| |
std::vector< std::vector
< Tensor< 1, dim > > > | grad_phi_p_cell |
| | shape function gradients. More...
|
| |
std::vector< std::vector
< Tensor< 1, dim > > > | grad_phi_T_cell |
| | shape function gradients. More...
|
| |
| unsigned int | dofs_per_cell |
| | Number of degrees of freedom per cell. More...
|
| |
| unsigned int | n_q_points_cell |
| | Number of quadrature points per cell. More...
|
| |
| unsigned int | n_q_points_bdry |
| | Number of quadrature points per boundary. More...
|
| |
DoFHandler< dim >
::active_cell_iterator | cell |
| | Currently active DoFHandler<dim> active cell iterator. More...
|
| |
DoFHandler< dim >
::active_face_iterator | bdry |
| | Currently active DoFHandler<dim> active boundary iterator. More...
|
| |
| std::vector< double > | JxW_cell |
| | Jacobian of mapping by Weight in the quadrature points of a cell. More...
|
| |
| std::vector< double > | JxW_bdry |
| | Jacobian of mapping by Weight in the quadrature points of a boundary. More...
|
| |
| std::vector< Point< dim > > | normal_vectors |
| | Normal vectors in the quadrature points of a boundary. More...
|
| |
std::vector< std::vector
< Point< dim > > > | tangential_vectors |
| | Tangential vectors in the quadrature points of a boundary. More...
|
| |
| FuelCell::SystemManagement * | system_management |
| | Pointer to the external YourApplication<dim>::system_management object. More...
|
| |
| couplings_map | internal_cell_couplings |
| | This object contains the info on how the equations and solution variables of a derived equation class are coupled. More...
|
| |
| couplings_map | internal_flux_couplings |
| | This object contains the info on how the "X" and "Y" of a derived equation class are coupled (DG FEM only). More...
|
| |
| component_materialID_value_map | component_materialID_value |
| | This object reflects the following structure (see FuelCell::InitialAndBoundaryData namespace docs): More...
|
| |
| component_boundaryID_value_map | component_boundaryID_value |
| | This object reflects the following structure (see FuelCell::InitialAndBoundaryData namespace docs): More...
|
| |
| std::vector< BoundaryType > | boundary_types |
| | The list of boundary types of a derived equation class. More...
|
| |
std::vector< std::vector
< BoundaryType > > | multi_boundary_types |
| | The list of multiple boundary types of a derived equation class. More...
|
| |
| std::vector< OutputType > | output_types |
| | The list of output types of a derived equation class. More...
|
| |
std::vector< std::vector
< OutputType > > | multi_output_types |
| | The list of multiple output types of a derived equation class. More...
|
| |
| std::string | equation_name |
| | The name of a derived equation class. More...
|
| |
| std::string | name_base_variable |
| | Const std::string member storing name of the base solution variable corresponding to the equation represented by this class. More...
|
| |
| std::vector< unsigned int > | matrix_block_indices |
| | The system matrix block indices (a derived equation class) drawn from the global structure (a derived equation class + other active equation classes included into the computation). More...
|
| |
| std::vector< unsigned int > | residual_indices |
| | The residual indices (a derived equation class) drawn from the global structure (a derived equation class + other active equation classes included into the computation). More...
|
| |
| std::vector< bool > | counter |
| | This vector contains the collection of internal "counters" used by the derived equation classes. More...
|
| |
| EquationFlags | assemble_flags |
| | This vector contains a collection of internal flags to tell derived equation classes what needs to be re-computed. More...
|
| |
boost::shared_ptr
< FuelCell::ApplicationCore::ApplicationData > | data |
| | Data object for the application data to be passed to the equation classes. More...
|
| |
| std::string | solution_vector_name |
| | The name of the solution vector in FEVectors. More...
|
| |
| std::string | residual_vector_name |
| | The name of the residual vector name in FEVectors. More...
|
| |