Extends FEMContext to work for DG problems. More...
#include <dg_fem_context.h>
Public Types | |
enum | AlgebraicType { NONE = 0, DOFS_ONLY, CURRENT, OLD, OLD_DOFS_ONLY } |
typedef const DenseSubVector< Number > &(DiffContext::* | diff_subsolution_getter) (unsigned int) const |
typedef std::map< const NumericVector< Number > *, std::pair< DenseVector< Number >, std::vector< std::unique_ptr< DenseSubVector< Number > > > > >::iterator | localized_vectors_iterator |
Public Member Functions | |
DGFEMContext (const System &sys) | |
virtual | ~DGFEMContext () |
virtual void | side_fe_reinit () override |
void | neighbor_side_fe_reinit () |
const std::vector< dof_id_type > & | get_neighbor_dof_indices () const |
const std::vector< dof_id_type > & | get_neighbor_dof_indices (unsigned int var) const |
const DenseVector< Number > & | get_neighbor_residual () const |
DenseVector< Number > & | get_neighbor_residual () |
const DenseSubVector< Number > & | get_neighbor_residual (unsigned int var) const |
DenseSubVector< Number > & | get_neighbor_residual (unsigned int var) |
const DenseMatrix< Number > & | get_elem_elem_jacobian () const |
DenseMatrix< Number > & | get_elem_elem_jacobian () |
const DenseSubMatrix< Number > & | get_elem_elem_jacobian (unsigned int var1, unsigned int var2) const |
DenseSubMatrix< Number > & | get_elem_elem_jacobian (unsigned int var1, unsigned int var2) |
const DenseMatrix< Number > & | get_elem_neighbor_jacobian () const |
DenseMatrix< Number > & | get_elem_neighbor_jacobian () |
const DenseSubMatrix< Number > & | get_elem_neighbor_jacobian (unsigned int var1, unsigned int var2) const |
DenseSubMatrix< Number > & | get_elem_neighbor_jacobian (unsigned int var1, unsigned int var2) |
const DenseMatrix< Number > & | get_neighbor_elem_jacobian () const |
DenseMatrix< Number > & | get_neighbor_elem_jacobian () |
const DenseSubMatrix< Number > & | get_neighbor_elem_jacobian (unsigned int var1, unsigned int var2) const |
DenseSubMatrix< Number > & | get_neighbor_elem_jacobian (unsigned int var1, unsigned int var2) |
const DenseMatrix< Number > & | get_neighbor_neighbor_jacobian () const |
DenseMatrix< Number > & | get_neighbor_neighbor_jacobian () |
const DenseSubMatrix< Number > & | get_neighbor_neighbor_jacobian (unsigned int var1, unsigned int var2) const |
DenseSubMatrix< Number > & | get_neighbor_neighbor_jacobian (unsigned int var1, unsigned int var2) |
void | set_neighbor (const Elem &neighbor) |
const Elem & | get_neighbor () const |
bool | dg_terms_are_active () const |
template<typename OutputShape > | |
void | get_neighbor_side_fe (unsigned int var, FEGenericBase< OutputShape > *&fe) const |
bool | has_side_boundary_id (boundary_id_type id) const |
std::vector< boundary_id_type > | side_boundary_ids () const |
void | side_boundary_ids (std::vector< boundary_id_type > &vec_to_fill) const |
Number | interior_value (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | interior_value (unsigned int var, unsigned int qp, OutputType &u) const |
Number | side_value (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | side_value (unsigned int var, unsigned int qp, OutputType &u) const |
Number | point_value (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | point_value (unsigned int var, const Point &p, OutputType &u, const Real tolerance=TOLERANCE) const |
Gradient | interior_gradient (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | interior_gradient (unsigned int var, unsigned int qp, OutputType &du) const |
Gradient | side_gradient (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | side_gradient (unsigned int var, unsigned int qp, OutputType &du) const |
Gradient | point_gradient (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | point_gradient (unsigned int var, const Point &p, OutputType &grad_u, const Real tolerance=TOLERANCE) const |
Tensor | interior_hessian (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | interior_hessian (unsigned int var, unsigned int qp, OutputType &d2u) const |
Tensor | side_hessian (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | side_hessian (unsigned int var, unsigned int qp, OutputType &d2u) const |
Tensor | point_hessian (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | point_hessian (unsigned int var, const Point &p, OutputType &hess_u, const Real tolerance=TOLERANCE) const |
Number | fixed_interior_value (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_interior_value (unsigned int var, unsigned int qp, OutputType &u) const |
Number | fixed_side_value (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_side_value (unsigned int var, unsigned int qp, OutputType &u) const |
Number | fixed_point_value (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | fixed_point_value (unsigned int var, const Point &p, OutputType &u, const Real tolerance=TOLERANCE) const |
Gradient | fixed_interior_gradient (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_interior_gradient (unsigned int var, unsigned int qp, OutputType &grad_u) const |
Gradient | fixed_side_gradient (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_side_gradient (unsigned int var, unsigned int qp, OutputType &grad_u) const |
Gradient | fixed_point_gradient (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | fixed_point_gradient (unsigned int var, const Point &p, OutputType &grad_u, const Real tolerance=TOLERANCE) const |
Tensor | fixed_interior_hessian (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_interior_hessian (unsigned int var, unsigned int qp, OutputType &hess_u) const |
Tensor | fixed_side_hessian (unsigned int var, unsigned int qp) const |
template<typename OutputType > | |
void | fixed_side_hessian (unsigned int var, unsigned int qp, OutputType &hess_u) const |
Tensor | fixed_point_hessian (unsigned int var, const Point &p) const |
template<typename OutputType > | |
void | fixed_point_hessian (unsigned int var, const Point &p, OutputType &hess_u, const Real tolerance=TOLERANCE) const |
template<typename OutputShape > | |
void | get_element_fe (unsigned int var, FEGenericBase< OutputShape > *&fe) const |
FEBase * | get_element_fe (unsigned int var) const |
template<typename OutputShape > | |
void | get_element_fe (unsigned int var, FEGenericBase< OutputShape > *&fe, unsigned short dim) const |
FEBase * | get_element_fe (unsigned int var, unsigned short dim) const |
template<typename OutputShape > | |
void | get_side_fe (unsigned int var, FEGenericBase< OutputShape > *&fe) const |
FEBase * | get_side_fe (unsigned int var) const |
template<typename OutputShape > | |
void | get_side_fe (unsigned int var, FEGenericBase< OutputShape > *&fe, unsigned short dim) const |
FEBase * | get_side_fe (unsigned int var, unsigned short dim) const |
template<typename OutputShape > | |
void | get_edge_fe (unsigned int var, FEGenericBase< OutputShape > *&fe) const |
FEBase * | get_edge_fe (unsigned int var) const |
template<typename OutputType > | |
void | interior_values (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &interior_values_vector) const |
template<typename OutputType > | |
void | side_values (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &side_values_vector) const |
template<typename OutputType > | |
void | interior_gradients (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &interior_gradients_vector) const |
template<typename OutputType > | |
void | side_gradients (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &side_gradients_vector) const |
template<typename OutputType > | |
void | interior_hessians (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &d2u_vals) const |
template<typename OutputType > | |
void | side_hessians (unsigned int var, const NumericVector< Number > &_system_vector, std::vector< OutputType > &d2u_vals) const |
template<typename OutputType > | |
void | interior_rate (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType > | |
void | side_rate (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType > | |
void | point_rate (unsigned int var, const Point &p, OutputType &u) const |
template<typename OutputType > | |
void | interior_accel (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType > | |
void | side_accel (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType > | |
void | point_accel (unsigned int var, const Point &p, OutputType &u) const |
template<typename OutputType > | |
void | interior_curl (unsigned int var, unsigned int qp, OutputType &curl_u) const |
template<typename OutputType > | |
void | point_curl (unsigned int var, const Point &p, OutputType &curl_u, const Real tolerance=TOLERANCE) const |
template<typename OutputType > | |
void | interior_div (unsigned int var, unsigned int qp, OutputType &div_u) const |
virtual void | elem_reinit (Real theta) override |
virtual void | elem_side_reinit (Real theta) override |
virtual void | elem_edge_reinit (Real theta) override |
virtual void | nonlocal_reinit (Real theta) override |
virtual void | pre_fe_reinit (const System &, const Elem *e) |
virtual void | elem_fe_reinit (const std::vector< Point > *const pts=nullptr) |
virtual void | edge_fe_reinit () |
const QBase & | get_element_qrule () const |
const QBase & | get_element_qrule (unsigned short dim) const |
const QBase & | get_side_qrule () const |
const QBase & | get_side_qrule (unsigned short dim) const |
const QBase & | get_edge_qrule () const |
virtual void | set_mesh_system (System *sys) |
const System * | get_mesh_system () const |
System * | get_mesh_system () |
unsigned int | get_mesh_x_var () const |
void | set_mesh_x_var (unsigned int x_var) |
unsigned int | get_mesh_y_var () const |
void | set_mesh_y_var (unsigned int y_var) |
unsigned int | get_mesh_z_var () const |
void | set_mesh_z_var (unsigned int z_var) |
bool | has_elem () const |
const Elem & | get_elem () const |
Elem & | get_elem () |
unsigned char | get_side () const |
unsigned char | get_edge () const |
unsigned char | get_dim () const |
unsigned char | get_elem_dim () const |
const std::set< unsigned char > & | elem_dimensions () const |
void | elem_position_set (Real theta) |
void | elem_position_get () |
void | set_algebraic_type (const AlgebraicType atype) |
AlgebraicType | algebraic_type () const |
void | set_custom_solution (const NumericVector< Number > *custom_sol) |
template<typename OutputShape > | |
FEGenericBase< OutputShape > * | build_new_fe (const FEGenericBase< OutputShape > *fe, const Point &p, const Real tolerance=TOLERANCE) const |
template<> | |
FEGenericBase< Real > * | cached_fe (const unsigned int elem_dim, const FEType fe_type) const |
template<> | |
FEGenericBase< RealGradient > * | cached_fe (const unsigned int elem_dim, const FEType fe_type) const |
unsigned int | n_vars () const |
const System & | get_system () const |
const DenseVector< Number > & | get_elem_solution () const |
DenseVector< Number > & | get_elem_solution () |
const DenseSubVector< Number > & | get_elem_solution (unsigned int var) const |
DenseSubVector< Number > & | get_elem_solution (unsigned int var) |
const DenseVector< Number > & | get_elem_solution_rate () const |
DenseVector< Number > & | get_elem_solution_rate () |
const DenseSubVector< Number > & | get_elem_solution_rate (unsigned int var) const |
DenseSubVector< Number > & | get_elem_solution_rate (unsigned int var) |
const DenseVector< Number > & | get_elem_solution_accel () const |
DenseVector< Number > & | get_elem_solution_accel () |
const DenseSubVector< Number > & | get_elem_solution_accel (unsigned int var) const |
DenseSubVector< Number > & | get_elem_solution_accel (unsigned int var) |
const DenseVector< Number > & | get_elem_fixed_solution () const |
DenseVector< Number > & | get_elem_fixed_solution () |
const DenseSubVector< Number > & | get_elem_fixed_solution (unsigned int var) const |
DenseSubVector< Number > & | get_elem_fixed_solution (unsigned int var) |
const DenseVector< Number > & | get_elem_residual () const |
DenseVector< Number > & | get_elem_residual () |
const DenseSubVector< Number > & | get_elem_residual (unsigned int var) const |
DenseSubVector< Number > & | get_elem_residual (unsigned int var) |
const DenseMatrix< Number > & | get_elem_jacobian () const |
DenseMatrix< Number > & | get_elem_jacobian () |
const DenseSubMatrix< Number > & | get_elem_jacobian (unsigned int var1, unsigned int var2) const |
DenseSubMatrix< Number > & | get_elem_jacobian (unsigned int var1, unsigned int var2) |
const std::vector< Number > & | get_qois () const |
std::vector< Number > & | get_qois () |
const std::vector< DenseVector< Number > > & | get_qoi_derivatives () const |
std::vector< DenseVector< Number > > & | get_qoi_derivatives () |
const DenseSubVector< Number > & | get_qoi_derivatives (std::size_t qoi, unsigned int var) const |
DenseSubVector< Number > & | get_qoi_derivatives (std::size_t qoi, unsigned int var) |
const std::vector< dof_id_type > & | get_dof_indices () const |
std::vector< dof_id_type > & | get_dof_indices () |
const std::vector< dof_id_type > & | get_dof_indices (unsigned int var) const |
std::vector< dof_id_type > & | get_dof_indices (unsigned int var) |
unsigned int | n_dof_indices () const |
unsigned int | n_dof_indices (unsigned int var) const |
Real | get_system_time () const |
Real | get_time () const |
void | set_time (Real time_in) |
Real | get_elem_solution_derivative () const |
Real | get_elem_solution_rate_derivative () const |
Real | get_elem_solution_accel_derivative () const |
Real | get_fixed_solution_derivative () const |
bool | is_adjoint () const |
bool & | is_adjoint () |
void | set_deltat_pointer (Real *dt) |
Real | get_deltat_value () |
void | add_localized_vector (NumericVector< Number > &localized_vector, const System &sys) |
DenseVector< Number > & | get_localized_vector (const NumericVector< Number > &localized_vector) |
const DenseVector< Number > & | get_localized_vector (const NumericVector< Number > &localized_vector) const |
DenseSubVector< Number > & | get_localized_subvector (const NumericVector< Number > &localized_vector, unsigned int var) |
const DenseSubVector< Number > & | get_localized_subvector (const NumericVector< Number > &localized_vector, unsigned int var) const |
Public Attributes | |
System * | _mesh_sys |
unsigned int | _mesh_x_var |
unsigned int | _mesh_y_var |
unsigned int | _mesh_z_var |
unsigned char | side |
unsigned char | edge |
Real | time |
const Real | system_time |
Real | elem_solution_derivative |
Real | elem_solution_rate_derivative |
Real | elem_solution_accel_derivative |
Real | fixed_solution_derivative |
Protected Member Functions | |
template<typename OutputShape > | |
FEGenericBase< OutputShape > * | cached_fe (const unsigned int elem_dim, const FEType fe_type) const |
void | set_elem (const Elem *e) |
template<typename OutputType , typename FENeeded< OutputType >::value_getter fe_getter, diff_subsolution_getter subsolution_getter> | |
void | some_value (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType , typename FENeeded< OutputType >::grad_getter fe_getter, diff_subsolution_getter subsolution_getter> | |
void | some_gradient (unsigned int var, unsigned int qp, OutputType &u) const |
template<typename OutputType , typename FENeeded< OutputType >::hess_getter fe_getter, diff_subsolution_getter subsolution_getter> | |
void | some_hessian (unsigned int var, unsigned int qp, OutputType &u) const |
Extends FEMContext to work for DG problems.
This class extends FEMContext in order to provide extra data required to perform local element residual and Jacobian assembly in the case of a discontinuous Galerkin (DG) discretization.
Definition at line 39 of file dg_fem_context.h.
|
inherited |
Helper typedef to simplify refactoring
Definition at line 1030 of file fem_context.h.
|
inherited |
Typedef for the localized_vectors iterator
Definition at line 544 of file diff_context.h.
|
inherited |
Enum describing what data to use when initializing algebraic structures on each element.
Enumerator | |
---|---|
NONE | |
DOFS_ONLY | |
CURRENT | |
OLD | |
OLD_DOFS_ONLY |
Definition at line 933 of file fem_context.h.
|
explicit |
Constructor. Allocates some but fills no data structures.
Definition at line 29 of file dg_fem_context.C.
References libMesh::FEMContext::_dim, _elem_elem_jacobian, _elem_elem_subjacobians, _elem_neighbor_jacobian, _elem_neighbor_subjacobians, _neighbor_elem_jacobian, _neighbor_elem_subjacobians, _neighbor_neighbor_jacobian, _neighbor_neighbor_subjacobians, _neighbor_residual, _neighbor_side_fe, _neighbor_side_fe_var, _neighbor_subresiduals, libMesh::FEAbstract::build(), libMesh::System::n_vars(), and libMesh::System::variable_type().
|
virtual |
|
inherited |
Adds a vector to the map of localized vectors. We can later evaluate interior_values, interior_gradients and side_values for these fields these vectors represent.
Definition at line 119 of file diff_context.C.
References libMesh::DiffContext::_localized_vectors, and libMesh::System::n_vars().
|
inlineinherited |
Definition at line 954 of file fem_context.h.
References libMesh::FEMContext::_atype.
Referenced by libMesh::FEMContext::build_new_fe(), and libMesh::FEMContext::pre_fe_reinit().
|
inherited |
Helper function to reduce some code duplication in the *_point_* methods.
Definition at line 1862 of file fem_context.C.
References libMesh::FEMContext::algebraic_type(), libMesh::Elem::dim(), libMesh::FEType::family, libMesh::FEMContext::get_elem(), libMesh::FEAbstract::get_fe_type(), libMesh::FEMContext::has_elem(), libMesh::FEInterface::inverse_map(), libMesh::Elem::JUST_COARSENED, libMesh::Elem::JUST_REFINED, libMesh::FEMContext::OLD, libMesh::FEType::order, libMesh::Elem::p_refinement_flag(), libMesh::FEAbstract::reinit(), and libMesh::SCALAR.
Referenced by libMesh::FEMContext::fixed_point_gradient(), libMesh::FEMContext::fixed_point_hessian(), libMesh::FEMContext::fixed_point_value(), libMesh::FEMContext::point_curl(), libMesh::FEMContext::point_gradient(), libMesh::FEMContext::point_hessian(), and libMesh::FEMContext::point_value().
|
protectedinherited |
|
inherited |
Definition at line 1789 of file fem_context.C.
References libMesh::FEMContext::_real_fe, libMesh::FEMContext::_real_fe_is_inf, libMesh::FEGenericBase< OutputType >::build(), libMesh::FEGenericBase< OutputType >::build_InfFE(), libMesh::FEMContext::get_elem(), libMesh::FEMContext::has_elem(), and libMesh::Elem::infinite().
|
inherited |
Definition at line 1825 of file fem_context.C.
References libMesh::FEMContext::_real_grad_fe, libMesh::FEMContext::_real_grad_fe_is_inf, libMesh::FEGenericBase< OutputType >::build(), libMesh::FEGenericBase< OutputType >::build_InfFE(), libMesh::FEMContext::get_elem(), libMesh::FEMContext::has_elem(), and libMesh::Elem::infinite().
|
inline |
Are the DG terms active, i.e. have they been assembled?
Definition at line 232 of file dg_fem_context.h.
References _dg_terms_active.
|
virtualinherited |
Reinitializes edge FE objects on the current geometric element
Definition at line 1399 of file fem_context.C.
References libMesh::FEMContext::_edge_fe, libMesh::FEMContext::get_edge(), libMesh::FEMContext::get_elem(), and libMesh::FEMContext::get_elem_dim().
Referenced by libMesh::FEMContext::elem_edge_reinit(), and libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
inlineinherited |
Definition at line 913 of file fem_context.h.
References libMesh::FEMContext::_elem_dims.
Referenced by libMesh::LaplacianErrorEstimator::init_context(), libMesh::DiscontinuityMeasure::init_context(), libMesh::KellyErrorEstimator::init_context(), and libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
overridevirtualinherited |
Resets the current time in the context. Additionally, reinitialize Elem and FE objects if there's a moving mesh present in the system such that the mesh is deformed to its position at .
Reimplemented from libMesh::DiffContext.
Definition at line 1337 of file fem_context.C.
References libMesh::FEMContext::_mesh_sys, libMesh::FEMContext::_update_time_from_system(), libMesh::FEMContext::edge_fe_reinit(), and libMesh::FEMContext::elem_position_set().
|
virtualinherited |
Reinitializes interior FE objects on the current geometric element
Definition at line 1362 of file fem_context.C.
References libMesh::FEMContext::_element_fe, libMesh::FEMContext::get_elem(), libMesh::FEMContext::get_elem_dim(), and libMesh::FEMContext::has_elem().
Referenced by libMesh::FEMContext::elem_reinit(), libMesh::FEMSystem::mesh_position_set(), libMesh::FEMContext::nonlocal_reinit(), and libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
inherited |
Uses the geometry of elem
to set the coordinate data specified by mesh_*_position configuration.
Definition at line 1411 of file fem_context.C.
References libMesh::FEMContext::_mesh_sys, libMesh::Elem::default_order(), libMesh::FEMContext::get_elem(), libMesh::FEMContext::get_elem_dim(), libMesh::DiffContext::get_elem_solution(), libMesh::FEMContext::get_element_fe(), libMesh::FEMContext::get_mesh_x_var(), libMesh::FEMContext::get_mesh_y_var(), libMesh::FEMContext::get_mesh_z_var(), libMesh::invalid_uint, libMesh::LAGRANGE, n_nodes, libMesh::Elem::n_nodes(), libMesh::n_threads(), and libMesh::Elem::point().
Referenced by libMesh::FEMSystem::mesh_position_get().
|
inlineinherited |
Uses the coordinate data specified by mesh_*_position configuration to set the geometry of elem
to the value it would take after a fraction theta
of a timestep.
Definition at line 1197 of file fem_context.h.
References libMesh::FEMContext::_do_elem_position_set(), and libMesh::FEMContext::_mesh_sys.
Referenced by libMesh::FEMContext::elem_edge_reinit(), libMesh::FEMContext::elem_reinit(), libMesh::FEMContext::elem_side_reinit(), and libMesh::FEMSystem::mesh_position_set().
|
overridevirtualinherited |
Resets the current time in the context. Additionally, reinitialize Elem and FE objects if there's a moving mesh present in the system such that the mesh is deformed to its position at .
Reimplemented from libMesh::DiffContext.
Definition at line 1298 of file fem_context.C.
References libMesh::FEMContext::_mesh_sys, libMesh::FEMContext::_update_time_from_system(), libMesh::FEMContext::elem_fe_reinit(), libMesh::FEMContext::elem_position_set(), and libMesh::n_threads().
|
overridevirtualinherited |
Resets the current time in the context. Additionally, reinitialize Elem and FE objects if there's a moving mesh present in the system such that the mesh is deformed to its position at .
Reimplemented from libMesh::DiffContext.
Definition at line 1322 of file fem_context.C.
References libMesh::FEMContext::_mesh_sys, libMesh::FEMContext::_update_time_from_system(), libMesh::FEMContext::elem_position_set(), and libMesh::FEMContext::side_fe_reinit().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 976 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 987 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_gradient().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 1003 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 1014 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_hessian().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 953 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 965 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_value().
|
inherited |
var
at the physical point p
on the current element.Definition at line 1149 of file fem_context.C.
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 1161 of file fem_context.C.
References libMesh::DiffContext::_elem_fixed_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_fixed_solution().
|
inherited |
var
at the physical point p
on the current element.Definition at line 1200 of file fem_context.C.
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 1212 of file fem_context.C.
References libMesh::DiffContext::_elem_fixed_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_fixed_solution().
var
at the physical point p
on the current element.Definition at line 1103 of file fem_context.C.
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 1113 of file fem_context.C.
References libMesh::DiffContext::_elem_fixed_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_fixed_solution().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1053 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1064 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_gradient().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1078 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1088 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_hessian().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1029 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 1040 of file fem_context.C.
References libMesh::DiffContext::get_elem_fixed_solution(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_value().
|
inherited |
_deltat
member Definition at line 111 of file diff_context.C.
References libMesh::DiffContext::_deltat.
Referenced by libMesh::FEMContext::_update_time_from_system().
|
inlineinherited |
Accessor for cached mesh dimension. This is the largest dimension of the elements in the mesh. For the dimension of this->_elem, use get_elem_dim();
Definition at line 899 of file fem_context.h.
References libMesh::FEMContext::_dim.
Referenced by libMesh::FEMContext::get_element_fe(), libMesh::FEMContext::get_side_fe(), and neighbor_side_fe_reinit().
|
inlineinherited |
Accessor for element dof indices
Definition at line 367 of file diff_context.h.
References libMesh::DiffContext::_dof_indices.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::FEMContext::fixed_point_gradient(), libMesh::FEMContext::fixed_point_hessian(), libMesh::FEMContext::fixed_point_value(), libMesh::VectorSetAction< Val >::insert(), libMesh::MatrixFillAction< ValIn, ValOut >::insert(), libMesh::FEMContext::interior_curl(), libMesh::FEMContext::interior_div(), libMesh::FEMContext::interior_gradients(), libMesh::FEMContext::interior_hessians(), libMesh::FEMContext::interior_values(), libMesh::FEMSystem::mesh_position_get(), neighbor_side_fe_reinit(), libMesh::FEMSystem::numerical_jacobian(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::FEMContext::point_curl(), libMesh::FEMContext::point_gradient(), libMesh::FEMContext::point_hessian(), libMesh::FEMContext::point_value(), libMesh::FEMContext::pre_fe_reinit(), libMesh::FEMContext::side_gradient(), libMesh::FEMContext::side_gradients(), libMesh::FEMContext::side_hessians(), libMesh::FEMContext::side_values(), libMesh::FEMContext::some_gradient(), libMesh::FEMContext::some_hessian(), and libMesh::FEMContext::some_value().
|
inlineinherited |
Non-const accessor for element dof indices
Definition at line 373 of file diff_context.h.
References libMesh::DiffContext::_dof_indices.
|
inlineinherited |
Accessor for element dof indices of a particular variable corresponding to the index argument.
Definition at line 380 of file diff_context.h.
References libMesh::DiffContext::_dof_indices_var.
|
inlineinherited |
Accessor for element dof indices of a particular variable corresponding to the index argument.
Definition at line 390 of file diff_context.h.
References libMesh::DiffContext::_dof_indices_var.
|
inlineinherited |
Accessor for current edge of Elem object
Definition at line 891 of file fem_context.h.
References libMesh::FEMContext::edge.
Referenced by libMesh::FEMContext::edge_fe_reinit().
|
inlineinherited |
Accessor for edge (3D only!) finite element object for variable var.
Definition at line 1241 of file fem_context.h.
References libMesh::FEMContext::_edge_fe_var.
Referenced by libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
inlineinherited |
Accessor for edge (3D only!) finite element object for scalar-valued variable var.
Definition at line 1248 of file fem_context.h.
References libMesh::FEMContext::_edge_fe_var.
|
inlineinherited |
Accessor for element edge quadrature rule.
Definition at line 794 of file fem_context.h.
References libMesh::FEMContext::_edge_qrule.
|
inlineinherited |
Accessor for current Elem object
Definition at line 871 of file fem_context.h.
References libMesh::FEMContext::_elem.
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::FEMContext::build_new_fe(), libMesh::FEMContext::cached_fe(), libMesh::OldSolutionBase< Output, point_output >::check_old_context(), libMesh::FEMContext::edge_fe_reinit(), libMesh::FEMContext::elem_fe_reinit(), libMesh::FEMContext::elem_position_get(), libMesh::FEMContext::has_side_boundary_id(), libMesh::FEMSystem::mesh_position_set(), libMesh::FEMSystem::numerical_jacobian(), libMesh::FEMContext::pre_fe_reinit(), libMesh::FEMContext::side_boundary_ids(), and libMesh::FEMContext::side_fe_reinit().
|
inlineinherited |
Accessor for current Elem object
Definition at line 878 of file fem_context.h.
References libMesh::FEMContext::_elem.
|
inlineinherited |
Definition at line 906 of file fem_context.h.
References libMesh::FEMContext::_elem_dim.
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::FEMContext::edge_fe_reinit(), libMesh::FEMContext::elem_fe_reinit(), libMesh::FEMContext::elem_position_get(), libMesh::FEMContext::fixed_point_gradient(), libMesh::FEMContext::fixed_point_hessian(), libMesh::FEMContext::fixed_point_value(), libMesh::FEMContext::get_element_qrule(), libMesh::FEMContext::get_side_qrule(), libMesh::FEMContext::interior_curl(), libMesh::FEMContext::interior_div(), libMesh::FEMContext::interior_gradients(), libMesh::FEMContext::interior_hessians(), libMesh::FEMContext::interior_values(), libMesh::FEMContext::point_curl(), libMesh::FEMContext::point_gradient(), libMesh::FEMContext::point_hessian(), libMesh::FEMContext::point_value(), libMesh::FEMContext::side_fe_reinit(), libMesh::FEMContext::side_gradient(), libMesh::FEMContext::side_gradients(), libMesh::FEMContext::side_hessians(), libMesh::FEMContext::side_values(), libMesh::FEMContext::some_gradient(), libMesh::FEMContext::some_hessian(), and libMesh::FEMContext::some_value().
|
inline |
Const accessor for element-element Jacobian.
Definition at line 110 of file dg_fem_context.h.
References _elem_elem_jacobian.
|
inline |
Non-const accessor for element-element Jacobian.
Definition at line 116 of file dg_fem_context.h.
References _elem_elem_jacobian.
|
inline |
Const accessor for element-element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 123 of file dg_fem_context.h.
References _elem_elem_subjacobians.
|
inline |
Non-const accessor for element-element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 130 of file dg_fem_context.h.
References _elem_elem_subjacobians.
|
inlineinherited |
Accessor for element fixed solution.
Definition at line 215 of file diff_context.h.
References libMesh::DiffContext::_elem_fixed_solution.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::SteadySolver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::FEMContext::fixed_interior_gradient(), libMesh::FEMContext::fixed_interior_hessian(), libMesh::FEMContext::fixed_interior_value(), libMesh::FEMContext::fixed_point_gradient(), libMesh::FEMContext::fixed_point_hessian(), libMesh::FEMContext::fixed_point_value(), libMesh::FEMContext::fixed_side_gradient(), libMesh::FEMContext::fixed_side_hessian(), libMesh::FEMContext::fixed_side_value(), and libMesh::FEMContext::pre_fe_reinit().
|
inlineinherited |
Non-const accessor for element fixed solution.
Definition at line 221 of file diff_context.h.
References libMesh::DiffContext::_elem_fixed_solution.
|
inlineinherited |
Accessor for element fixed solution of a particular variable corresponding to the variable index argument.
Definition at line 228 of file diff_context.h.
References libMesh::DiffContext::_elem_fixed_subsolutions.
|
inlineinherited |
Accessor for element fixed solution of a particular variable corresponding to the variable index argument.
Definition at line 239 of file diff_context.h.
References libMesh::DiffContext::_elem_fixed_subsolutions.
|
inlineinherited |
Const accessor for element Jacobian.
Definition at line 283 of file diff_context.h.
References libMesh::DiffContext::_elem_jacobian.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::FEMSystem::assembly(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::EigenTimeSolver::element_residual(), libMesh::EigenTimeSolver::nonlocal_residual(), libMesh::FEMSystem::numerical_jacobian(), libMesh::FEMContext::pre_fe_reinit(), and libMesh::EigenTimeSolver::side_residual().
|
inlineinherited |
Non-const accessor for element Jacobian.
Definition at line 289 of file diff_context.h.
References libMesh::DiffContext::_elem_jacobian.
|
inlineinherited |
Const accessor for element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 296 of file diff_context.h.
References libMesh::DiffContext::_elem_subjacobians.
|
inlineinherited |
Non-const accessor for element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 308 of file diff_context.h.
References libMesh::DiffContext::_elem_subjacobians.
|
inline |
Const accessor for element-neighbor Jacobian.
Definition at line 136 of file dg_fem_context.h.
References _elem_neighbor_jacobian.
|
inline |
Non-const accessor for element -neighborJacobian.
Definition at line 142 of file dg_fem_context.h.
References _elem_neighbor_jacobian.
|
inline |
Const accessor for element-neighbor Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 149 of file dg_fem_context.h.
References _elem_neighbor_subjacobians.
|
inline |
Non-const accessor for element-neighbor Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 156 of file dg_fem_context.h.
References _elem_neighbor_subjacobians.
|
inlineinherited |
Const accessor for element residual.
Definition at line 249 of file diff_context.h.
References libMesh::DiffContext::_elem_residual.
Referenced by libMesh::Euler2Solver::_general_residual(), libMesh::FEMSystem::assembly(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::FEMSystem::numerical_jacobian(), and libMesh::FEMContext::pre_fe_reinit().
|
inlineinherited |
Non-const accessor for element residual.
Definition at line 255 of file diff_context.h.
References libMesh::DiffContext::_elem_residual.
|
inlineinherited |
Const accessor for element residual of a particular variable corresponding to the variable index argument.
Definition at line 262 of file diff_context.h.
References libMesh::DiffContext::_elem_subresiduals.
|
inlineinherited |
Non-const accessor for element residual of a particular variable corresponding to the variable index argument.
Definition at line 273 of file diff_context.h.
References libMesh::DiffContext::_elem_subresiduals.
|
inlineinherited |
Accessor for element solution.
Definition at line 111 of file diff_context.h.
References libMesh::DiffContext::_elem_solution.
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::SteadySolver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::FEMContext::elem_position_get(), libMesh::FEMContext::interior_curl(), libMesh::FEMContext::interior_div(), libMesh::FEMContext::interior_gradient(), libMesh::FEMContext::interior_hessian(), libMesh::FEMContext::interior_value(), libMesh::FEMSystem::mesh_position_get(), libMesh::FEMSystem::numerical_jacobian(), libMesh::FEMContext::point_curl(), libMesh::FEMContext::point_gradient(), libMesh::FEMContext::point_hessian(), libMesh::FEMContext::point_value(), libMesh::FEMContext::pre_fe_reinit(), libMesh::FEMContext::side_gradient(), libMesh::FEMContext::side_hessian(), and libMesh::FEMContext::side_value().
|
inlineinherited |
Non-const accessor for element solution.
Definition at line 117 of file diff_context.h.
References libMesh::DiffContext::_elem_solution.
|
inlineinherited |
Accessor for element solution of a particular variable corresponding to the variable index argument.
Definition at line 124 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolutions.
|
inlineinherited |
Accessor for element solution of a particular variable corresponding to the variable index argument.
Definition at line 135 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolutions.
|
inlineinherited |
Accessor for element solution accel of change w.r.t. time.
Definition at line 180 of file diff_context.h.
References libMesh::DiffContext::_elem_solution_accel.
Referenced by libMesh::NewmarkSolver::_general_residual(), libMesh::FEMContext::interior_accel(), libMesh::FEMContext::pre_fe_reinit(), libMesh::FirstOrderUnsteadySolver::prepare_accel(), and libMesh::FEMContext::side_accel().
|
inlineinherited |
Non-const accessor for element solution accel of change w.r.t. time.
Definition at line 187 of file diff_context.h.
References libMesh::DiffContext::_elem_solution_accel.
|
inlineinherited |
Accessor for element solution accel for a particular variable corresponding to the variable index argument.
Definition at line 194 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolution_accels.
|
inlineinherited |
Accessor for element solution accel for a particular variable corresponding to the variable index argument.
Definition at line 205 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolution_accels.
|
inlineinherited |
The derivative of the current elem_solution_accel w.r.t. the unknown solution. Corresponding Jacobian contributions should be multiplied by this amount, or may be skipped if get_elem_solution_accel_derivative() is 0.
Definition at line 454 of file diff_context.h.
References libMesh::DiffContext::elem_solution_accel_derivative.
|
inlineinherited |
The derivative of the current elem_solution w.r.t. the unknown solution. Corresponding Jacobian contributions should be multiplied by this amount, or may be skipped if get_elem_solution_derivative() is 0.
Definition at line 436 of file diff_context.h.
References libMesh::DiffContext::elem_solution_derivative.
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns().
|
inlineinherited |
Accessor for element solution rate of change w.r.t. time.
Definition at line 145 of file diff_context.h.
References libMesh::DiffContext::_elem_solution_rate.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::FEMContext::interior_rate(), libMesh::FEMContext::pre_fe_reinit(), libMesh::FirstOrderUnsteadySolver::prepare_accel(), and libMesh::FEMContext::side_rate().
|
inlineinherited |
Non-const accessor for element solution rate of change w.r.t. time.
Definition at line 152 of file diff_context.h.
References libMesh::DiffContext::_elem_solution_rate.
|
inlineinherited |
Accessor for element solution rate for a particular variable corresponding to the variable index argument.
Definition at line 159 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolution_rates.
|
inlineinherited |
Accessor for element solution rate for a particular variable corresponding to the variable index argument.
Definition at line 170 of file diff_context.h.
References libMesh::DiffContext::_elem_subsolution_rates.
|
inlineinherited |
The derivative of the current elem_solution_rate w.r.t. the unknown solution. Corresponding Jacobian contributions should be multiplied by this amount, or may be skipped if get_elem_solution_rate_derivative() is 0.
Definition at line 445 of file diff_context.h.
References libMesh::DiffContext::elem_solution_rate_derivative.
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), and libMesh::FirstOrderUnsteadySolver::prepare_accel().
|
inlineinherited |
Accessor for interior finite element object for variable var for the largest dimension in the mesh. We default to the largest mesh dim because this method may be called before the Elem * is set in the FEMContext, e.g. in FEMSystem::init_context (or a subclass). If you have lower dimensional elements in the mesh and need to query for those FE objects, use the alternative get_element_fe method.
Definition at line 262 of file fem_context.h.
References libMesh::FEMContext::get_dim().
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::FEMContext::elem_position_get(), libMesh::FEMContext::fixed_interior_gradient(), libMesh::FEMContext::fixed_interior_hessian(), libMesh::FEMContext::fixed_interior_value(), libMesh::FEMContext::get_element_fe(), libMesh::ParsedFEMFunction< T >::init_context(), libMesh::FEMSystem::init_context(), libMesh::FEMContext::interior_accel(), libMesh::FEMContext::interior_gradient(), libMesh::FEMContext::interior_hessian(), libMesh::FEMContext::interior_rate(), and libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
inlineinherited |
Accessor for interior finite element object for scalar-valued variable var for the largest dimension in the mesh. We default to the largest mesh dim because this method may be called before the Elem * is set in the FEMContext, e.g. in FEMSystem::init_context (or a subclass). If you have lower dimensional elements in the mesh and need to query for those FE objects, use the alternative get_element_fe method.
Definition at line 273 of file fem_context.h.
References libMesh::FEMContext::get_dim(), and libMesh::FEMContext::get_element_fe().
|
inlineinherited |
Accessor for interior finite element object for variable var for dimension dim.
Definition at line 1205 of file fem_context.h.
References libMesh::FEMContext::_element_fe_var.
|
inlineinherited |
Accessor for interior finite element object for scalar-valued variable var for dimension dim.
Definition at line 1214 of file fem_context.h.
References libMesh::FEMContext::_element_fe_var.
|
inlineinherited |
Accessor for element interior quadrature rule for the dimension of the current _elem.
Definition at line 765 of file fem_context.h.
References libMesh::FEMContext::get_elem_dim().
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns().
|
inlineinherited |
Accessor for element interior quadrature rule.
Definition at line 778 of file fem_context.h.
References libMesh::FEMContext::_element_qrule.
|
inlineinherited |
The derivative of the current fixed_elem_solution w.r.t. the unknown solution. Corresponding Jacobian contributions should be multiplied by this amount, or may be skipped if get_fixed_elem_solution_derivative() is 0.
Definition at line 463 of file diff_context.h.
References libMesh::DiffContext::fixed_solution_derivative.
|
inherited |
Return a reference to DenseSubVector localization of localized_vector at variable var contained in the _localized_vectors map
Definition at line 148 of file diff_context.C.
References libMesh::DiffContext::_localized_vectors.
Referenced by libMesh::FEMContext::interior_gradients(), libMesh::FEMContext::interior_hessians(), libMesh::FEMContext::interior_values(), libMesh::FEMContext::side_gradients(), libMesh::FEMContext::side_hessians(), and libMesh::FEMContext::side_values().
|
inherited |
const accessible version of get_localized_subvector function
Definition at line 154 of file diff_context.C.
References libMesh::DiffContext::_localized_vectors.
|
inherited |
Return a reference to DenseVector localization of localized_vector contained in the _localized_vectors map
Definition at line 134 of file diff_context.C.
References libMesh::DiffContext::_localized_vectors.
|
inherited |
const accessible version of get_localized_vector function
Definition at line 140 of file diff_context.C.
References libMesh::DiffContext::_localized_vectors.
|
inlineinherited |
Accessor for moving mesh System
Definition at line 811 of file fem_context.h.
References libMesh::FEMContext::_mesh_sys.
|
inlineinherited |
Accessor for moving mesh System
Definition at line 817 of file fem_context.h.
References libMesh::FEMContext::_mesh_sys.
|
inlineinherited |
Accessor for x-variable of moving mesh System
Definition at line 823 of file fem_context.h.
References libMesh::FEMContext::_mesh_x_var.
Referenced by libMesh::FEMContext::_do_elem_position_set(), and libMesh::FEMContext::elem_position_get().
|
inlineinherited |
Accessor for y-variable of moving mesh System
Definition at line 837 of file fem_context.h.
References libMesh::FEMContext::_mesh_y_var.
Referenced by libMesh::FEMContext::_do_elem_position_set(), and libMesh::FEMContext::elem_position_get().
|
inlineinherited |
Accessor for z-variable of moving mesh System
Definition at line 851 of file fem_context.h.
References libMesh::FEMContext::_mesh_z_var.
Referenced by libMesh::FEMContext::_do_elem_position_set(), and libMesh::FEMContext::elem_position_get().
|
inline |
Accessor for current neighbor Elem object for assembling DG terms.
Definition at line 226 of file dg_fem_context.h.
References _neighbor.
Referenced by neighbor_side_fe_reinit().
|
inline |
Accessor for neighbor dof indices
Definition at line 71 of file dg_fem_context.h.
References _neighbor_dof_indices.
|
inline |
Accessor for element dof indices of a particular variable corresponding to the index argument.
Definition at line 78 of file dg_fem_context.h.
References _neighbor_dof_indices_var.
|
inline |
Const accessor for element-neighbor Jacobian.
Definition at line 162 of file dg_fem_context.h.
References _neighbor_elem_jacobian.
|
inline |
Non-const accessor for element Jacobian.
Definition at line 168 of file dg_fem_context.h.
References _neighbor_elem_jacobian.
|
inline |
Const accessor for neighbor-element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 175 of file dg_fem_context.h.
References _neighbor_elem_subjacobians.
|
inline |
Non-const accessor for neighbor-element Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 182 of file dg_fem_context.h.
References _neighbor_elem_subjacobians.
|
inline |
Const accessor for element-neighbor Jacobian.
Definition at line 188 of file dg_fem_context.h.
References _neighbor_neighbor_jacobian.
|
inline |
Non-const accessor for element Jacobian.
Definition at line 194 of file dg_fem_context.h.
References _neighbor_neighbor_jacobian.
|
inline |
Const accessor for neighbor-neighbor Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 201 of file dg_fem_context.h.
References _neighbor_neighbor_subjacobians.
|
inline |
Non-const accessor for neighbor-neighbor Jacobian of particular variables corresponding to the variable index arguments.
Definition at line 208 of file dg_fem_context.h.
References _neighbor_neighbor_subjacobians.
|
inline |
Const accessor for neighbor residual.
Definition at line 84 of file dg_fem_context.h.
References _neighbor_residual.
|
inline |
Non-const accessor for neighbor residual.
Definition at line 90 of file dg_fem_context.h.
References _neighbor_residual.
|
inline |
Const accessor for neighbor residual of a particular variable corresponding to the variable index argument.
Definition at line 97 of file dg_fem_context.h.
References _neighbor_subresiduals.
|
inline |
Non-const accessor for neighbor residual of a particular variable corresponding to the variable index argument.
Definition at line 104 of file dg_fem_context.h.
References _neighbor_subresiduals.
|
inline |
Accessor for neighbor edge/face (2D/3D) finite element object for variable var.
Definition at line 301 of file dg_fem_context.h.
References _neighbor_side_fe_var.
|
inlineinherited |
Const accessor for QoI derivatives.
Definition at line 331 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi_derivative.
Referenced by libMesh::FEMContext::pre_fe_reinit().
|
inlineinherited |
Non-const accessor for QoI derivatives.
Definition at line 337 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi_derivative.
|
inlineinherited |
Const accessor for QoI derivative of a particular qoi and variable corresponding to the index arguments.
Definition at line 344 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi_subderivatives.
|
inlineinherited |
Non-const accessor for QoI derivative of a particular qoi and variable corresponding to the index arguments.
Definition at line 356 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi_subderivatives.
|
inlineinherited |
Const accessor for QoI vector.
Definition at line 319 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi.
|
inlineinherited |
Non-const accessor for QoI vector.
Definition at line 325 of file diff_context.h.
References libMesh::DiffContext::_elem_qoi.
|
inlineinherited |
Accessor for current side of Elem object
Definition at line 885 of file fem_context.h.
References libMesh::FEMContext::side.
Referenced by libMesh::FEMContext::side_fe_reinit().
|
inlineinherited |
Accessor for edge/face (2D/3D) finite element object for variable var for the largest dimension in the mesh. We default to the largest mesh dim because this method may be called before the Elem * is set in the FEMContext, e.g. in FEMSystem::init_context (or a subclass). If you have lower dimensional elements in the mesh and need to query for those FE objects, use the alternative get_side_fe method.
Definition at line 299 of file fem_context.h.
References libMesh::FEMContext::get_dim().
Referenced by libMesh::ParsedFEMFunction< T >::eval_args(), libMesh::FEMContext::fixed_side_gradient(), libMesh::FEMContext::fixed_side_hessian(), libMesh::FEMContext::fixed_side_value(), libMesh::FEMContext::get_side_fe(), libMesh::ParsedFEMFunction< T >::init_context(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::FEMContext::side_accel(), libMesh::FEMContext::side_hessian(), and libMesh::FEMContext::side_rate().
|
inlineinherited |
Accessor for side finite element object for scalar-valued variable var for the largest dimension in the mesh. We default to the largest mesh dim because this method may be called before the Elem * is set in the FEMContext, e.g. in FEMSystem::init_context (or a subclass). If you have lower dimensional elements in the mesh and need to query for those FE objects, use the alternative get_side_fe method.
Definition at line 310 of file fem_context.h.
References libMesh::FEMContext::get_dim(), and libMesh::FEMContext::get_side_fe().
|
inlineinherited |
Accessor for edge/face (2D/3D) finite element object for variable var for dimension dim.
Definition at line 1223 of file fem_context.h.
References libMesh::FEMContext::_side_fe_var.
|
inlineinherited |
Accessor for side finite element object for scalar-valued variable var for dimension dim.
Definition at line 1232 of file fem_context.h.
References libMesh::FEMContext::_side_fe_var.
|
inlineinherited |
Accessor for element side quadrature rule for the dimension of the current _elem.
Definition at line 772 of file fem_context.h.
References libMesh::FEMContext::get_elem_dim().
|
inlineinherited |
Accessor for element side quadrature rule.
Definition at line 785 of file fem_context.h.
References libMesh::FEMContext::_side_qrule.
|
inlineinherited |
Accessor for associated system.
Definition at line 105 of file diff_context.h.
References libMesh::DiffContext::_system.
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), and neighbor_side_fe_reinit().
|
inlineinherited |
Accessor for the time variable stored in the system class.
Definition at line 415 of file diff_context.h.
References libMesh::DiffContext::system_time.
Referenced by libMesh::FEMContext::_update_time_from_system().
|
inlineinherited |
Accessor for the time for which the current nonlinear_solution is defined.
Definition at line 421 of file diff_context.h.
References libMesh::DiffContext::time.
|
inlineinherited |
Test for current Elem object
Definition at line 865 of file fem_context.h.
References libMesh::FEMContext::_elem.
Referenced by libMesh::FEMContext::build_new_fe(), libMesh::FEMContext::cached_fe(), libMesh::FEMContext::elem_fe_reinit(), and libMesh::FEMContext::pre_fe_reinit().
|
inherited |
Reports if the boundary id is found on the current side
Definition at line 189 of file fem_context.C.
References libMesh::FEMContext::_boundary_info, libMesh::FEMContext::get_elem(), libMesh::BoundaryInfo::has_boundary_id(), and libMesh::FEMContext::side.
|
inherited |
var
at the quadrature point qp
on the current element interior. Definition at line 1275 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution_accel(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_value().
|
inherited |
var
at the physical point p
on the current element. Definition at line 492 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEGenericBase< OutputType >::get_curl_phi(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
|
inherited |
var
at the physical point p
on the current element. Definition at line 523 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEGenericBase< OutputType >::get_div_phi(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 361 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 374 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_gradient().
|
inherited |
Fills a vector with the gradient of the solution variable var
at all the quadrature points in the current element interior.
Definition at line 388 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEGenericBase< OutputType >::get_dphi(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_localized_subvector().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 426 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 436 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_hessian().
|
inherited |
Fills a vector of hessians of the _system_vector at the all the quadrature points in the current element interior. This is the preferred API.
Definition at line 450 of file fem_context.C.
References libMesh::FEGenericBase< OutputType >::get_d2phi(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_localized_subvector().
|
inherited |
var
at the quadrature point qp
on the current element interior. Definition at line 1253 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution_rate(), libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::some_value().
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 306 of file fem_context.C.
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns().
|
inherited |
var
at the quadrature point qp
on the current element interior.Definition at line 316 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution(), and libMesh::FEMContext::some_value().
|
inherited |
Fills a vector of values of the _system_vector at the all the quadrature points in the current element interior.
Definition at line 326 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), libMesh::DiffContext::get_localized_subvector(), and libMesh::FEGenericBase< OutputType >::get_phi().
|
inlineinherited |
Accessor for querying whether we need to do a primal or adjoint solve
Definition at line 470 of file diff_context.h.
References libMesh::DiffContext::_is_adjoint.
Referenced by libMesh::FEMSystem::build_context().
|
inlineinherited |
Accessor for setting whether we need to do a primal or adjoint solve
Definition at line 477 of file diff_context.h.
References libMesh::DiffContext::_is_adjoint.
|
inlineinherited |
Total number of dof indices on the element
Definition at line 399 of file diff_context.h.
References libMesh::DiffContext::_dof_indices.
|
inlineinherited |
Total number of dof indices of the particular variable corresponding to the index argument
Definition at line 406 of file diff_context.h.
References libMesh::DiffContext::_dof_indices_var.
|
inlineinherited |
Number of variables in solution.
Definition at line 99 of file diff_context.h.
References libMesh::DiffContext::_dof_indices_var.
Referenced by libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::LaplacianErrorEstimator::init_context(), libMesh::DiscontinuityMeasure::init_context(), libMesh::KellyErrorEstimator::init_context(), and libMesh::FEMSystem::numerical_jacobian().
void libMesh::DGFEMContext::neighbor_side_fe_reinit | ( | ) |
Initialize neighbor side data needed to assemble DG terms. The neighbor element is determined by the current value of get_neighbor().
Definition at line 86 of file dg_fem_context.C.
References _dg_terms_active, _elem_elem_jacobian, _elem_elem_subjacobians, _elem_neighbor_jacobian, _elem_neighbor_subjacobians, _neighbor_dof_indices, _neighbor_dof_indices_var, _neighbor_elem_jacobian, _neighbor_elem_subjacobians, _neighbor_neighbor_jacobian, _neighbor_neighbor_subjacobians, _neighbor_residual, _neighbor_side_fe, _neighbor_subresiduals, libMesh::FEMContext::_side_fe, libMesh::DofMap::dof_indices(), libMesh::FEMContext::get_dim(), libMesh::DiffContext::get_dof_indices(), libMesh::System::get_dof_map(), get_neighbor(), libMesh::DiffContext::get_system(), libMesh::FEAbstract::get_xyz(), libMesh::FEInterface::inverse_map(), libMesh::System::n_vars(), libMesh::DenseVector< T >::resize(), and libMesh::DenseMatrix< T >::resize().
|
overridevirtualinherited |
Gives derived classes the opportunity to reinitialize data needed for nonlocal calculations at a new point within a timestep
Reimplemented from libMesh::DiffContext.
Definition at line 1352 of file fem_context.C.
References libMesh::FEMContext::_update_time_from_system(), and libMesh::FEMContext::elem_fe_reinit().
|
inherited |
var
at the physical point p
on the current element.
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 917 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
var
at the physical point p
on the current element.Definition at line 814 of file fem_context.C.
Referenced by libMesh::ParsedFEMFunction< T >::eval_args().
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 826 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
var
at the physical point p
on the current element.Definition at line 866 of file fem_context.C.
Referenced by libMesh::ParsedFEMFunction< T >::eval_args().
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 877 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
|
inherited |
var
at the physical point p
on the current element. var
at the physical point p
on the current element.Definition at line 768 of file fem_context.C.
Referenced by libMesh::ParsedFEMFunction< T >::eval_args().
|
inherited |
var
at the physical point p
on the current element.Allows evaluation of points within a relative tolerance outside the element.
Definition at line 778 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::FEMContext::build_new_fe(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
Reinitializes local data vectors/matrices on the current geometric element
Definition at line 1552 of file fem_context.C.
References libMesh::FEMContext::_custom_solution, libMesh::DiffContext::_elem_qoi_subderivatives, libMesh::DiffContext::_localized_vectors, libMesh::FEMContext::algebraic_type(), libMesh::FEMContext::CURRENT, libMesh::System::current_local_solution, libMesh::DofMap::dof_indices(), libMesh::FEMContext::DOFS_ONLY, libMesh::NumericVector< T >::get(), libMesh::DiffContext::get_dof_indices(), libMesh::System::get_dof_map(), libMesh::FEMContext::get_elem(), libMesh::DiffContext::get_elem_fixed_solution(), libMesh::DiffContext::get_elem_jacobian(), libMesh::DiffContext::get_elem_residual(), libMesh::DiffContext::get_elem_solution(), libMesh::DiffContext::get_elem_solution_accel(), libMesh::DiffContext::get_elem_solution_rate(), libMesh::DiffContext::get_qoi_derivatives(), libMesh::DifferentiablePhysics::get_second_order_vars(), libMesh::DifferentiableSystem::get_time_solver(), libMesh::DenseVector< T >::get_values(), libMesh::FEMContext::has_elem(), libMesh::TimeSolver::is_steady(), libMesh::System::n_qois(), libMesh::System::n_vars(), libMesh::FEMContext::NONE, libMesh::FEMContext::OLD, libMesh::DofMap::old_dof_indices(), libMesh::FEMContext::OLD_DOFS_ONLY, libMesh::DenseVector< T >::resize(), libMesh::DenseMatrix< T >::resize(), libMesh::FEMContext::set_elem(), libMesh::UnsteadySolver::time_order(), and libMesh::System::use_fixed_solution.
Referenced by libMesh::FEMSystem::assembly(), libMesh::FEMSystem::mesh_position_get(), libMesh::FEMSystem::mesh_position_set(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), libMesh::WeightedPatchRecoveryErrorEstimator::EstimateError::operator()(), and libMesh::System::project_vector().
|
inlineinherited |
Setting which determines whether to initialize algebraic structures (elem_*) on each element and set their values from current_local_solution. Algebraic initialization may be disabled for efficiency in cases where FEMContext is only used as a convenient container of FE objects.
Definition at line 948 of file fem_context.h.
References libMesh::FEMContext::_atype.
Referenced by libMesh::OldSolutionBase< Output, point_output >::init_context().
|
inlineinherited |
Set a NumericVector to be used in place of current_local_solution for calculating elem_solution. Set to nullptr to restore the current_local_solution behavior. Advanced DifferentiableSystem specific capabilities will only be enabled in the current_local_solution case.
Definition at line 963 of file fem_context.h.
References libMesh::FEMContext::_custom_solution.
|
inherited |
Points the _deltat member of this class at a timestep value stored in the creating System, for example DiffSystem::deltat
Definition at line 103 of file diff_context.C.
References libMesh::DiffContext::_deltat.
Referenced by libMesh::FEMSystem::build_context(), libMesh::DifferentiableSystem::build_context(), and libMesh::FEMSystem::init_context().
|
protectedinherited |
Helper function to promote accessor usage
Definition at line 1765 of file fem_context.C.
References libMesh::FEMContext::_elem, libMesh::FEMContext::_elem_dim, and libMesh::Elem::dim().
Referenced by libMesh::FEMContext::pre_fe_reinit().
|
inlinevirtualinherited |
Tells the FEMContext that system sys
contains the isoparametric Lagrangian variables which correspond to the coordinates of mesh nodes, in problems where the mesh itself is expected to move in time.
This should be set automatically if the FEMPhysics requires it.
Definition at line 805 of file fem_context.h.
References libMesh::FEMContext::_mesh_sys.
Referenced by libMesh::FEMSystem::build_context().
|
inlineinherited |
Accessor for x-variable of moving mesh System
This should be set automatically if the FEMPhysics requires it.
Definition at line 831 of file fem_context.h.
References libMesh::FEMContext::_mesh_x_var.
Referenced by libMesh::FEMSystem::build_context().
|
inlineinherited |
Accessor for y-variable of moving mesh System
This should be set automatically if the FEMPhysics requires it.
Definition at line 845 of file fem_context.h.
References libMesh::FEMContext::_mesh_y_var.
Referenced by libMesh::FEMSystem::build_context().
|
inlineinherited |
Accessor for z-variable of moving mesh System
This should be set automatically if the FEMPhysics requires it.
Definition at line 859 of file fem_context.h.
References libMesh::FEMContext::_mesh_z_var.
Referenced by libMesh::FEMSystem::build_context().
|
inline |
Set the neighbor element which we will use to assemble DG terms.
Definition at line 220 of file dg_fem_context.h.
References _neighbor.
|
inlineinherited |
Set the time for which the current nonlinear_solution is defined.
Definition at line 427 of file diff_context.h.
References libMesh::DiffContext::time.
Referenced by libMesh::FEMContext::_update_time_from_system().
|
inherited |
var
at the quadrature point qp
on the current element side. Definition at line 1287 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution_accel(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_value().
|
inherited |
Lists the boundary ids found on the current side
Definition at line 196 of file fem_context.C.
References libMesh::FEMContext::_boundary_info, libMesh::BoundaryInfo::boundary_ids(), libMesh::FEMContext::get_elem(), and libMesh::FEMContext::side.
|
inherited |
As above, but fills in the std::set provided by the user.
Definition at line 204 of file fem_context.C.
References libMesh::FEMContext::_boundary_info, libMesh::BoundaryInfo::boundary_ids(), libMesh::FEMContext::get_elem(), and libMesh::FEMContext::side.
|
overridevirtual |
Override side_fe_reinit to set a boolean flag so that by default DG terms are assumed to be inactive. DG terms are only active if neighbor_side_fe_reinit is called.
Reimplemented from libMesh::FEMContext.
Definition at line 77 of file dg_fem_context.C.
References _dg_terms_active, and libMesh::FEMContext::side_fe_reinit().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 613 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 624 of file fem_context.C.
References libMesh::DiffContext::_elem_subsolutions, libMesh::DiffContext::get_dof_indices(), libMesh::FEGenericBase< OutputType >::get_dphi(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_elem_solution().
|
inherited |
Fills a vector with the gradient of the solution variable var
at all the quadrature points on the current element side.
Definition at line 658 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEGenericBase< OutputType >::get_dphi(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_localized_subvector().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 696 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 709 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_hessian().
|
inherited |
Fills a vector of hessians of the _system_vector at the all the quadrature points on the current element side. This is the preferred API.
Definition at line 725 of file fem_context.C.
References libMesh::FEGenericBase< OutputType >::get_d2phi(), libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::DiffContext::get_localized_subvector().
|
inherited |
var
at the quadrature point qp
on the current element side. Definition at line 1265 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution_rate(), libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::some_value().
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 555 of file fem_context.C.
|
inherited |
var
at the quadrature point qp
on the current element side.Definition at line 567 of file fem_context.C.
References libMesh::DiffContext::get_elem_solution(), and libMesh::FEMContext::some_value().
|
inherited |
Fills a vector of values of the _system_vector at the all the quadrature points on the current element side.
Definition at line 578 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), libMesh::DiffContext::get_localized_subvector(), and libMesh::FEGenericBase< OutputType >::get_phi().
|
protectedinherited |
Helper function to reduce some code duplication in the *interior_gradient methods.
Definition at line 243 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEGenericBase< OutputType >::get_dphi(), and libMesh::FEMContext::get_elem_dim().
Referenced by libMesh::FEMContext::fixed_interior_gradient(), libMesh::FEMContext::fixed_side_gradient(), and libMesh::FEMContext::interior_gradient().
|
protectedinherited |
Helper function to reduce some code duplication in the *interior_hessian methods.
Definition at line 276 of file fem_context.C.
References libMesh::FEGenericBase< OutputType >::get_d2phi(), libMesh::DiffContext::get_dof_indices(), and libMesh::FEMContext::get_elem_dim().
Referenced by libMesh::FEMContext::fixed_interior_hessian(), libMesh::FEMContext::fixed_side_hessian(), libMesh::FEMContext::interior_hessian(), and libMesh::FEMContext::side_hessian().
|
protectedinherited |
Helper function to reduce some code duplication in the *interior_value methods.
Definition at line 214 of file fem_context.C.
References libMesh::DiffContext::get_dof_indices(), libMesh::FEMContext::get_elem_dim(), and libMesh::FEGenericBase< OutputType >::get_phi().
Referenced by libMesh::FEMContext::fixed_interior_value(), libMesh::FEMContext::fixed_side_value(), libMesh::FEMContext::interior_accel(), libMesh::FEMContext::interior_rate(), libMesh::FEMContext::interior_value(), libMesh::FEMContext::side_accel(), libMesh::FEMContext::side_rate(), and libMesh::FEMContext::side_value().
|
protectedinherited |
Keep track of what type of algebra reinitialization is to be done
Definition at line 999 of file fem_context.h.
Referenced by libMesh::FEMContext::algebraic_type(), and libMesh::FEMContext::set_algebraic_type().
|
protectedinherited |
Saved reference to BoundaryInfo on the mesh for this System. Used to answer boundary id requests.
Definition at line 1114 of file fem_context.h.
Referenced by libMesh::FEMContext::has_side_boundary_id(), and libMesh::FEMContext::side_boundary_ids().
|
protectedinherited |
Data with which to do algebra reinitialization
Definition at line 1004 of file fem_context.h.
Referenced by libMesh::FEMContext::pre_fe_reinit(), and libMesh::FEMContext::set_custom_solution().
|
private |
Boolean flag to indicate whether or not the DG terms have been assembled and should be used in the global matrix assembly.
Definition at line 296 of file dg_fem_context.h.
Referenced by dg_terms_are_active(), neighbor_side_fe_reinit(), and side_fe_reinit().
|
protectedinherited |
Cached dimension of largest dimension element in this mesh
Definition at line 1124 of file fem_context.h.
Referenced by DGFEMContext(), and libMesh::FEMContext::get_dim().
|
protectedinherited |
Global Degree of freedom index lists
Definition at line 637 of file diff_context.h.
Referenced by libMesh::DiffContext::get_dof_indices(), and libMesh::DiffContext::n_dof_indices().
|
protectedinherited |
Definition at line 638 of file diff_context.h.
Referenced by libMesh::DiffContext::get_dof_indices(), libMesh::DiffContext::n_dof_indices(), and libMesh::DiffContext::n_vars().
|
protectedinherited |
Definition at line 1097 of file fem_context.h.
Referenced by libMesh::FEMContext::edge_fe_reinit(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Definition at line 1108 of file fem_context.h.
Referenced by libMesh::FEMContext::get_edge_fe(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Quadrature rules for element edges. If the FEM context is told to prepare for edge integration on 3D elements, it will try to find a quadrature rule that correctly integrates all variables. Because edge rules only apply to 3D elements, we don't need to worry about multiple dimensions
Definition at line 1160 of file fem_context.h.
Referenced by libMesh::FEMContext::get_edge_qrule(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Current element for element_* to examine
Definition at line 1119 of file fem_context.h.
Referenced by libMesh::FEMContext::get_elem(), libMesh::FEMContext::has_elem(), and libMesh::FEMContext::set_elem().
|
protectedinherited |
Cached dimension of this->_elem.
Definition at line 1129 of file fem_context.h.
Referenced by libMesh::FEMContext::get_elem_dim(), and libMesh::FEMContext::set_elem().
|
protectedinherited |
Cached dimensions of elements in the mesh, plus dimension 0 if SCALAR variables are in use.
Definition at line 1135 of file fem_context.h.
Referenced by libMesh::FEMContext::elem_dimensions(), and libMesh::FEMContext::init_internal_data().
|
private |
The DG Jacobian terms. Trial and test functions come from either element or neighbor.
Definition at line 257 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_elem_elem_jacobian(), and neighbor_side_fe_reinit().
|
private |
Definition at line 266 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_elem_elem_jacobian(), and neighbor_side_fe_reinit().
|
protectedinherited |
Element by element components of nonlinear_solution at a fixed point in a timestep, for optional use by e.g. stabilized methods
Definition at line 603 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_fixed_solution().
|
protectedinherited |
Definition at line 604 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), libMesh::FEMContext::fixed_point_gradient(), libMesh::FEMContext::fixed_point_hessian(), libMesh::FEMContext::fixed_point_value(), and libMesh::DiffContext::get_elem_fixed_solution().
|
protectedinherited |
Element jacobian: derivatives of elem_residual with respect to elem_solution
Definition at line 615 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_jacobian().
|
private |
Definition at line 258 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_elem_neighbor_jacobian(), and neighbor_side_fe_reinit().
|
private |
Definition at line 267 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_elem_neighbor_jacobian(), and neighbor_side_fe_reinit().
|
protectedinherited |
Element quantity of interest contributions
Definition at line 620 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_qois().
|
protectedinherited |
Element quantity of interest derivative contributions
Definition at line 625 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_qoi_derivatives().
|
protectedinherited |
Definition at line 626 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), libMesh::DiffContext::get_qoi_derivatives(), and libMesh::FEMContext::pre_fe_reinit().
|
protectedinherited |
Element residual vector
Definition at line 609 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_residual().
|
protectedinherited |
Element by element components of nonlinear_solution as adjusted by a time_solver
Definition at line 581 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_solution().
|
protectedinherited |
Element by element components of du/dt as adjusted by a time_solver
Definition at line 595 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_solution_accel().
|
protectedinherited |
Element by element components of du/dt as adjusted by a time_solver
Definition at line 588 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_solution_rate().
|
protectedinherited |
Definition at line 632 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_jacobian().
|
protectedinherited |
Element residual subvectors and Jacobian submatrices
Definition at line 631 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_residual().
|
protectedinherited |
Definition at line 596 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_solution_accel().
|
protectedinherited |
Definition at line 589 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), and libMesh::DiffContext::get_elem_solution_rate().
|
protectedinherited |
Definition at line 582 of file diff_context.h.
Referenced by libMesh::DiffContext::DiffContext(), libMesh::DiffContext::get_elem_solution(), libMesh::FEMContext::interior_curl(), libMesh::FEMContext::interior_div(), libMesh::FEMContext::point_curl(), libMesh::FEMContext::point_gradient(), libMesh::FEMContext::point_hessian(), libMesh::FEMContext::point_value(), and libMesh::FEMContext::side_gradient().
|
protectedinherited |
Finite element objects for each variable's interior, sides and edges. We store FE objects for each element dimension present in the mesh, except for edge_fe which only applies to 3D elements.
Definition at line 1095 of file fem_context.h.
Referenced by libMesh::FEMContext::elem_fe_reinit(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Pointers to the same finite element objects, but indexed by variable number. We store FE objects for each element dimension present in the mesh, except for edge_fe_var which only applies for 3D elements.
Definition at line 1106 of file fem_context.h.
Referenced by libMesh::FEMContext::get_element_fe(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Quadrature rule for element interior. The FEM context will try to find a quadrature rule that correctly integrates all variables. We prepare quadrature rules for each element dimension in the mesh.
Definition at line 1143 of file fem_context.h.
Referenced by libMesh::FEMContext::get_element_qrule(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
The extra quadrature order for this context.
Definition at line 1165 of file fem_context.h.
Referenced by libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Contains pointers to vectors the user has asked to be localized, keyed with pairs of element localized versions of that vector and per variable views
Definition at line 575 of file diff_context.h.
Referenced by libMesh::DiffContext::add_localized_vector(), libMesh::DiffContext::get_localized_subvector(), libMesh::DiffContext::get_localized_vector(), and libMesh::FEMContext::pre_fe_reinit().
|
inherited |
System from which to acquire moving mesh information
Definition at line 969 of file fem_context.h.
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::FEMContext::elem_edge_reinit(), libMesh::FEMContext::elem_position_get(), libMesh::FEMContext::elem_position_set(), libMesh::FEMContext::elem_reinit(), libMesh::FEMContext::elem_side_reinit(), libMesh::FEMContext::get_mesh_system(), and libMesh::FEMContext::set_mesh_system().
|
inherited |
Variables from which to acquire moving mesh information
Definition at line 974 of file fem_context.h.
Referenced by libMesh::FEMContext::get_mesh_x_var(), and libMesh::FEMContext::set_mesh_x_var().
|
inherited |
Definition at line 974 of file fem_context.h.
Referenced by libMesh::FEMContext::get_mesh_y_var(), and libMesh::FEMContext::set_mesh_y_var().
|
inherited |
Definition at line 974 of file fem_context.h.
Referenced by libMesh::FEMContext::get_mesh_z_var(), and libMesh::FEMContext::set_mesh_z_var().
|
private |
Current neighbor element for assembling DG terms.
Definition at line 246 of file dg_fem_context.h.
Referenced by get_neighbor(), and set_neighbor().
|
private |
Global Degree of freedom index lists for the neighbor element
Definition at line 274 of file dg_fem_context.h.
Referenced by get_neighbor_dof_indices(), and neighbor_side_fe_reinit().
|
private |
Definition at line 275 of file dg_fem_context.h.
Referenced by get_neighbor_dof_indices(), and neighbor_side_fe_reinit().
|
private |
Definition at line 259 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_elem_jacobian(), and neighbor_side_fe_reinit().
|
private |
Definition at line 268 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_elem_jacobian(), and neighbor_side_fe_reinit().
|
private |
Definition at line 260 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_neighbor_jacobian(), and neighbor_side_fe_reinit().
|
private |
Definition at line 269 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_neighbor_jacobian(), and neighbor_side_fe_reinit().
|
private |
Residual vector of the neighbor component.
Definition at line 251 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_residual(), and neighbor_side_fe_reinit().
|
private |
Finite element objects for each variable's sides on the neighbor element. We do not need FE objects for neighbor element interior since we just need to handle DG interface terms here.
Definition at line 284 of file dg_fem_context.h.
Referenced by DGFEMContext(), and neighbor_side_fe_reinit().
|
private |
Pointers to the same finite element objects on the neighbor element, but indexed by variable number
Definition at line 290 of file dg_fem_context.h.
Referenced by DGFEMContext(), and get_neighbor_side_fe().
|
private |
Element residual subvectors and Jacobian submatrices
Definition at line 265 of file dg_fem_context.h.
Referenced by DGFEMContext(), get_neighbor_residual(), and neighbor_side_fe_reinit().
|
mutableprotectedinherited |
Definition at line 1006 of file fem_context.h.
Referenced by libMesh::FEMContext::cached_fe().
|
mutableprotectedinherited |
Definition at line 1010 of file fem_context.h.
Referenced by libMesh::FEMContext::cached_fe().
|
mutableprotectedinherited |
Definition at line 1007 of file fem_context.h.
Referenced by libMesh::FEMContext::cached_fe().
|
mutableprotectedinherited |
Definition at line 1011 of file fem_context.h.
Referenced by libMesh::FEMContext::cached_fe().
|
protectedinherited |
Definition at line 1096 of file fem_context.h.
Referenced by libMesh::FEMContext::init_internal_data(), neighbor_side_fe_reinit(), and libMesh::FEMContext::side_fe_reinit().
|
protectedinherited |
Definition at line 1107 of file fem_context.h.
Referenced by libMesh::FEMContext::get_side_fe(), and libMesh::FEMContext::init_internal_data().
|
protectedinherited |
Quadrature rules for element sides The FEM context will try to find a quadrature rule that correctly integrates all variables. We prepare quadrature rules for each element dimension in the mesh.
Definition at line 1151 of file fem_context.h.
Referenced by libMesh::FEMContext::get_side_qrule(), and libMesh::FEMContext::init_internal_data().
|
inherited |
Current edge for edge_* to examine
Definition at line 984 of file fem_context.h.
Referenced by libMesh::FEMContext::get_edge(), and libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()().
|
inherited |
The derivative of elem_solution_accel with respect to the current nonlinear solution, for use by systems with non default mass_residual terms.
Definition at line 514 of file diff_context.h.
Referenced by libMesh::NewmarkSolver::_general_residual(), libMesh::DiffContext::get_elem_solution_accel_derivative(), and libMesh::FirstOrderUnsteadySolver::prepare_accel().
|
inherited |
The derivative of elem_solution with respect to the current nonlinear solution.
Definition at line 500 of file diff_context.h.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::EigenTimeSolver::element_residual(), libMesh::DiffContext::get_elem_solution_derivative(), and libMesh::EigenTimeSolver::side_residual().
|
inherited |
The derivative of elem_solution_rate with respect to the current nonlinear solution, for use by systems with non default mass_residual terms.
Definition at line 507 of file diff_context.h.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::EigenTimeSolver::element_residual(), libMesh::DiffContext::get_elem_solution_rate_derivative(), and libMesh::EigenTimeSolver::side_residual().
|
inherited |
The derivative of elem_fixed_solution with respect to the nonlinear solution, for use by systems constructing jacobians with elem_fixed_solution based methods
Definition at line 521 of file diff_context.h.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::SteadySolver::_general_residual(), and libMesh::DiffContext::get_fixed_solution_derivative().
|
inherited |
Current side for side_* to examine
Definition at line 979 of file fem_context.h.
Referenced by libMesh::FEMContext::get_side(), libMesh::FEMContext::has_side_boundary_id(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), and libMesh::FEMContext::side_boundary_ids().
|
inherited |
This is the time stored in the System class at the time this context was created, i.e. the time at the beginning of the current timestep. This value gets set in the constructor and unlike DiffContext::time, is not tweaked mid-timestep by transient solvers: it remains equal to the value it was assigned at construction.
Definition at line 494 of file diff_context.h.
Referenced by libMesh::DiffContext::get_system_time().
|
inherited |
For time-dependent problems, this is the time t for which the current nonlinear_solution is defined. FIXME - this needs to be tweaked mid-timestep by all transient solvers!
Definition at line 485 of file diff_context.h.
Referenced by libMesh::DiffContext::get_time(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::operator()(), and libMesh::DiffContext::set_time().