libMesh
|
#include <hdg_problem.h>
Public Member Functions | |
HDGProblem (const Real nu_in, const bool cavity_in) | |
~HDGProblem () | |
void | init () |
virtual void | residual (const NumericVector< Number > &X, NumericVector< Number > &R, NonlinearImplicitSystem &S) override |
virtual void | jacobian (const NumericVector< Number > &X, SparseMatrix< Number > &, NonlinearImplicitSystem &S) override |
virtual void | residual (const NumericVector< Number > &X, NumericVector< Number > &R, sys_type &S)=0 |
Residual function. More... | |
virtual void | jacobian (const NumericVector< Number > &X, SparseMatrix< Number > &J, sys_type &S)=0 |
Jacobian function. More... | |
Public Attributes | |
System * | system |
const MeshBase * | mesh |
const DofMap * | dof_map |
StaticCondensation * | sc |
std::unique_ptr< FEVectorBase > | vector_fe |
std::unique_ptr< FEBase > | scalar_fe |
std::unique_ptr< QBase > | qrule |
std::unique_ptr< FEVectorBase > | vector_fe_face |
std::unique_ptr< FEBase > | scalar_fe_face |
std::unique_ptr< FEBase > | lm_fe_face |
std::unique_ptr< QBase > | qface |
boundary_id_type | left_bnd |
boundary_id_type | top_bnd |
boundary_id_type | right_bnd |
boundary_id_type | bottom_bnd |
Real | nu |
bool | cavity |
const USoln | u_true_soln |
const VSoln | v_true_soln |
const PSoln | p_true_soln |
bool | mms |
Private Member Functions | |
void | add_matrix (NonlinearImplicitSystem &sys, const unsigned int ivar_num, const unsigned int jvar_num, const DenseMatrix< Number > &elem_mat) |
void | create_identity_residual (const QBase &quadrature, const std::vector< Real > &JxW_local, const std::vector< std::vector< Real >> &phi, const std::vector< Number > &sol, const std::size_t n_dofs, DenseVector< Number > &R) |
void | create_identity_jacobian (const QBase &quadrature, const std::vector< Real > &JxW_local, const std::vector< std::vector< Real >> &phi, const std::size_t n_dofs, DenseMatrix< Number > &J) |
void | compute_stress (const std::vector< Gradient > &vel_gradient, const unsigned int vel_component, std::vector< Gradient > &sigma) |
void | vector_volume_residual (const std::vector< Gradient > &vector_sol, const std::vector< Number > &scalar_sol, DenseVector< Number > &R) |
void | vector_volume_jacobian (DenseMatrix< Number > &Jqq, DenseMatrix< Number > &Jqs) |
NumberVectorValue | vel_cross_vel_residual (const std::vector< Number > &u_sol_local, const std::vector< Number > &v_sol_local, const unsigned int qp, const unsigned int vel_component) const |
NumberVectorValue | vel_cross_vel_jacobian (const std::vector< Number > &u_sol_local, const std::vector< Number > &v_sol_local, const unsigned int qp, const unsigned int vel_component, const unsigned int vel_j_component, const std::vector< std::vector< Real >> &phi, const unsigned int j) const |
void | scalar_volume_residual (const std::vector< Gradient > &vel_gradient, const unsigned int vel_component, std::vector< Gradient > &sigma, DenseVector< Number > &R) |
void | scalar_volume_jacobian (const unsigned int vel_component, DenseMatrix< Number > &Jsq, DenseMatrix< Number > &Jsp, DenseMatrix< Number > &Jsu, DenseMatrix< Number > &Jsv) |
void | pressure_volume_residual (DenseVector< Number > &Rp, DenseVector< Number > &Rglm) |
void | pressure_volume_jacobian (DenseMatrix< Number > &Jpu, DenseMatrix< Number > &Jpv, DenseMatrix< Number > &Jpglm, DenseMatrix< Number > &Jglmp) |
void | pressure_face_residual (DenseVector< Number > &R) |
void | pressure_face_jacobian (DenseMatrix< Number > &Jplm_u, DenseMatrix< Number > &Jplm_v) |
RealVectorValue | get_dirichlet_velocity (const unsigned int qp) const |
void | pressure_dirichlet_residual (DenseVector< Number > &R) |
void | vector_dirichlet_residual (const unsigned int vel_component, DenseVector< Number > &R) |
void | vector_face_residual (const std::vector< Number > &lm_sol, DenseVector< Number > &R) |
void | vector_face_jacobian (DenseMatrix< Number > &Jqlm) |
void | scalar_dirichlet_residual (const std::vector< Gradient > &vector_sol, const std::vector< Number > &scalar_sol, const unsigned int vel_component, DenseVector< Number > &R) |
void | scalar_dirichlet_jacobian (const unsigned int vel_component, DenseMatrix< Number > &Jsq, DenseMatrix< Number > &Jsp, DenseMatrix< Number > &Jss) |
void | scalar_face_residual (const std::vector< Gradient > &vector_sol, const std::vector< Number > &scalar_sol, const std::vector< Number > &lm_sol, const unsigned int vel_component, DenseVector< Number > &R) |
void | scalar_face_jacobian (const unsigned int vel_component, DenseMatrix< Number > &Jsq, DenseMatrix< Number > &Jsp, DenseMatrix< Number > &Jss, DenseMatrix< Number > &Jslm, DenseMatrix< Number > &Js_lmu, DenseMatrix< Number > &Js_lmv) |
void | lm_face_residual (const std::vector< Gradient > &vector_sol, const std::vector< Number > &scalar_sol, const std::vector< Number > &lm_sol, const unsigned int vel_component, DenseVector< Number > &R) |
void | lm_face_jacobian (const unsigned int vel_component, DenseMatrix< Number > &Jlmq, DenseMatrix< Number > &Jlmp, DenseMatrix< Number > &Jlms, DenseMatrix< Number > &Jlmlm, DenseMatrix< Number > &Jlm_lmu, DenseMatrix< Number > &Jlm_lmv) |
Private Attributes | |
const std::vector< Real > * | JxW |
const std::vector< Point > * | q_point |
const std::vector< std::vector< RealVectorValue > > * | vector_phi |
const std::vector< std::vector< Real > > * | scalar_phi |
const std::vector< std::vector< RealVectorValue > > * | grad_scalar_phi |
const std::vector< std::vector< Real > > * | div_vector_phi |
const std::vector< Real > * | JxW_face |
const std::vector< Point > * | qface_point |
const std::vector< std::vector< RealVectorValue > > * | vector_phi_face |
const std::vector< std::vector< Real > > * | scalar_phi_face |
const std::vector< std::vector< Real > > * | lm_phi_face |
const std::vector< Point > * | normals |
std::unordered_map< unsigned int, std::vector< dof_id_type > > | dof_indices |
std::vector< Gradient > | qu_sol |
std::vector< Number > | u_sol |
std::vector< Number > | lm_u_sol |
std::vector< Gradient > | qv_sol |
std::vector< Number > | v_sol |
std::vector< Number > | lm_v_sol |
std::vector< Number > | p_sol |
std::vector< Gradient > | sigma_u |
std::vector< Gradient > | sigma_v |
std::vector< Number > | qu_dof_values |
std::vector< Number > | u_dof_values |
std::vector< Number > | lm_u_dof_values |
std::vector< Number > | qv_dof_values |
std::vector< Number > | v_dof_values |
std::vector< Number > | lm_v_dof_values |
std::vector< Number > | p_dof_values |
Number | global_lm_dof_value |
std::size_t | vector_n_dofs |
std::size_t | scalar_n_dofs |
std::size_t | lm_n_dofs |
std::size_t | p_n_dofs |
std::size_t | global_lm_n_dofs |
boundary_id_type | current_bnd |
const Elem * | neigh |
std::vector< Number > | qbar |
Static Private Attributes | |
static constexpr Real | tau = 1 |
Definition at line 36 of file hdg_problem.h.
libMesh::HDGProblem::HDGProblem | ( | const Real | nu_in, |
const bool | cavity_in | ||
) |
Definition at line 55 of file hdg_problem.C.
|
default |
|
private |
Definition at line 888 of file hdg_problem.C.
References libMesh::SparseMatrix< T >::add_matrix(), dof_indices, and libMesh::ImplicitSystem::get_system_matrix().
Referenced by jacobian().
|
private |
Definition at line 133 of file hdg_problem.C.
References libMesh::make_range(), nu, p_sol, and qrule.
Referenced by scalar_volume_residual().
|
private |
Definition at line 120 of file hdg_problem.C.
References libMesh::make_range(), and libMesh::QBase::n_points().
Referenced by jacobian().
|
private |
Definition at line 107 of file hdg_problem.C.
References libMesh::make_range(), and libMesh::QBase::n_points().
Referenced by residual().
|
private |
Definition at line 373 of file hdg_problem.C.
References cavity, current_bnd, left_bnd, libMesh::libmesh_assert(), mms, qface_point, right_bnd, top_bnd, u_true_soln, and v_true_soln.
Referenced by pressure_dirichlet_residual(), scalar_dirichlet_residual(), and vector_dirichlet_residual().
void libMesh::HDGProblem::init | ( | ) |
Definition at line 67 of file hdg_problem.C.
References bottom_bnd, cavity, div_vector_phi, libMesh::MeshBase::get_boundary_info(), global_lm_n_dofs, grad_scalar_phi, libMesh::BoundaryInfo::invalid_id, JxW, JxW_face, left_bnd, libMesh::libmesh_assert(), lm_fe_face, lm_phi_face, mesh, normals, q_point, qface, qface_point, qrule, right_bnd, scalar_fe, scalar_fe_face, scalar_phi, scalar_phi_face, top_bnd, vector_fe, vector_fe_face, vector_phi, and vector_phi_face.
Referenced by main().
|
overridevirtual |
Definition at line 898 of file hdg_problem.C.
References libMesh::SparseMatrix< T >::add(), add_matrix(), cavity, libMesh::compute_qp_soln(), create_identity_jacobian(), current_bnd, dof_indices, libMesh::DofMap::dof_indices(), dof_map, libMesh::NumericVector< T >::get(), libMesh::MeshBase::get_boundary_info(), libMesh::ImplicitSystem::get_system_matrix(), global_lm_dof_value, libMesh::invalid_uint, JxW_face, libMesh::libmesh_assert(), lm_face_jacobian(), lm_fe_face, lm_n_dofs, lm_phi_face, lm_u_dof_values, lm_u_sol, lm_v_dof_values, lm_v_sol, libMesh::make_range(), mesh, neigh, libMesh::Elem::neighbor_ptr(), p_dof_values, p_n_dofs, p_sol, pressure_face_jacobian(), pressure_volume_jacobian(), qface, qrule, qu_dof_values, qu_sol, qv_dof_values, qv_sol, libMesh::DenseMatrix< T >::resize(), right_bnd, sc, scalar_dirichlet_jacobian(), scalar_face_jacobian(), scalar_fe, scalar_fe_face, scalar_n_dofs, scalar_phi, scalar_phi_face, scalar_volume_jacobian(), libMesh::StaticCondensation::set_current_elem(), u_dof_values, u_sol, v_dof_values, v_sol, libMesh::System::variable_number(), vector_face_jacobian(), vector_fe, vector_fe_face, vector_n_dofs, vector_phi, vector_phi_face, and vector_volume_jacobian().
|
pure virtualinherited |
Jacobian function.
This function will be called to compute the jacobian and must be implemented by the user in a derived class.
Referenced by libMesh::Problem_Interface::computeJacobian(), libMesh::Problem_Interface::computePreconditioner(), and libMesh::libmesh_petsc_snes_jacobian().
|
private |
Definition at line 657 of file hdg_problem.C.
References current_bnd, lm_n_dofs, lm_phi_face, lm_u_sol, lm_v_sol, libMesh::make_range(), neigh, nu, p_n_dofs, qface, right_bnd, scalar_n_dofs, tau, vector_n_dofs, and vel_cross_vel_jacobian().
Referenced by jacobian().
|
private |
Definition at line 615 of file hdg_problem.C.
References current_bnd, lm_n_dofs, lm_u_sol, lm_v_sol, libMesh::make_range(), neigh, nu, p_sol, qface, right_bnd, tau, and vel_cross_vel_residual().
Referenced by residual().
|
private |
Definition at line 398 of file hdg_problem.C.
References get_dirichlet_velocity(), libMesh::make_range(), p_n_dofs, and qface.
Referenced by residual().
|
private |
Definition at line 355 of file hdg_problem.C.
References lm_n_dofs, lm_phi_face, libMesh::make_range(), p_n_dofs, and qface.
Referenced by jacobian().
|
private |
Definition at line 343 of file hdg_problem.C.
References lm_u_sol, lm_v_sol, libMesh::make_range(), p_n_dofs, and qface.
Referenced by residual().
|
private |
Definition at line 309 of file hdg_problem.C.
References cavity, libMesh::libmesh_assert(), libMesh::make_range(), p_n_dofs, qrule, scalar_n_dofs, and scalar_phi.
Referenced by jacobian().
|
private |
Definition at line 281 of file hdg_problem.C.
References cavity, libMesh::PSoln::forcing(), global_lm_dof_value, libMesh::make_range(), mms, p_n_dofs, p_sol, p_true_soln, q_point, qrule, libMesh::Real, u_sol, and v_sol.
Referenced by residual().
|
overridevirtual |
Definition at line 714 of file hdg_problem.C.
References libMesh::NumericVector< T >::add_vector(), cavity, libMesh::compute_qp_soln(), create_identity_residual(), current_bnd, dof_indices, libMesh::DofMap::dof_indices(), dof_map, libMesh::NumericVector< T >::get(), libMesh::MeshBase::get_boundary_info(), global_lm_dof_value, libMesh::invalid_uint, JxW_face, libMesh::libmesh_assert(), lm_face_residual(), lm_fe_face, lm_n_dofs, lm_phi_face, lm_u_dof_values, lm_u_sol, lm_v_dof_values, lm_v_sol, mesh, neigh, libMesh::Elem::neighbor_ptr(), p_dof_values, p_n_dofs, p_sol, pressure_dirichlet_residual(), pressure_face_residual(), pressure_volume_residual(), qface, qrule, qu_dof_values, qu_sol, qv_dof_values, qv_sol, libMesh::DenseVector< T >::resize(), right_bnd, scalar_dirichlet_residual(), scalar_face_residual(), scalar_fe, scalar_fe_face, scalar_n_dofs, scalar_phi, scalar_phi_face, scalar_volume_residual(), sigma_u, sigma_v, u_dof_values, u_sol, v_dof_values, v_sol, libMesh::System::variable_number(), vector_dirichlet_residual(), vector_face_residual(), vector_fe, vector_fe_face, vector_n_dofs, vector_phi, vector_phi_face, vector_volume_residual(), and libMesh::NumericVector< T >::zero().
|
pure virtualinherited |
Residual function.
This function will be called to compute the residual and must be implemented by the user in a derived class.
Referenced by libMesh::Problem_Interface::computeF(), libMesh::libmesh_petsc_snes_fd_residual(), libMesh::libmesh_petsc_snes_mffd_residual(), and libMesh::libmesh_petsc_snes_residual().
|
private |
Definition at line 481 of file hdg_problem.C.
References libMesh::make_range(), nu, p_n_dofs, qface, scalar_n_dofs, tau, and vector_n_dofs.
Referenced by jacobian().
|
private |
Definition at line 443 of file hdg_problem.C.
References get_dirichlet_velocity(), libMesh::make_range(), nu, p_sol, qface, scalar_n_dofs, and tau.
Referenced by residual().
|
private |
Definition at line 551 of file hdg_problem.C.
References current_bnd, lm_n_dofs, lm_phi_face, lm_u_sol, lm_v_sol, libMesh::make_range(), neigh, nu, p_n_dofs, qface, right_bnd, scalar_n_dofs, tau, vector_n_dofs, and vel_cross_vel_jacobian().
Referenced by jacobian().
|
private |
Definition at line 508 of file hdg_problem.C.
References current_bnd, lm_u_sol, lm_v_sol, libMesh::make_range(), neigh, nu, p_sol, qface, right_bnd, scalar_n_dofs, tau, and vel_cross_vel_residual().
Referenced by residual().
|
private |
Definition at line 240 of file hdg_problem.C.
References libMesh::make_range(), nu, p_n_dofs, qrule, scalar_n_dofs, scalar_phi, u_sol, v_sol, vector_n_dofs, and vel_cross_vel_jacobian().
Referenced by jacobian().
|
private |
Definition at line 207 of file hdg_problem.C.
References compute_stress(), libMesh::make_range(), mms, q_point, qrule, libMesh::Real, scalar_n_dofs, u_sol, u_true_soln, v_sol, v_true_soln, and vel_cross_vel_residual().
Referenced by residual().
|
private |
Definition at line 410 of file hdg_problem.C.
References get_dirichlet_velocity(), libMesh::make_range(), qface, and vector_n_dofs.
Referenced by residual().
|
private |
Definition at line 432 of file hdg_problem.C.
References lm_n_dofs, lm_phi_face, libMesh::make_range(), qface, and vector_n_dofs.
Referenced by jacobian().
|
private |
Definition at line 423 of file hdg_problem.C.
References libMesh::make_range(), qface, and vector_n_dofs.
Referenced by residual().
|
private |
Definition at line 163 of file hdg_problem.C.
References libMesh::make_range(), qrule, scalar_n_dofs, and vector_n_dofs.
Referenced by jacobian().
|
private |
Definition at line 147 of file hdg_problem.C.
References libMesh::make_range(), qrule, and vector_n_dofs.
Referenced by residual().
|
private |
Definition at line 189 of file hdg_problem.C.
Referenced by lm_face_jacobian(), scalar_face_jacobian(), and scalar_volume_jacobian().
|
private |
Definition at line 179 of file hdg_problem.C.
Referenced by lm_face_residual(), scalar_face_residual(), and scalar_volume_residual().
boundary_id_type libMesh::HDGProblem::bottom_bnd |
Definition at line 62 of file hdg_problem.h.
Referenced by init().
bool libMesh::HDGProblem::cavity |
Definition at line 68 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), init(), jacobian(), pressure_volume_jacobian(), pressure_volume_residual(), and residual().
|
private |
Definition at line 253 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), jacobian(), lm_face_jacobian(), lm_face_residual(), residual(), scalar_face_jacobian(), and scalar_face_residual().
|
private |
Definition at line 206 of file hdg_problem.h.
Referenced by init().
|
private |
Definition at line 217 of file hdg_problem.h.
Referenced by add_matrix(), jacobian(), and residual().
const DofMap* libMesh::HDGProblem::dof_map |
Definition at line 46 of file hdg_problem.h.
Referenced by jacobian(), main(), and residual().
|
private |
Definition at line 240 of file hdg_problem.h.
Referenced by jacobian(), pressure_volume_residual(), and residual().
|
private |
Definition at line 247 of file hdg_problem.h.
Referenced by init().
|
private |
Definition at line 205 of file hdg_problem.h.
Referenced by init().
|
private |
Definition at line 201 of file hdg_problem.h.
Referenced by init().
|
private |
Definition at line 209 of file hdg_problem.h.
Referenced by init(), jacobian(), and residual().
boundary_id_type libMesh::HDGProblem::left_bnd |
Definition at line 59 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), and init().
std::unique_ptr<FEBase> libMesh::HDGProblem::lm_fe_face |
Definition at line 55 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
|
private |
Definition at line 245 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), lm_face_residual(), pressure_face_jacobian(), residual(), scalar_face_jacobian(), and vector_face_jacobian().
|
private |
Definition at line 213 of file hdg_problem.h.
Referenced by init(), jacobian(), lm_face_jacobian(), pressure_face_jacobian(), residual(), scalar_face_jacobian(), and vector_face_jacobian().
|
private |
Definition at line 235 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 222 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), lm_face_residual(), pressure_face_residual(), residual(), scalar_face_jacobian(), and scalar_face_residual().
|
private |
Definition at line 238 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 225 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), lm_face_residual(), pressure_face_residual(), residual(), scalar_face_jacobian(), and scalar_face_residual().
const MeshBase* libMesh::HDGProblem::mesh |
Definition at line 45 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
bool libMesh::HDGProblem::mms |
Definition at line 76 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), main(), pressure_volume_residual(), and scalar_volume_residual().
|
private |
Definition at line 256 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), lm_face_residual(), residual(), scalar_face_jacobian(), and scalar_face_residual().
|
private |
Definition at line 214 of file hdg_problem.h.
Referenced by init().
Real libMesh::HDGProblem::nu |
Definition at line 65 of file hdg_problem.h.
Referenced by compute_stress(), lm_face_jacobian(), lm_face_residual(), scalar_dirichlet_jacobian(), scalar_dirichlet_residual(), scalar_face_jacobian(), scalar_face_residual(), and scalar_volume_jacobian().
|
private |
Definition at line 239 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 246 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), pressure_dirichlet_residual(), pressure_face_jacobian(), pressure_face_residual(), pressure_volume_jacobian(), pressure_volume_residual(), residual(), scalar_dirichlet_jacobian(), scalar_face_jacobian(), and scalar_volume_jacobian().
|
private |
Definition at line 226 of file hdg_problem.h.
Referenced by compute_stress(), jacobian(), lm_face_residual(), pressure_volume_residual(), residual(), scalar_dirichlet_residual(), and scalar_face_residual().
const PSoln libMesh::HDGProblem::p_true_soln |
Definition at line 73 of file hdg_problem.h.
Referenced by main(), and pressure_volume_residual().
|
private |
Definition at line 202 of file hdg_problem.h.
Referenced by init(), pressure_volume_residual(), and scalar_volume_residual().
|
private |
Definition at line 259 of file hdg_problem.h.
std::unique_ptr<QBase> libMesh::HDGProblem::qface |
Definition at line 56 of file hdg_problem.h.
Referenced by init(), jacobian(), lm_face_jacobian(), lm_face_residual(), main(), pressure_dirichlet_residual(), pressure_face_jacobian(), pressure_face_residual(), residual(), scalar_dirichlet_jacobian(), scalar_dirichlet_residual(), scalar_face_jacobian(), scalar_face_residual(), vector_dirichlet_residual(), vector_face_jacobian(), and vector_face_residual().
|
private |
Definition at line 210 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), and init().
std::unique_ptr<QBase> libMesh::HDGProblem::qrule |
Definition at line 52 of file hdg_problem.h.
Referenced by compute_stress(), init(), jacobian(), main(), pressure_volume_jacobian(), pressure_volume_residual(), residual(), scalar_volume_jacobian(), scalar_volume_residual(), vector_volume_jacobian(), and vector_volume_residual().
|
private |
Definition at line 233 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 220 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 236 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 223 of file hdg_problem.h.
Referenced by jacobian(), and residual().
boundary_id_type libMesh::HDGProblem::right_bnd |
Definition at line 61 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), init(), jacobian(), lm_face_jacobian(), lm_face_residual(), residual(), scalar_face_jacobian(), and scalar_face_residual().
StaticCondensation* libMesh::HDGProblem::sc |
Definition at line 47 of file hdg_problem.h.
Referenced by jacobian(), and main().
std::unique_ptr<FEBase> libMesh::HDGProblem::scalar_fe |
Definition at line 51 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
std::unique_ptr<FEBase> libMesh::HDGProblem::scalar_fe_face |
Definition at line 54 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
|
private |
Definition at line 244 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), pressure_volume_jacobian(), residual(), scalar_dirichlet_jacobian(), scalar_dirichlet_residual(), scalar_face_jacobian(), scalar_face_residual(), scalar_volume_jacobian(), scalar_volume_residual(), and vector_volume_jacobian().
|
private |
Definition at line 204 of file hdg_problem.h.
Referenced by init(), jacobian(), pressure_volume_jacobian(), residual(), and scalar_volume_jacobian().
|
private |
Definition at line 212 of file hdg_problem.h.
Referenced by init(), jacobian(), and residual().
|
private |
Definition at line 229 of file hdg_problem.h.
Referenced by residual().
|
private |
Definition at line 230 of file hdg_problem.h.
Referenced by residual().
System* libMesh::HDGProblem::system |
Definition at line 44 of file hdg_problem.h.
Referenced by main().
|
staticprivate |
Definition at line 250 of file hdg_problem.h.
Referenced by lm_face_jacobian(), lm_face_residual(), scalar_dirichlet_jacobian(), scalar_dirichlet_residual(), scalar_face_jacobian(), and scalar_face_residual().
boundary_id_type libMesh::HDGProblem::top_bnd |
Definition at line 60 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), and init().
|
private |
Definition at line 234 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 221 of file hdg_problem.h.
Referenced by jacobian(), pressure_volume_residual(), residual(), scalar_volume_jacobian(), and scalar_volume_residual().
const USoln libMesh::HDGProblem::u_true_soln |
Definition at line 71 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), main(), and scalar_volume_residual().
|
private |
Definition at line 237 of file hdg_problem.h.
Referenced by jacobian(), and residual().
|
private |
Definition at line 224 of file hdg_problem.h.
Referenced by jacobian(), pressure_volume_residual(), residual(), scalar_volume_jacobian(), and scalar_volume_residual().
const VSoln libMesh::HDGProblem::v_true_soln |
Definition at line 72 of file hdg_problem.h.
Referenced by get_dirichlet_velocity(), main(), and scalar_volume_residual().
std::unique_ptr<FEVectorBase> libMesh::HDGProblem::vector_fe |
Definition at line 50 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
std::unique_ptr<FEVectorBase> libMesh::HDGProblem::vector_fe_face |
Definition at line 53 of file hdg_problem.h.
Referenced by init(), jacobian(), main(), and residual().
|
private |
Definition at line 243 of file hdg_problem.h.
Referenced by jacobian(), lm_face_jacobian(), residual(), scalar_dirichlet_jacobian(), scalar_face_jacobian(), scalar_volume_jacobian(), vector_dirichlet_residual(), vector_face_jacobian(), vector_face_residual(), vector_volume_jacobian(), and vector_volume_residual().
|
private |
Definition at line 203 of file hdg_problem.h.
Referenced by init(), jacobian(), and residual().
|
private |
Definition at line 211 of file hdg_problem.h.
Referenced by init(), jacobian(), and residual().