libMesh
libMesh::DofMap Member List

This is the complete list of members for libMesh::DofMap, including all inherited members.

_adjoint_constraint_valueslibMesh::DofMapprivate
_adjoint_dirichlet_boundarieslibMesh::DofMapprivate
_algebraic_ghosting_functorslibMesh::DofMapprivate
_augment_send_listlibMesh::DofMapprivate
_augment_sparsity_patternlibMesh::DofMapprivate
_communicatorlibMesh::ParallelObjectprotected
_constrained_sparsity_constructionlibMesh::DofMapprivate
_countslibMesh::ReferenceCounterprotectedstatic
_coupling_functorslibMesh::DofMapprivate
_default_couplinglibMesh::DofMapprivate
_default_evaluatinglibMesh::DofMapprivate
_dirichlet_boundarieslibMesh::DofMapprivate
_dof_constraintslibMesh::DofMapprivate
_dof_couplinglibMesh::DofMap
_dof_indices(const Elem &elem, int p_level, std::vector< dof_id_type > &di, const unsigned int vg, const unsigned int vig, const Node *const *nodes, unsigned int n_nodes #ifdef DEBUG, const unsigned int v, std::size_t &tot_size #endif) constlibMesh::DofMapprivate
_dont_p_refinelibMesh::DofMapprivate
_enable_print_counterlibMesh::ReferenceCounterprotectedstatic
_end_dflibMesh::DofMapprivate
_end_old_dflibMesh::DofMapprivate
_error_on_constraint_looplibMesh::DofMapprivate
_extra_send_list_contextlibMesh::DofMapprivate
_extra_send_list_functionlibMesh::DofMapprivate
_extra_sparsity_contextlibMesh::DofMapprivate
_extra_sparsity_functionlibMesh::DofMapprivate
_first_dflibMesh::DofMapprivate
_first_old_dflibMesh::DofMapprivate
_first_old_scalar_dflibMesh::DofMapprivate
_first_scalar_dflibMesh::DofMapprivate
_implicit_neighbor_dofslibMesh::DofMapprivate
_implicit_neighbor_dofs_initializedlibMesh::DofMapprivate
_matriceslibMesh::DofMapprivate
_meshlibMesh::DofMapprivate
_mutexlibMesh::ReferenceCounterprotectedstatic
_n_dfslibMesh::DofMapprivate
_n_objectslibMesh::ReferenceCounterprotectedstatic
_n_old_dfslibMesh::DofMapprivate
_n_SCALAR_dofslibMesh::DofMapprivate
_node_constraintslibMesh::DofMapprivate
_node_dof_indices(const Elem &elem, unsigned int n, const DofObject &obj, std::vector< dof_id_type > &di, const unsigned int vn) constlibMesh::DofMapprivate
_periodic_boundarieslibMesh::DofMapprivate
_primal_constraint_valueslibMesh::DofMapprivate
_send_listlibMesh::DofMapprivate
_shared_functorslibMesh::DofMapprivate
_splibMesh::DofMapprivate
_stashed_dof_constraintslibMesh::DofMapprivate
_sys_numberlibMesh::DofMapprivate
_var_to_vglibMesh::DofMapprivate
_variable_group_numberslibMesh::DofMapprivate
_variable_groupslibMesh::DofMapprivate
_variableslibMesh::DofMapprivate
_verify_dirichlet_bc_consistencylibMesh::DofMapprivate
add_adjoint_constraint_row(const unsigned int qoi_index, const dof_id_type dof_number, const DofConstraintRow &constraint_row, const Number constraint_rhs, const bool forbid_constraint_overwrite)libMesh::DofMap
add_adjoint_dirichlet_boundary(const DirichletBoundary &dirichlet_boundary, unsigned int q)libMesh::DofMap
add_algebraic_ghosting_functor(GhostingFunctor &evaluable_functor, bool to_mesh=true)libMesh::DofMap
add_algebraic_ghosting_functor(std::shared_ptr< GhostingFunctor > evaluable_functor, bool to_mesh=true)libMesh::DofMapinline
add_constraint_row(const dof_id_type dof_number, const DofConstraintRow &constraint_row, const Number constraint_rhs, const bool forbid_constraint_overwrite)libMesh::DofMap
add_constraint_row(const dof_id_type dof_number, const DofConstraintRow &constraint_row, const bool forbid_constraint_overwrite=true)libMesh::DofMapinline
add_constraints_to_send_list()libMesh::DofMapprivate
add_coupling_functor(GhostingFunctor &coupling_functor, bool to_mesh=true)libMesh::DofMap
add_coupling_functor(std::shared_ptr< GhostingFunctor > coupling_functor, bool to_mesh=true)libMesh::DofMapinline
add_default_ghosting()libMesh::DofMap
add_dirichlet_boundary(const DirichletBoundary &dirichlet_boundary)libMesh::DofMap
add_neighbors_to_send_list(MeshBase &mesh)libMesh::DofMapprivate
add_periodic_boundary(const PeriodicBoundaryBase &periodic_boundary)libMesh::DofMap
add_periodic_boundary(const PeriodicBoundaryBase &boundary, const PeriodicBoundaryBase &inverse_boundary)libMesh::DofMap
add_variable_group(VariableGroup var_group)libMesh::DofMap
algebraic_ghosting_functors_begin() constlibMesh::DofMapinline
algebraic_ghosting_functors_end() constlibMesh::DofMapinline
all_semilocal_indices(const std::vector< dof_id_type > &dof_indices) constlibMesh::DofMap
allgather_recursive_constraints(MeshBase &)libMesh::DofMap
assert_no_nodes_missed(MeshBase &mesh)libMesh::DofMapprivate
attach_extra_send_list_function(void(*func)(std::vector< dof_id_type > &, void *), void *context=nullptr)libMesh::DofMapinline
attach_extra_send_list_object(DofMap::AugmentSendList &asl)libMesh::DofMapinline
attach_extra_sparsity_function(void(*func)(SparsityPattern::Graph &sparsity, std::vector< dof_id_type > &n_nz, std::vector< dof_id_type > &n_oz, void *), void *context=nullptr)libMesh::DofMapinline
attach_extra_sparsity_object(SparsityPattern::AugmentSparsityPattern &asp)libMesh::DofMapinline
attach_matrix(SparseMatrix< Number > &matrix)libMesh::DofMap
block_size() constlibMesh::DofMapinline
build_constraint_matrix(DenseMatrix< Number > &C, std::vector< dof_id_type > &elem_dofs, const bool called_recursively=false) constlibMesh::DofMapprivate
build_constraint_matrix_and_vector(DenseMatrix< Number > &C, DenseVector< Number > &H, std::vector< dof_id_type > &elem_dofs, int qoi_index=-1, const bool called_recursively=false) constlibMesh::DofMapprivate
build_sparsity(const MeshBase &mesh, bool calculate_constrained=false) constlibMesh::DofMap
check_dirichlet_bcid_consistency(const MeshBase &mesh, const DirichletBoundary &boundary) constlibMesh::DofMap
check_for_constraint_loops()libMesh::DofMap
check_for_cyclic_constraints()libMesh::DofMap
clear()libMesh::DofMap
clear_send_list()libMesh::DofMapinline
clear_sparsity()libMesh::DofMap
comm() constlibMesh::ParallelObjectinline
compute_sparsity(const MeshBase &)libMesh::DofMap
computed_sparsity_already() constlibMesh::DofMap
constrain_element_dyad_matrix(DenseVector< Number > &v, DenseVector< Number > &w, std::vector< dof_id_type > &row_dofs, bool asymmetric_constraint_rows=true) constlibMesh::DofMapinline
constrain_element_matrix(DenseMatrix< Number > &matrix, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true) constlibMesh::DofMapinline
constrain_element_matrix(DenseMatrix< Number > &matrix, std::vector< dof_id_type > &row_dofs, std::vector< dof_id_type > &col_dofs, bool asymmetric_constraint_rows=true) constlibMesh::DofMapinline
constrain_element_matrix_and_vector(DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true) constlibMesh::DofMapinline
constrain_element_residual(DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, NumericVector< Number > &solution_local) constlibMesh::DofMap
constrain_element_vector(DenseVector< Number > &rhs, std::vector< dof_id_type > &dofs, bool asymmetric_constraint_rows=true) constlibMesh::DofMapinline
constrain_nothing(std::vector< dof_id_type > &dofs) constlibMesh::DofMapinline
constrain_p_dofs(unsigned int var, const Elem *elem, unsigned int s, unsigned int p)libMesh::DofMap
constrained_sparsity_construction()libMesh::DofMapinline
constraint_rows_begin() constlibMesh::DofMapinline
constraint_rows_end() constlibMesh::DofMapinline
Counts typedeflibMesh::ReferenceCounterprotected
coupling_functors_begin() constlibMesh::DofMapinline
coupling_functors_end() constlibMesh::DofMapinline
CouplingMatricesSet typedeflibMesh::DofMapprivate
create_dof_constraints(const MeshBase &, Real time=0)libMesh::DofMap
default_algebraic_ghosting()libMesh::DofMapinline
default_coupling()libMesh::DofMapinline
disable_print_counter_info()libMesh::ReferenceCounterstatic
distribute_dofs(MeshBase &)libMesh::DofMap
distribute_local_dofs_node_major(dof_id_type &next_free_dof, MeshBase &mesh)libMesh::DofMapprivate
distribute_local_dofs_var_major(dof_id_type &next_free_dof, MeshBase &mesh)libMesh::DofMapprivate
distribute_scalar_dofs(dof_id_type &next_free_dof)libMesh::DofMapprivate
dof_indices(const Elem *const elem, std::vector< dof_id_type > &di) constlibMesh::DofMap
dof_indices(const Elem *const elem, std::vector< dof_id_type > &di, const unsigned int vn, int p_level=-12345) constlibMesh::DofMap
dof_indices(const Node *const node, std::vector< dof_id_type > &di) constlibMesh::DofMap
dof_indices(const Node *const node, std::vector< dof_id_type > &di, const unsigned int vn) constlibMesh::DofMap
dof_indices(const Elem &elem, unsigned int n, std::vector< dof_id_type > &di, const unsigned int vn) constlibMesh::DofMap
dof_owner(const dof_id_type dof) constlibMesh::DofMapinline
DofMap(const unsigned int sys_number, MeshBase &mesh)libMesh::DofMapexplicit
dofobject_accessor typedeflibMesh::DofMapprivate
elem_ptr(MeshBase &mesh, dof_id_type i) constlibMesh::DofMapprivate
enable_print_counter_info()libMesh::ReferenceCounterstatic
end_dof(const processor_id_type proc) constlibMesh::DofMapinline
end_dof() constlibMesh::DofMapinline
end_old_dof(const processor_id_type proc) constlibMesh::DofMapinline
end_old_dof() constlibMesh::DofMapinline
enforce_adjoint_constraints_exactly(NumericVector< Number > &v, unsigned int q) constlibMesh::DofMapinline
enforce_constraints_exactly(const System &system, NumericVector< Number > *v=nullptr, bool homogeneous=false) constlibMesh::DofMapinline
enforce_constraints_on_jacobian(const NonlinearImplicitSystem &system, SparseMatrix< Number > *jac) constlibMesh::DofMapinline
enforce_constraints_on_residual(const NonlinearImplicitSystem &system, NumericVector< Number > *rhs, NumericVector< Number > const *solution, bool homogeneous=true) constlibMesh::DofMapinline
extract_local_vector(const NumericVector< Number > &Ug, const std::vector< dof_id_type > &dof_indices, DenseVectorBase< Number > &Ue) constlibMesh::DofMap
find_connected_dof_objects(std::vector< const DofObject *> &objs) constlibMesh::DofMapprivate
find_connected_dofs(std::vector< dof_id_type > &elem_dofs) constlibMesh::DofMapprivate
first_dof(const processor_id_type proc) constlibMesh::DofMapinline
first_dof() constlibMesh::DofMapinline
first_old_dof(const processor_id_type proc) constlibMesh::DofMapinline
first_old_dof() constlibMesh::DofMapinline
gather_constraints(MeshBase &mesh, std::set< dof_id_type > &unexpanded_dofs, bool look_for_constrainees)libMesh::DofMap
get_adjoint_dirichlet_boundaries(unsigned int q) constlibMesh::DofMap
get_adjoint_dirichlet_boundaries(unsigned int q)libMesh::DofMap
get_dirichlet_boundaries() constlibMesh::DofMapinline
get_dirichlet_boundaries()libMesh::DofMapinline
get_dof_constraints() constlibMesh::DofMapinline
get_info() constlibMesh::DofMap
ReferenceCountedObject< DofMap >::get_info()libMesh::ReferenceCounterstatic
get_local_constraints(bool print_nonlocal=false) constlibMesh::DofMap
get_n_nz() constlibMesh::DofMapinline
get_n_oz() constlibMesh::DofMapinline
get_periodic_boundaries()libMesh::DofMapinline
get_periodic_boundaries() constlibMesh::DofMapinline
get_primal_constraint_values()libMesh::DofMapinline
get_send_list() constlibMesh::DofMapinline
get_sparsity_pattern() constlibMesh::DofMapinline
has_adjoint_dirichlet_boundaries(unsigned int q) constlibMesh::DofMap
has_blocked_representation() constlibMesh::DofMapinline
has_heterogeneous_adjoint_constraint(const unsigned int qoi_num, const dof_id_type dof) constlibMesh::DofMapinline
has_heterogeneous_adjoint_constraints(const unsigned int qoi_num) constlibMesh::DofMapinline
has_heterogenous_adjoint_constraint(const unsigned int qoi_num, const dof_id_type dof) constlibMesh::DofMapinline
has_heterogenous_adjoint_constraints(const unsigned int qoi_num) constlibMesh::DofMapinline
heterogeneously_constrain_element_jacobian_and_residual(DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, NumericVector< Number > &solution_local) constlibMesh::DofMap
heterogeneously_constrain_element_matrix_and_vector(DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true, int qoi_index=-1) constlibMesh::DofMapinline
heterogeneously_constrain_element_residual(DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, NumericVector< Number > &solution_local) constlibMesh::DofMap
heterogeneously_constrain_element_vector(const DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true, int qoi_index=-1) constlibMesh::DofMapinline
heterogenously_constrain_element_matrix_and_vector(DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true, int qoi_index=-1) constlibMesh::DofMapinline
heterogenously_constrain_element_vector(const DenseMatrix< Number > &matrix, DenseVector< Number > &rhs, std::vector< dof_id_type > &elem_dofs, bool asymmetric_constraint_rows=true, int qoi_index=-1) constlibMesh::DofMapinline
increment_constructor_count(const std::string &name) noexceptlibMesh::ReferenceCounterinlineprotected
increment_destructor_count(const std::string &name) noexceptlibMesh::ReferenceCounterinlineprotected
invalidate_dofs(MeshBase &mesh) constlibMesh::DofMapprivate
is_attached(SparseMatrix< Number > &matrix)libMesh::DofMap
is_constrained_dof(const dof_id_type dof) constlibMesh::DofMapinline
is_constrained_node(const Node *node) constlibMesh::DofMapinline
is_evaluable(const DofObjectSubclass &obj, unsigned int var_num=libMesh::invalid_uint) constlibMesh::DofMap
is_periodic_boundary(const boundary_id_type boundaryid) constlibMesh::DofMap
local_index(dof_id_type dof_index) constlibMesh::DofMapinline
local_variable_indices(std::vector< dof_id_type > &idx, const MeshBase &mesh, unsigned int var_num) constlibMesh::DofMap
max_constraint_error(const System &system, NumericVector< Number > *v=nullptr) constlibMesh::DofMap
merge_ghost_functor_outputs(GhostingFunctor::map_type &elements_to_ghost, CouplingMatricesSet &temporary_coupling_matrices, const std::set< GhostingFunctor *>::iterator &gf_begin, const std::set< GhostingFunctor *>::iterator &gf_end, const MeshBase::const_element_iterator &elems_begin, const MeshBase::const_element_iterator &elems_end, processor_id_type p)libMesh::DofMapprivatestatic
n_constrained_dofs() constlibMesh::DofMap
n_constrained_nodes() constlibMesh::DofMapinline
n_dofs() constlibMesh::DofMapinline
n_dofs_on_processor(const processor_id_type proc) constlibMesh::DofMapinline
n_local_constrained_dofs() constlibMesh::DofMap
n_local_dofs() constlibMesh::DofMapinline
n_objects()libMesh::ReferenceCounterinlinestatic
n_old_dofs() constlibMesh::DofMapinline
n_processors() constlibMesh::ParallelObjectinline
n_SCALAR_dofs() constlibMesh::DofMapinline
n_variable_groups() constlibMesh::DofMapinline
n_variables() constlibMesh::DofMapinline
need_full_sparsity_patternlibMesh::DofMapprivate
node_constraint_rows_begin() constlibMesh::DofMapinline
node_constraint_rows_end() constlibMesh::DofMapinline
node_ptr(MeshBase &mesh, dof_id_type i) constlibMesh::DofMapprivate
old_dof_indices(const Elem &elem, unsigned int n, std::vector< dof_id_type > &di, const unsigned int vn) constlibMesh::DofMap
old_dof_indices(const Elem *const elem, std::vector< dof_id_type > &di, const unsigned int vn=libMesh::invalid_uint) constlibMesh::DofMap
ReferenceCountedObject< DofMap >::operator=(const ReferenceCountedObject &)libMesh::ReferenceCountedObject< DofMap >inlineprotected
libMesh::ParallelObject::operator=(const ParallelObject &libmesh_dbg_var(other))libMesh::ParallelObjectinline
ParallelObject(const Parallel::Communicator &comm_in)libMesh::ParallelObjectinline
ParallelObject(const ParallelObject &other)libMesh::ParallelObjectinline
prepare_send_list()libMesh::DofMap
print_dof_constraints(std::ostream &os=libMesh::out, bool print_nonlocal=false) constlibMesh::DofMap
print_info(std::ostream &os=libMesh::out) constlibMesh::DofMap
ReferenceCountedObject< DofMap >::print_info(std::ostream &out_stream=libMesh::out)libMesh::ReferenceCounterstatic
process_constraints(MeshBase &)libMesh::DofMap
process_mesh_constraint_rows(const MeshBase &mesh)libMesh::DofMapprivate
processor_id() constlibMesh::ParallelObjectinline
ReferenceCountedObject()libMesh::ReferenceCountedObject< DofMap >inlineprotected
ReferenceCountedObject(const ReferenceCountedObject &other)libMesh::ReferenceCountedObject< DofMap >inlineprotected
ReferenceCountedObject(ReferenceCountedObject &&other) noexceptlibMesh::ReferenceCountedObject< DofMap >inlineprotected
ReferenceCounter()libMesh::ReferenceCounterinlineprotected
ReferenceCounter(const ReferenceCounter &)libMesh::ReferenceCounterinlineprotected
ReferenceCounter(ReferenceCounter &&other) noexceptlibMesh::ReferenceCounterinlineprotected
reinit(MeshBase &mesh)libMesh::DofMap
reinit_send_list(MeshBase &mesh)libMesh::DofMap
remove_adjoint_dirichlet_boundary(const DirichletBoundary &dirichlet_boundary, unsigned int q)libMesh::DofMap
remove_algebraic_ghosting_functor(GhostingFunctor &evaluable_functor)libMesh::DofMap
remove_coupling_functor(GhostingFunctor &coupling_functor)libMesh::DofMap
remove_default_ghosting()libMesh::DofMap
remove_dirichlet_boundary(const DirichletBoundary &dirichlet_boundary)libMesh::DofMap
SCALAR_dof_indices(std::vector< dof_id_type > &di, const unsigned int vn, const bool old_dofs=false) constlibMesh::DofMap
scatter_constraints(MeshBase &)libMesh::DofMap
semilocal_index(dof_id_type dof_index) constlibMesh::DofMap
set_constrained_sparsity_construction(bool use_constraints)libMesh::DofMapinline
set_error_on_constraint_loop(bool error_on_constraint_loop)libMesh::DofMap
set_error_on_cyclic_constraint(bool error_on_cyclic_constraint)libMesh::DofMap
set_implicit_neighbor_dofs(bool implicit_neighbor_dofs)libMesh::DofMap
set_nonlocal_dof_objects(iterator_type objects_begin, iterator_type objects_end, MeshBase &mesh, dofobject_accessor objects)libMesh::DofMapprivate
set_verify_dirichlet_bc_consistency(bool val)libMesh::DofMap
should_p_refine(unsigned int g, bool p_refine)libMesh::DofMapinline
should_p_refine(unsigned int g) constlibMesh::DofMapinline
should_p_refine(FEFamily, bool)=deletelibMesh::DofMap
should_p_refine(Order, bool)=deletelibMesh::DofMap
should_p_refine(FEFamily) const =deletelibMesh::DofMap
should_p_refine(Order) const =deletelibMesh::DofMap
should_p_refine_var(unsigned int var) constlibMesh::DofMapinline
SparsityPattern::Build classlibMesh::DofMapfriend
stash_dof_constraints()libMesh::DofMapinline
swap_dof_constraints()libMesh::DofMapinline
sys_number() constlibMesh::DofMapinline
unstash_dof_constraints()libMesh::DofMapinline
update_sparsity_pattern(SparseMatrix< Number > &matrix) constlibMesh::DofMap
use_coupled_neighbor_dofs(const MeshBase &mesh) constlibMesh::DofMap
var_group_from_var_number(unsigned int var_num) constlibMesh::DofMapinline
variable(const unsigned int c) constlibMesh::DofMapinline
variable_group(const unsigned int c) constlibMesh::DofMapinline
variable_group_order(const unsigned int vg) constlibMesh::DofMapinline
variable_group_type(const unsigned int vg) constlibMesh::DofMapinline
variable_order(const unsigned int c) constlibMesh::DofMapinline
variable_type(const unsigned int c) constlibMesh::DofMapinline
~DofMap()libMesh::DofMap
~ParallelObject()=defaultlibMesh::ParallelObjectvirtual
~ReferenceCountedObject()libMesh::ReferenceCountedObject< DofMap >inline
~ReferenceCounter()libMesh::ReferenceCounterinline