|
| | RefineableTriangleMesh (const std::string &node_file_name, const std::string &element_file_name, const std::string &poly_file_name, TimeStepper *time_stepper_pt=&Mesh::Default_TimeStepper, const bool &allow_automatic_creation_of_vertices_on_boundaries=true) |
| | Build mesh, based on the polyfiles. More...
|
| |
| | TriangleMesh () |
| | Empty constructor. More...
|
| |
| | TriangleMesh (const std::string &node_file_name, const std::string &element_file_name, const std::string &poly_file_name, TimeStepper *time_stepper_pt=&Mesh::Default_TimeStepper, const bool &allow_automatic_creation_of_vertices_on_boundaries=true) |
| | Constructor with the input files. More...
|
| |
| void | output_boundary_coordinates (const unsigned &b, std::ostream &outfile) |
| |
| | TriangleMeshBase () |
| | Constructor. More...
|
| |
| | TriangleMeshBase (const TriangleMeshBase &node)=delete |
| | Broken copy constructor. More...
|
| |
| virtual | ~TriangleMeshBase () |
| | Broken assignment operator. More...
|
| |
| void | setup_boundary_element_info () |
| |
| void | setup_boundary_element_info (std::ostream &outfile) |
| |
| virtual void | load_balance (const Vector< unsigned > &target_domain_for_local_non_halo_element) |
| | Virtual function to perform the load balance rutines. More...
|
| |
| 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...
|
| |
| | UnstructuredTwoDMeshGeometryBase () |
| | Empty constructor. More...
|
| |
| | UnstructuredTwoDMeshGeometryBase (const UnstructuredTwoDMeshGeometryBase &dummy)=delete |
| | Broken copy constructor. More...
|
| |
| void | operator= (const UnstructuredTwoDMeshGeometryBase &)=delete |
| | Broken assignment operator. More...
|
| |
| | ~UnstructuredTwoDMeshGeometryBase () |
| | Empty destructor. More...
|
| |
| unsigned | nregion () |
| | Return the number of regions specified by attributes. More...
|
| |
| unsigned | nregion_element (const unsigned &i) |
| | Return the number of elements in the i-th region. More...
|
| |
| FiniteElement * | region_element_pt (const unsigned &i, const unsigned &e) |
| | Return the e-th element in the i-th region. More...
|
| |
| unsigned | nregion_attribute () |
| | Return the number of attributes used in the mesh. More...
|
| |
| double | region_attribute (const unsigned &i) |
| | Return the attribute associated with region i. More...
|
| |
| GeomObject * | boundary_geom_object_pt (const unsigned &b) |
| |
| std::map< unsigned, GeomObject * > & | boundary_geom_object_pt () |
| | Return direct access to the geometric object storage. More...
|
| |
| std::map< unsigned, Vector< double > > & | boundary_coordinate_limits () |
| |
| Vector< double > & | boundary_coordinate_limits (const unsigned &b) |
| |
| unsigned | nboundary_element_in_region (const unsigned &b, const unsigned &r) const |
| | Return the number of elements adjacent to boundary b in region r. More...
|
| |
| FiniteElement * | boundary_element_in_region_pt (const unsigned &b, const unsigned &r, const unsigned &e) const |
| | Return pointer to the e-th element adjacent to boundary b in region r. More...
|
| |
| int | face_index_at_boundary_in_region (const unsigned &b, const unsigned &r, const unsigned &e) const |
| | Return face index of the e-th element adjacent to boundary b in region r. More...
|
| |
| TriangleMeshPolyLine * | boundary_polyline_pt (const unsigned &b) |
| |
| std::map< unsigned, std::set< Node * > > & | nodes_on_boundary_pt () |
| |
| const bool | get_connected_vertex_number_on_destination_polyline (TriangleMeshPolyLine *dst_polyline_pt, Vector< double > &vertex_coordinates, unsigned &vertex_number) |
| |
| void | check_contiguousness_on_polylines_helper (Vector< TriangleMeshPolyLine * > &polylines_pt, unsigned &index) |
| |
| void | check_contiguousness_on_polylines_helper (Vector< TriangleMeshPolyLine * > &polylines_pt, unsigned &index_halo_start, unsigned &index_halo_end) |
| |
| bool | is_point_inside_polygon_helper (Vector< Vector< double >> polygon_vertices, Vector< double > point) |
| | Helper function that checks if a given point is inside a polygon. More...
|
| |
| void | enable_automatic_creation_of_vertices_on_boundaries () |
| |
| void | disable_automatic_creation_of_vertices_on_boundaries () |
| |
| bool | is_automatic_creation_of_vertices_on_boundaries_allowed () |
| |
| template<class ELEMENT > |
| void | setup_boundary_coordinates (const unsigned &b) |
| |
| template<class ELEMENT > |
| void | setup_boundary_coordinates (const unsigned &b, std::ofstream &outfile) |
| |
| | Mesh () |
| | Default constructor. More...
|
| |
| | Mesh (const Vector< Mesh * > &sub_mesh_pt) |
| |
| void | merge_meshes (const Vector< Mesh * > &sub_mesh_pt) |
| |
| 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) |
| |
| 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...
|
| |
| 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 () |
| |
| 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 | p_adapt (const Vector< double > &elemental_error) |
| |
| 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...
|
| |
| void | p_unrefine_uniformly (DocInfo &doc_info) |
| | p-unrefine mesh uniformly More...
|
| |
|
| virtual | ~RefineableTriangleMesh () |
| | Empty Destructor. More...
|
| |
| void | enable_timings_tranfering_target_areas () |
| |
| void | disable_timings_tranfering_target_areas () |
| |
| void | enable_projection () |
| | Enables the solution projection step during adaptation. More...
|
| |
| void | disable_projection () |
| | Disables the solution projection step during adaptation. More...
|
| |
| void | enable_timings_projection () |
| | Enables info. and timings for projection. More...
|
| |
| void | disable_timings_projection () |
| | Disables info. and timings for projection. More...
|
| |
| unsigned & | nbin_x_for_area_transfer () |
| |
| unsigned & | nbin_y_for_area_transfer () |
| |
| unsigned | max_sample_points_for_limited_locate_zeta_during_target_area_transfer () |
| |
| double & | max_element_size () |
| | Max element size allowed during adaptation. More...
|
| |
| double & | min_element_size () |
| | Min element size allowed during adaptation. More...
|
| |
| double & | min_permitted_angle () |
| | Min angle before remesh gets triggered. More...
|
| |
| bool | use_iterative_solver_for_projection () |
| |
| void | enable_iterative_solver_for_projection () |
| |
| void | disable_iterative_solver_for_projection () |
| |
| void | enable_print_timings_adaptation (const unsigned &print_level=1) |
| | Enables printing of timings for adaptation. More...
|
| |
| void | disable_print_timings_adaptation () |
| | Disables printing of timings for adaptation. More...
|
| |
| void | set_print_level_timings_adaptation (const unsigned &print_level) |
| | Sets the printing level of timings for adaptation. More...
|
| |
| void | enable_print_timings_load_balance (const unsigned &print_level=1) |
| | Enables printing of timings for load balance. More...
|
| |
| void | disable_print_timings_load_balance () |
| | Disables printing of timings for load balance. More...
|
| |
| void | set_print_level_timings_load_balance (const unsigned &print_level) |
| | Sets the printing level of timings for load balance. More...
|
| |
| void | doc_adaptivity_targets (std::ostream &outfile) |
| | Doc the targets for mesh adaptation. More...
|
| |
| void | refine_uniformly (DocInfo &doc_info) |
| | Refine mesh uniformly and doc process. More...
|
| |
| unsigned | unrefine_uniformly () |
| |
| void | adapt (const Vector< double > &elem_error) |
| | Adapt mesh, based on elemental error provided. More...
|
| |
| MeshUpdateFctPt & | mesh_update_fct_pt () |
| |
| InternalHolePointUpdateFctPt & | internal_hole_point_update_fct_pt () |
| |
| void | create_polylines_from_polyfiles (const std::string &node_file_name, const std::string &poly_file_name) |
| | Helper function to create polylines and fill associate data. More...
|
| |
| void | update_polyline_representation_from_restart () |
| | Method used to update the polylines representation after restart. More...
|
| |
| void | get_boundary_segment_nodes_helper (const unsigned &b, Vector< Vector< Node * >> &tmp_segment_nodes) |
| |
| void | enable_boundary_unrefinement_constrained_by_target_areas () |
| |
| void | disable_boundary_unrefinement_constrained_by_target_areas () |
| |
| void | enable_boundary_refinement_constrained_by_target_areas () |
| |
| void | disable_boundary_refinement_constrained_by_target_areas () |
| |
| void | enable_shared_boundary_unrefinement_constrained_by_target_areas () |
| |
| void | disable_shared_boundary_unrefinement_constrained_by_target_areas () |
| |
| void | enable_shared_boundary_refinement_constrained_by_target_areas () |
| |
| void | disable_shared_boundary_refinement_constrained_by_target_areas () |
| |
| const bool | boundary_connections (const unsigned &b, const unsigned &c, std::set< Vector< double >> &vertices) |
| |
| const void | synchronize_shared_boundary_connections () |
| | Synchronise the vertices that are marked for non deletion. More...
|
| |
| void | add_vertices_for_non_deletion () |
| |
| void | add_non_delete_vertices_from_boundary_helper (Vector< Vector< Node * >> src_bound_segment_node_pt, Vector< Vector< Node * >> dst_bound_segment_node_pt, const unsigned &dst_bnd_id, const unsigned &dst_bnd_chunk) |
| |
| void | create_temporary_boundary_connections (Vector< TriangleMeshPolygon * > &tmp_outer_polygons_pt, Vector< TriangleMeshOpenCurve * > &tmp_open_curves_pt) |
| |
| void | restore_boundary_connections (Vector< TriangleMeshPolyLine * > &resume_initial_connection_polyline_pt, Vector< TriangleMeshPolyLine * > &resume_final_connection_polyline_pt) |
| |
| void | restore_polyline_connections_helper (TriangleMeshPolyLine *polyline_pt, Vector< TriangleMeshPolyLine * > &resume_initial_connection_polyline_pt, Vector< TriangleMeshPolyLine * > &resume_final_connection_polyline_pt) |
| |
| void | resume_boundary_connections (Vector< TriangleMeshPolyLine * > &resume_initial_connection_polyline_pt, Vector< TriangleMeshPolyLine * > &resume_final_connection_polyline_pt) |
| |
| bool | get_connected_vertex_number_on_dst_boundary (Vector< double > &vertex_coordinates, const unsigned &dst_b_id, unsigned &vertex_number) |
| |
| bool | unrefine_boundary (const unsigned &b, const unsigned &c, Vector< Vector< double >> &vector_bnd_vertices, double &unrefinement_tolerance, const bool &check_only=false) |
| | Helper function that performs the unrefinement process. More...
|
| |
| bool | refine_boundary (Mesh *face_mesh_pt, Vector< Vector< double >> &vector_bnd_vertices, double &refinement_tolerance, const bool &check_only=false) |
| |
| bool | apply_max_length_constraint (Mesh *face_mesh_pt, Vector< Vector< double >> &vector_bnd_vertices, double &max_length_constraint) |
| |
| bool | unrefine_boundary_constrained_by_target_area (const unsigned &b, const unsigned &c, Vector< Vector< double >> &vector_bnd_vertices, double &unrefinement_tolerance, Vector< double > &area_constraint) |
| |
| bool | refine_boundary_constrained_by_target_area (MeshAsGeomObject *mesh_geom_obj_pt, Vector< Vector< double >> &vector_bnd_vertices, double &refinement_tolerance, Vector< double > &area_constraint) |
| |
| bool | unrefine_shared_boundary_constrained_by_target_area (const unsigned &b, const unsigned &c, Vector< Vector< double >> &vector_bnd_vertices, Vector< double > &area_constraint) |
| |
| bool | refine_shared_boundary_constrained_by_target_area (Vector< Vector< double >> &vector_bnd_vertices, Vector< double > &area_constraint) |
| |
| void | initialise_boundary_refinement_data () |
| | Set all the flags to true (the default values) More...
|
| |
| bool | update_polygon_using_face_mesh (TriangleMeshPolygon *polygon_pt, const bool &check_only=false) |
| |
| bool | update_open_curve_using_face_mesh (TriangleMeshOpenCurve *open_polyline_pt, const bool &check_only=false) |
| |
| virtual bool | surface_remesh_for_inner_hole_boundaries (Vector< Vector< double >> &internal_point_coord, const bool &check_only=false) |
| |
| void | snap_nodes_onto_boundary (RefineableTriangleMesh< ELEMENT > *&new_mesh_pt, const unsigned &b) |
| | Snap the boundary nodes onto any curvilinear boundaries. More...
|
| |
| void | create_unsorted_face_mesh_representation (const unsigned &boundary_id, Mesh *face_mesh_pt) |
| |
| void | create_sorted_face_mesh_representation (const unsigned &boundary_id, Mesh *face_mesh_pt, std::map< FiniteElement *, bool > &is_inverted, bool &inverted_face_mesh) |
| |
| void | get_face_mesh_representation (TriangleMeshPolygon *polygon_pt, Vector< Mesh * > &face_mesh_pt) |
| |
| void | get_face_mesh_representation (TriangleMeshOpenCurve *open_polyline_pt, Vector< Mesh * > &face_mesh_pt) |
| |
| void | update_polygon_after_restart (TriangleMeshPolygon *&polygon_pt) |
| | Updates the polylines representation after restart. More...
|
| |
| void | update_open_curve_after_restart (TriangleMeshOpenCurve *&open_curve_pt) |
| | Updates the open curve representation after restart. More...
|
| |
| bool | update_polygon_using_elements_area (TriangleMeshPolygon *&polygon_pt, const Vector< double > &target_area) |
| |
| bool | update_open_curve_using_elements_area (TriangleMeshOpenCurve *&open_curve_pt, const Vector< double > &target_area) |
| |
| void | initialise_adaptation_data () |
| | Helper function to initialise data associated with adaptation. More...
|
| |
| double | compute_area_target (const Vector< double > &elem_error, Vector< double > &target_area) |
| |
| | TriangleMesh (const TriangleMesh &dummy)=delete |
| | Broken copy constructor. More...
|
| |
| void | operator= (const TriangleMesh &)=delete |
| | Broken assignment operator. More...
|
| |
| virtual | ~TriangleMesh () |
| | Destructor. More...
|
| |
| void | set_mesh_level_time_stepper (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data) |
| |
| Vector< unsigned > | oomph_vertex_nodes_id () |
| |
| void | build_from_scaffold (TimeStepper *time_stepper_pt, const bool &use_attributes) |
| | Build mesh from scaffold. More...
|
| |
| void | snap_nodes_onto_geometric_objects () |
| |
| void | copy_connection_information (TriangleMeshCurveSection *input_curve_pt, TriangleMeshCurveSection *output_curve_pt) |
| |
| void | copy_connection_information_to_sub_polylines (TriangleMeshCurveSection *input_curve_pt, TriangleMeshCurveSection *output_curve_pt) |
| |
| 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) |
| |
|
| std::map< unsigned, std::set< Vector< double > > > | Boundary_connections_pt |
| |
| bool | Do_boundary_unrefinement_constrained_by_target_areas |
| | Flag that enables or disables boundary unrefinement (true by default) More...
|
| |
| bool | Do_boundary_refinement_constrained_by_target_areas |
| | Flag that enables or disables boundary refinement (true by default) More...
|
| |
| bool | Do_shared_boundary_unrefinement_constrained_by_target_areas |
| | Flag that enables or disables boundary unrefinement (true by default) More...
|
| |
| bool | Do_shared_boundary_refinement_constrained_by_target_areas |
| | Flag that enables or disables boundary unrefinement (true by default) More...
|
| |
| unsigned | Nbin_x_for_area_transfer |
| |
| unsigned | Nbin_y_for_area_transfer |
| |
| unsigned | Max_sample_points_for_limited_locate_zeta_during_target_area_transfer |
| |
| double | Max_element_size |
| | Max permitted element size. More...
|
| |
| double | Min_element_size |
| | Min permitted element size. More...
|
| |
| double | Min_permitted_angle |
| | Min angle before remesh gets triggered. More...
|
| |
| bool | Disable_projection |
| | Enable/disable solution projection during adaptation. More...
|
| |
| bool | Use_iterative_solver_for_projection |
| |
| bool | Print_timings_transfering_target_areas |
| | Enable/disable printing timings for transfering target areas. More...
|
| |
| bool | Print_timings_projection |
| | Enable/disable printing timings for projection. More...
|
| |
| unsigned | Print_timings_level_adaptation |
| | The printing level for adaptation. More...
|
| |
| unsigned | Print_timings_level_load_balance |
| | The printing level for load balance. More...
|
| |
| MeshUpdateFctPt | Mesh_update_fct_pt |
| |
| InternalHolePointUpdateFctPt | Internal_hole_point_update_fct_pt |
| |
| TimeStepper * | Time_stepper_pt |
| | Timestepper used to build elements. More...
|
| |
| bool | Use_attributes |
| |
| std::map< unsigned, double > | Regions_areas |
| |
| TriangleScaffoldMesh * | Tmp_mesh_pt |
| | Temporary scaffold mesh. More...
|
| |
| Vector< unsigned > | Oomph_vertex_nodes_id |
| |
| bool | Allow_automatic_creation_of_vertices_on_boundaries |
| |
| std::map< unsigned, Vector< FiniteElement * > > | Region_element_pt |
| |
| Vector< double > | Region_attribute |
| | Vector of attributes associated with the elements in each region. More...
|
| |
| std::map< unsigned, GeomObject * > | Boundary_geom_object_pt |
| | Storage for the geometric objects associated with any boundaries. More...
|
| |
| std::map< unsigned, Vector< double > > | Boundary_coordinate_limits |
| |
| Vector< TriangleMeshPolygon * > | Outer_boundary_pt |
| | Polygon that defines outer boundaries. More...
|
| |
| Vector< TriangleMeshPolygon * > | Internal_polygon_pt |
| | Vector of polygons that define internal polygons. More...
|
| |
| Vector< TriangleMeshOpenCurve * > | Internal_open_curve_pt |
| | Vector of open polylines that define internal curves. More...
|
| |
| Vector< Vector< double > > | Extra_holes_coordinates |
| | Storage for extra coordinates for holes. More...
|
| |
| std::map< unsigned, Vector< double > > | Regions_coordinates |
| |
| std::map< unsigned, TriangleMeshCurveSection * > | Boundary_curve_section_pt |
| |
| Vector< std::map< unsigned, Vector< FiniteElement * > > > | Boundary_region_element_pt |
| | Storage for elements adjacent to a boundary in a particular region. More...
|
| |
| Vector< std::map< unsigned, Vector< int > > > | Face_index_region_at_boundary |
| | Storage for the face index adjacent to a boundary in a particular region. More...
|
| |
| std::map< unsigned, Vector< std::pair< double, double > > > | Polygonal_vertex_arclength_info |
| |
| std::map< unsigned, std::set< Node * > > | Nodes_on_boundary_pt |
| |
| std::set< TriangleMeshCurveSection * > | Free_curve_section_pt |
| |
| std::set< TriangleMeshPolygon * > | Free_polygon_pt |
| |
| std::set< TriangleMeshOpenCurve * > | Free_open_curve_pt |
| |
| 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 |
| |
| 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 |
| |