![]() |
|
#include <refineable_mesh.h>
Inheritance diagram for oomph::RefineableMeshBase:Public Member Functions | |
| bool | adapt_flag () |
| RefineableMeshBase () | |
| RefineableMeshBase (const RefineableMeshBase &dummy)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const RefineableMeshBase &)=delete |
| Broken assignment operator. More... | |
| virtual | ~RefineableMeshBase () |
| Empty Destructor: More... | |
| unsigned | nrefined () |
| Access fct for number of elements that were refined. More... | |
| unsigned | nunrefined () |
| Access fct for number of elements that were unrefined. More... | |
| unsigned & | nrefinement_overruled () |
| unsigned & | max_keep_unrefined () |
| virtual void | doc_adaptivity_targets (std::ostream &outfile) |
| Doc the targets for mesh adaptation. More... | |
| ErrorEstimator *& | spatial_error_estimator_pt () |
| Access to spatial error estimator. More... | |
| ErrorEstimator * | spatial_error_estimator_pt () const |
| Access to spatial error estimator (const version. More... | |
| double & | min_permitted_error () |
| double & | max_permitted_error () |
| double & | min_error () |
| double & | max_error () |
| DocInfo *& | doc_info_pt () |
| Access fct for pointer to DocInfo. More... | |
| void | enable_adaptation () |
| Enable adaptation. More... | |
| void | disable_adaptation () |
| Disable adaptation. More... | |
| void | enable_p_adaptation () |
| Enable adaptation. More... | |
| void | disable_p_adaptation () |
| Disable adaptation. More... | |
| void | enable_additional_synchronisation_of_hanging_nodes () |
| Enable additional synchronisation of hanging nodes. More... | |
| void | disable_additional_synchronisation_of_hanging_nodes () |
| Disable additional synchronisation of hanging nodes. More... | |
| bool | is_adaptation_enabled () const |
| Return whether the mesh is to be adapted. More... | |
| bool | is_p_adaptation_enabled () const |
| Return whether the mesh is to be adapted. More... | |
| bool | is_additional_synchronisation_of_hanging_nodes_disabled () const |
| Return whether additional synchronisation is enabled. More... | |
| DocInfo | doc_info () |
| Access fct for DocInfo. More... | |
| virtual void | adapt (const Vector< double > &elemental_error)=0 |
| virtual void | p_adapt (const Vector< double > &elemental_error) |
| virtual void | refine_uniformly (DocInfo &doc_info)=0 |
| Refine mesh uniformly and doc process. More... | |
| virtual void | refine_uniformly () |
| Refine mesh uniformly. More... | |
| virtual void | p_refine_uniformly (DocInfo &doc_info) |
| p-refine mesh uniformly and doc process More... | |
| virtual void | p_refine_uniformly () |
| p-refine mesh uniformly More... | |
| virtual unsigned | unrefine_uniformly ()=0 |
| void | p_unrefine_uniformly (DocInfo &doc_info) |
| p-unrefine mesh uniformly More... | |
Public Member Functions inherited from oomph::Mesh | |
| Mesh () | |
| Default constructor. More... | |
| Mesh (const Vector< Mesh * > &sub_mesh_pt) | |
| void | merge_meshes (const Vector< Mesh * > &sub_mesh_pt) |
| virtual void | setup_boundary_element_info () |
| virtual void | setup_boundary_element_info (std::ostream &outfile) |
| virtual void | reset_boundary_element_info (Vector< unsigned > &ntmp_boundary_elements, Vector< Vector< unsigned >> &ntmp_boundary_elements_in_region, Vector< FiniteElement * > &deleted_elements) |
| Virtual function to perform the reset boundary elements info rutines. More... | |
| template<class BULK_ELEMENT > | |
| void | doc_boundary_coordinates (const unsigned &b, std::ofstream &the_file) |
| virtual void | scale_mesh (const double &factor) |
| Mesh (const Mesh &dummy)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const Mesh &)=delete |
| Broken assignment operator. More... | |
| virtual | ~Mesh () |
| Virtual Destructor to clean up all memory. More... | |
| void | flush_element_and_node_storage () |
| void | flush_element_storage () |
| void | flush_node_storage () |
| Node *& | node_pt (const unsigned long &n) |
| Return pointer to global node n. More... | |
| Node * | node_pt (const unsigned long &n) const |
| Return pointer to global node n (const version) More... | |
| GeneralisedElement *& | element_pt (const unsigned long &e) |
| Return pointer to element e. More... | |
| GeneralisedElement * | element_pt (const unsigned long &e) const |
| Return pointer to element e (const version) More... | |
| const Vector< GeneralisedElement * > & | element_pt () const |
| Return reference to the Vector of elements. More... | |
| Vector< GeneralisedElement * > & | element_pt () |
| Return reference to the Vector of elements. More... | |
| FiniteElement * | finite_element_pt (const unsigned &e) const |
| Node *& | boundary_node_pt (const unsigned &b, const unsigned &n) |
| Return pointer to node n on boundary b. More... | |
| Node * | boundary_node_pt (const unsigned &b, const unsigned &n) const |
| Return pointer to node n on boundary b. More... | |
| void | set_nboundary (const unsigned &nbound) |
| Set the number of boundaries in the mesh. More... | |
| void | remove_boundary_nodes () |
| Clear all pointers to boundary nodes. More... | |
| void | remove_boundary_nodes (const unsigned &b) |
| void | remove_boundary_node (const unsigned &b, Node *const &node_pt) |
| Remove a node from the boundary b. More... | |
| void | add_boundary_node (const unsigned &b, Node *const &node_pt) |
| Add a (pointer to) a node to the b-th boundary. More... | |
| void | copy_boundary_node_data_from_nodes () |
| bool | boundary_coordinate_exists (const unsigned &i) const |
| Indicate whether the i-th boundary has an intrinsic coordinate. More... | |
| unsigned long | nelement () const |
| Return number of elements in the mesh. More... | |
| unsigned long | nnode () const |
| Return number of nodes in the mesh. More... | |
| unsigned | ndof_types () const |
| Return number of dof types in mesh. More... | |
| unsigned | elemental_dimension () const |
| Return number of elemental dimension in mesh. More... | |
| unsigned | nodal_dimension () const |
| Return number of nodal dimension in mesh. More... | |
| void | add_node_pt (Node *const &node_pt) |
| Add a (pointer to a) node to the mesh. More... | |
| void | add_element_pt (GeneralisedElement *const &element_pt) |
| Add a (pointer to) an element to the mesh. More... | |
| virtual void | node_update (const bool &update_all_solid_nodes=false) |
| virtual void | reorder_nodes (const bool &use_old_ordering=true) |
| virtual void | get_node_reordering (Vector< Node * > &reordering, const bool &use_old_ordering=true) const |
| template<class BULK_ELEMENT , template< class > class FACE_ELEMENT> | |
| void | build_face_mesh (const unsigned &b, Mesh *const &face_mesh_pt) |
| unsigned | self_test () |
| Self-test: Check elements and nodes. Return 0 for OK. More... | |
| void | max_and_min_element_size (double &max_size, double &min_size) |
| double | total_size () |
| void | check_inverted_elements (bool &mesh_has_inverted_elements, std::ofstream &inverted_element_file) |
| void | check_inverted_elements (bool &mesh_has_inverted_elements) |
| unsigned | check_for_repeated_nodes (const double &epsilon=1.0e-12) |
| Vector< Node * > | prune_dead_nodes () |
| unsigned | nboundary () const |
| Return number of boundaries. More... | |
| unsigned long | nboundary_node (const unsigned &ibound) const |
| Return number of nodes on a particular boundary. More... | |
| FiniteElement * | boundary_element_pt (const unsigned &b, const unsigned &e) const |
| Return pointer to e-th finite element on boundary b. More... | |
| Node * | get_some_non_boundary_node () const |
| unsigned | nboundary_element (const unsigned &b) const |
| Return number of finite elements that are adjacent to boundary b. More... | |
| int | face_index_at_boundary (const unsigned &b, const unsigned &e) const |
| virtual void | dump (std::ofstream &dump_file, const bool &use_old_ordering=true) const |
| Dump the data in the mesh into a file for restart. More... | |
| void | dump (const std::string &dump_file_name, const bool &use_old_ordering=true) const |
| Dump the data in the mesh into a file for restart. More... | |
| virtual void | read (std::ifstream &restart_file) |
| Read solution from restart file. More... | |
| void | output_paraview (std::ofstream &file_out, const unsigned &nplot) const |
| void | output_fct_paraview (std::ofstream &file_out, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt) const |
| void | output_fct_paraview (std::ofstream &file_out, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt) const |
| void | output (std::ostream &outfile) |
| Output for all elements. More... | |
| void | output (std::ostream &outfile, const unsigned &n_plot) |
| Output at f(n_plot) points in each element. More... | |
| void | output (FILE *file_pt) |
| Output for all elements (C-style output) More... | |
| void | output (FILE *file_pt, const unsigned &nplot) |
| Output at f(n_plot) points in each element (C-style output) More... | |
| void | output (const std::string &output_filename) |
| Output for all elements. More... | |
| void | output (const std::string &output_filename, const unsigned &n_plot) |
| Output at f(n_plot) points in each element. More... | |
| void | output_fct (std::ostream &outfile, const unsigned &n_plot, FiniteElement::SteadyExactSolutionFctPt) |
| Output a given Vector function at f(n_plot) points in each element. More... | |
| void | output_fct (std::ostream &outfile, const unsigned &n_plot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt) |
| void | output_boundaries (std::ostream &outfile) |
| Output the nodes on the boundaries (into separate tecplot zones) More... | |
| void | output_boundaries (const std::string &output_filename) |
| void | assign_initial_values_impulsive () |
| Assign initial values for an impulsive start. More... | |
| void | shift_time_values () |
| void | calculate_predictions () |
| void | set_nodal_and_elemental_time_stepper (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data) |
| virtual void | set_mesh_level_time_stepper (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data) |
| void | set_consistent_pinned_values_for_continuation (ContinuationStorageScheme *const &continuation_stepper_pt) |
| Set consistent values for pinned data in continuation. More... | |
| bool | does_pointer_correspond_to_mesh_data (double *const ¶meter_pt) |
| Does the double pointer correspond to any mesh data. More... | |
| void | set_nodal_time_stepper (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data) |
| Set the timestepper associated with the nodal data in the mesh. More... | |
| void | set_elemental_internal_time_stepper (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data) |
| virtual void | compute_norm (double &norm) |
| virtual void | compute_norm (Vector< double > &norm) |
| virtual void | compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm) |
| virtual void | compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm) |
| virtual void | compute_error (FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm) |
| virtual void | compute_error (FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, Vector< double > &error, Vector< double > &norm) |
| virtual void | compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm) |
| virtual void | compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, Vector< double > &error, Vector< double > &norm) |
| virtual void | compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm) |
| Returns the norm of the error and that of the exact solution. More... | |
| virtual void | compute_error (FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, Vector< double > &error, Vector< double > &norm) |
| bool | is_mesh_distributed () const |
| Boolean to indicate if Mesh has been distributed. More... | |
| OomphCommunicator * | communicator_pt () const |
| void | delete_all_external_storage () |
| Wipe the storage for all externally-based elements. More... | |
Protected Attributes | |
| ErrorEstimator * | Spatial_error_estimator_pt |
| Pointer to spatial error estimator. More... | |
| double | Max_permitted_error |
| Max. error (i.e. split elements if their error is larger) More... | |
| double | Min_permitted_error |
| Min. error (i.e. (try to) merge elements if their error is smaller) More... | |
| double | Min_error |
| Min.actual error. More... | |
| double | Max_error |
| Max. actual error. More... | |
| unsigned | Nrefined |
| Stats: Number of elements that were refined. More... | |
| unsigned | Nunrefined |
| Stats: Number of elements that were unrefined. More... | |
| bool | Adapt_flag |
| Flag that requests adaptation. More... | |
| bool | P_adapt_flag |
| Flag that requests p-adaptation. More... | |
| bool | Additional_synchronisation_of_hanging_nodes_not_required |
| Flag that disables additional synchronisation of hanging nodes. More... | |
| DocInfo * | Doc_info_pt |
| Pointer to DocInfo. More... | |
| unsigned | Max_keep_unrefined |
| unsigned | Nrefinement_overruled |
Protected Attributes inherited from oomph::Mesh | |
| Vector< Vector< Node * > > | Boundary_node_pt |
| bool | Lookup_for_elements_next_boundary_is_setup |
| Vector< Vector< FiniteElement * > > | Boundary_element_pt |
| Vector< Vector< int > > | Face_index_at_boundary |
| Vector< Node * > | Node_pt |
| Vector of pointers to nodes. More... | |
| Vector< GeneralisedElement * > | Element_pt |
| Vector of pointers to generalised elements. More... | |
| std::vector< bool > | Boundary_coordinate_exists |
Additional Inherited Members | |
Public Types inherited from oomph::Mesh | |
| typedef void(FiniteElement::* | SteadyExactSolutionFctPt) (const Vector< double > &x, Vector< double > &soln) |
| typedef void(FiniteElement::* | UnsteadyExactSolutionFctPt) (const double &time, const Vector< double > &x, Vector< double > &soln) |
Static Public Attributes inherited from oomph::Mesh | |
| static Steady< 0 > | Default_TimeStepper |
| The Steady Timestepper. More... | |
| static bool | Suppress_warning_about_empty_mesh_level_time_stepper_function |
| Static boolean flag to control warning about mesh level timesteppers. More... | |
Protected Member Functions inherited from oomph::Mesh | |
| unsigned long | assign_global_eqn_numbers (Vector< double * > &Dof_pt) |
| Assign (global) equation numbers to the nodes. More... | |
| void | describe_dofs (std::ostream &out, const std::string ¤t_string) const |
| void | describe_local_dofs (std::ostream &out, const std::string ¤t_string) const |
| void | assign_local_eqn_numbers (const bool &store_local_dof_pt) |
| Assign local equation numbers in all elements. More... | |
| void | convert_to_boundary_node (Node *&node_pt, const Vector< FiniteElement * > &finite_element_pt) |
| void | convert_to_boundary_node (Node *&node_pt) |
Base class for refineable meshes. Provides standardised interfaces for the following standard mesh adaptation routines:
|
inline |
Constructor sets default values for refinement targets etc. and initialises pointer to spatial error estimator to NULL.
References Adapt_flag, Additional_synchronisation_of_hanging_nodes_not_required, Doc_info_pt, Max_error, Max_keep_unrefined, Max_permitted_error, Min_error, Min_permitted_error, Nrefinement_overruled, P_adapt_flag, and Spatial_error_estimator_pt.
|
delete |
Broken copy constructor.
|
pure virtual |
Adapt mesh: Refine elements whose error is lager than err_max and (try to) unrefine those whose error is smaller than err_min
Implemented in oomph::TreeBasedRefineableMeshBase, oomph::RefineableTriangleMesh< ELEMENT >, oomph::RefineableTriangleMesh< ELASTICITY_ELEMENT >, oomph::RefineableTriangleMesh< ProjectableUnsteadyHeatElement< TUnsteadyHeatElement< 2, 3 > > >, oomph::RefineableTetgenMesh< ELEMENT >, oomph::RefineableQuadFromTriangleMesh< ELEMENT >, oomph::RefineableGmshTetMesh< ELEMENT >, and oomph::RefineableTetgenMesh< ELEMENT >.
|
inline |
References Adapt_flag.
|
inline |
Disable adaptation.
References Adapt_flag.
Referenced by TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
|
inline |
Disable additional synchronisation of hanging nodes.
References Additional_synchronisation_of_hanging_nodes_not_required.
|
inline |
|
inlinevirtual |
Doc the targets for mesh adaptation.
Reimplemented in oomph::RefineableTriangleMesh< ELEMENT >, oomph::RefineableTriangleMesh< ELASTICITY_ELEMENT >, oomph::RefineableTriangleMesh< ProjectableUnsteadyHeatElement< TUnsteadyHeatElement< 2, 3 > > >, oomph::RefineableTetMeshBase, oomph::TreeBasedRefineableMeshBase, and oomph::RefineableTetgenMesh< ELEMENT >.
References Max_keep_unrefined, Max_permitted_error, and Min_permitted_error.
|
inline |
Access fct for DocInfo.
References Doc_info_pt.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::TreeBasedRefineableMeshBase::p_adapt(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), p_refine_uniformly(), oomph::TreeBasedRefineableMeshBase::p_refine_uniformly(), oomph::TreeBasedRefineableMeshBase::p_unrefine_uniformly(), refine_uniformly(), and oomph::TreeBasedRefineableMeshBase::refine_uniformly().
|
inline |
Access fct for pointer to DocInfo.
References Doc_info_pt.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), main(), and oomph::TreeBasedRefineableMeshBase::p_adapt().
|
inline |
|
inline |
Enable additional synchronisation of hanging nodes.
References Additional_synchronisation_of_hanging_nodes_not_required.
|
inline |
|
inline |
|
inline |
Return whether additional synchronisation is enabled.
References Additional_synchronisation_of_hanging_nodes_not_required.
|
inline |
Return whether the mesh is to be adapted.
References P_adapt_flag.
|
inline |
Access fct for max. actual error in present solution (i.e. before re-solve on adapted mesh)
References Max_error.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt_mesh(), and oomph::TreeBasedRefineableMeshBase::p_adapt_mesh().
|
inline |
Max. number of elements that we allow to remain unrefined if no other mesh adaptation is required (to avoid mesh-adaptations that would only unrefine a few elements and then force a new solve – this can't be worth our while!)
References Max_keep_unrefined.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), FSIRingProblem::dynamic_run(), oomph::TreeBasedRefineableMeshBase::p_adapt(), and oomph::TreeBasedRefineableMeshBase::unrefine_uniformly().
|
inline |
Access fct for max. error (i.e. split elements if their error is larger)
References Max_permitted_error.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), oomph::RefineableTetMeshBase::compute_volume_target(), FSIRingProblem::dynamic_run(), oomph::TreeBasedRefineableMeshBase::p_adapt(), SolidProblem< ELEMENT_TYPE >::setupRefinementParameters(), and oomph::TreeBasedRefineableMeshBase::unrefine_uniformly().
|
inline |
|
inline |
Access fct for min. error (i.e. (try to) merge elements if their error is smaller)
References Min_permitted_error.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), oomph::RefineableTetMeshBase::compute_volume_target(), FSIRingProblem::dynamic_run(), oomph::TreeBasedRefineableMeshBase::p_adapt(), SolidProblem< ELEMENT_TYPE >::setupRefinementParameters(), and oomph::TreeBasedRefineableMeshBase::unrefine_uniformly().
|
inline |
Access fct for number of elements that were refined.
References Nrefined.
|
inline |
Number of elements that would have liked to be refined further but can't because they've reached the max. refinement level
References Nrefinement_overruled.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), and oomph::TreeBasedRefineableMeshBase::p_adapt().
|
inline |
Access fct for number of elements that were unrefined.
References Nunrefined.
|
delete |
Broken assignment operator.
|
inlinevirtual |
p-adapt mesh: Refine elements whose error is lager than err_max and (try to) unrefine those whose error is smaller than err_min
Reimplemented in oomph::TreeBasedRefineableMeshBase.
References OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
|
inlinevirtual |
p-refine mesh uniformly
Reimplemented in oomph::TreeBasedRefineableMeshBase.
References oomph::DocInfo::directory(), oomph::DocInfo::disable_doc(), and doc_info().
Referenced by oomph::TreeBasedRefineableMeshBase::p_refine_uniformly().
|
inlinevirtual |
p-refine mesh uniformly and doc process
Reimplemented in oomph::TreeBasedRefineableMeshBase.
References OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
|
inline |
|
inlinevirtual |
Refine mesh uniformly.
Reimplemented in oomph::RefineableQuadFromTriangleMesh< ELEMENT >, and oomph::TreeBasedRefineableMeshBase.
References oomph::DocInfo::directory(), oomph::DocInfo::disable_doc(), and doc_info().
Referenced by oomph::TreeBasedRefineableMeshBase::refine_uniformly().
|
pure virtual |
Refine mesh uniformly and doc process.
Implemented in oomph::RefineableTriangleMesh< ELEMENT >, oomph::RefineableTriangleMesh< ELASTICITY_ELEMENT >, oomph::RefineableTriangleMesh< ProjectableUnsteadyHeatElement< TUnsteadyHeatElement< 2, 3 > > >, oomph::RefineableTetgenMesh< ELEMENT >, oomph::RefineableQuadFromTriangleMesh< ELEMENT >, oomph::RefineableGmshTetMesh< ELEMENT >, oomph::TreeBasedRefineableMeshBase, and oomph::RefineableTetgenMesh< ELEMENT >.
|
inline |
Access to spatial error estimator.
References Spatial_error_estimator_pt.
Referenced by FSIRingProblem::FSIRingProblem(), oomph::METIS::partition_mesh(), RefineableFishPoissonProblem< ELEMENT >::RefineableFishPoissonProblem(), SolidProblem< ELEMENT_TYPE >::setupRefinementParameters(), SimpleRefineableFishPoissonProblem< ELEMENT >::SimpleRefineableFishPoissonProblem(), oomph::StreamfunctionProblem::StreamfunctionProblem(), and TurekProblem< FLUID_ELEMENT, SOLID_ELEMENT >::TurekProblem().
|
inline |
Access to spatial error estimator (const version.
References Spatial_error_estimator_pt.
|
pure virtual |
Unrefine mesh uniformly: Return 0 for success, 1 for failure (if unrefinement has reached the coarsest permitted level)
Implemented in oomph::RefineableTriangleMesh< ELEMENT >, oomph::RefineableTriangleMesh< ELASTICITY_ELEMENT >, oomph::RefineableTriangleMesh< ProjectableUnsteadyHeatElement< TUnsteadyHeatElement< 2, 3 > > >, oomph::RefineableTetgenMesh< ELEMENT >, oomph::RefineableGmshTetMesh< ELEMENT >, oomph::TreeBasedRefineableMeshBase, and oomph::RefineableTetgenMesh< ELEMENT >.
|
protected |
Flag that requests adaptation.
Referenced by adapt_flag(), disable_adaptation(), enable_adaptation(), is_adaptation_enabled(), and RefineableMeshBase().
|
protected |
Flag that disables additional synchronisation of hanging nodes.
Referenced by disable_additional_synchronisation_of_hanging_nodes(), enable_additional_synchronisation_of_hanging_nodes(), is_additional_synchronisation_of_hanging_nodes_disabled(), and RefineableMeshBase().
|
protected |
Pointer to DocInfo.
Referenced by doc_info(), doc_info_pt(), RefineableMeshBase(), and oomph::TreeBasedRefineableMeshBase::TreeBasedRefineableMeshBase().
|
protected |
Max. actual error.
Referenced by max_error(), and RefineableMeshBase().
|
protected |
Max. number of elements that can remain unrefined if no other mesh adaptation is required (to avoid mesh-adaptations that would only unrefine a few elements and then force a new solve – this can't be worth our while!)
Referenced by doc_adaptivity_targets(), oomph::TreeBasedRefineableMeshBase::doc_adaptivity_targets(), oomph::RefineableTetMeshBase::doc_adaptivity_targets(), max_keep_unrefined(), and RefineableMeshBase().
|
protected |
Max. error (i.e. split elements if their error is larger)
Referenced by doc_adaptivity_targets(), oomph::TreeBasedRefineableMeshBase::doc_adaptivity_targets(), oomph::RefineableTetMeshBase::doc_adaptivity_targets(), max_permitted_error(), and RefineableMeshBase().
|
protected |
Min.actual error.
Referenced by min_error(), and RefineableMeshBase().
|
protected |
Min. error (i.e. (try to) merge elements if their error is smaller)
Referenced by doc_adaptivity_targets(), oomph::TreeBasedRefineableMeshBase::doc_adaptivity_targets(), oomph::RefineableTetMeshBase::doc_adaptivity_targets(), min_permitted_error(), and RefineableMeshBase().
|
protected |
Stats: Number of elements that were refined.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), oomph::RefineableTetMeshBase::compute_volume_target(), nrefined(), oomph::TreeBasedRefineableMeshBase::p_adapt(), and oomph::TreeBasedRefineableMeshBase::TreeBasedRefineableMeshBase().
|
protected |
Number of elements that would like to be refined further but can't because they've reached the max. refinement level
Referenced by oomph::RefineableTetMeshBase::compute_volume_target(), nrefinement_overruled(), and RefineableMeshBase().
|
protected |
Stats: Number of elements that were unrefined.
Referenced by oomph::TreeBasedRefineableMeshBase::adapt(), oomph::RefineableTetMeshBase::compute_volume_target(), nunrefined(), oomph::TreeBasedRefineableMeshBase::p_adapt(), and oomph::TreeBasedRefineableMeshBase::TreeBasedRefineableMeshBase().
|
protected |
Flag that requests p-adaptation.
Referenced by disable_p_adaptation(), enable_p_adaptation(), is_p_adaptation_enabled(), and RefineableMeshBase().
|
protected |
Pointer to spatial error estimator.
Referenced by RefineableMeshBase(), and spatial_error_estimator_pt().