#include <nemesis_io_helper.h>
Public Types | |
enum | ExodusVarType { NODAL =0, ELEMENTAL =1, GLOBAL =2 } |
Public Member Functions | |
Nemesis_IO_Helper (const ParallelObject &parent, bool verbose=false, bool single_precision=false) | |
virtual | ~Nemesis_IO_Helper () |
void | get_init_global () |
void | get_ss_param_global () |
void | get_ns_param_global () |
void | get_eb_info_global () |
void | get_init_info () |
void | get_loadbal_param () |
void | get_elem_map () |
void | get_node_map () |
void | get_cmap_params () |
void | get_node_cmap () |
void | get_elem_cmap () |
void | put_init_info (unsigned num_proc, unsigned num_proc_in_file, const char *ftype) |
void | put_init_global (dof_id_type num_nodes_global, dof_id_type num_elems_global, unsigned num_elem_blks_global, unsigned num_node_sets_global, unsigned num_side_sets_global) |
void | put_eb_info_global (std::vector< int > &global_elem_blk_ids, std::vector< int > &global_elem_blk_cnts) |
void | put_ns_param_global (std::vector< int > &global_nodeset_ids, std::vector< int > &num_global_node_counts, std::vector< int > &num_global_node_df_counts) |
void | put_ss_param_global (std::vector< int > &global_sideset_ids, std::vector< int > &num_global_side_counts, std::vector< int > &num_global_side_df_counts) |
void | put_loadbal_param (unsigned num_internal_nodes, unsigned num_border_nodes, unsigned num_external_nodes, unsigned num_internal_elems, unsigned num_border_elems, unsigned num_node_cmaps, unsigned num_elem_cmaps) |
void | put_cmap_params (std::vector< int > &node_cmap_ids, std::vector< int > &node_cmap_node_cnts, std::vector< int > &elem_cmap_ids, std::vector< int > &elem_cmap_elem_cnts) |
void | put_node_cmap (std::vector< std::vector< int >> &node_cmap_node_ids, std::vector< std::vector< int >> &node_cmap_proc_ids) |
void | put_node_map (std::vector< int > &node_mapi, std::vector< int > &node_mapb, std::vector< int > &node_mape) |
void | put_elem_cmap (std::vector< std::vector< int >> &elem_cmap_elem_ids, std::vector< std::vector< int >> &elem_cmap_side_ids, std::vector< std::vector< int >> &elem_cmap_proc_ids) |
void | put_elem_map (std::vector< int > &elem_mapi, std::vector< int > &elem_mapb) |
void | put_n_coord (unsigned start_node_num, unsigned num_nodes, std::vector< Real > &x_coor, std::vector< Real > &y_coor, std::vector< Real > &z_coor) |
virtual void | write_nodal_coordinates (const MeshBase &mesh, bool use_discontinuous=false) override |
virtual void | write_elements (const MeshBase &mesh, bool use_discontinuous=false) override |
virtual void | write_sidesets (const MeshBase &mesh) override |
virtual void | write_nodesets (const MeshBase &mesh) override |
virtual void | create (std::string filename) override |
virtual void | initialize (std::string title, const MeshBase &mesh, bool use_discontinuous=false) override |
void | write_nodal_solution (const NumericVector< Number > ¶llel_soln, const std::vector< std::string > &names, int timestep, const std::vector< std::string > &output_names) |
void | write_nodal_solution (const std::vector< Number > &values, const std::vector< std::string > &names, int timestep) |
virtual void | initialize_element_variables (std::vector< std::string > names, const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) override |
void | write_element_values (const MeshBase &mesh, const NumericVector< Number > ¶llel_soln, const std::vector< std::string > &names, int timestep, const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) |
std::string | construct_nemesis_filename (const std::string &base_filename) |
const char * | get_elem_type () const |
void | open (const char *filename, bool read_only) |
void | read_header () |
void | read_qa_records () |
void | print_header () |
void | read_nodes () |
void | read_node_num_map () |
void | print_nodes (std::ostream &out=libMesh::out) |
void | read_block_info () |
int | get_block_id (int index) |
std::string | get_block_name (int index) |
int | get_side_set_id (int index) |
std::string | get_side_set_name (int index) |
int | get_node_set_id (int index) |
std::string | get_node_set_name (int index) |
void | read_elem_in_block (int block) |
void | read_elem_num_map () |
void | read_sideset_info () |
void | read_nodeset_info () |
void | read_sideset (int id, int offset) |
void | read_nodeset (int id) |
void | close () |
int | inquire (int req_info, std::string error_msg="") |
void | read_time_steps () |
void | read_num_time_steps () |
void | read_nodal_var_values (std::string nodal_var_name, int time_step) |
void | read_elemental_var_values (std::string elemental_var_name, int time_step, std::map< dof_id_type, Real > &elem_var_value_map) |
void | initialize_nodal_variables (std::vector< std::string > names) |
void | initialize_global_variables (std::vector< std::string > names) |
void | write_timestep (int timestep, Real time) |
void | write_element_values (const MeshBase &mesh, const std::vector< Real > &values, int timestep, const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) |
void | write_nodal_values (int var_id, const std::vector< Real > &values, int timestep) |
void | write_information_records (const std::vector< std::string > &records) |
void | write_global_values (const std::vector< Real > &values, int timestep) |
void | read_global_values (std::vector< Real > &values, int timestep) |
void | use_mesh_dimension_instead_of_spatial_dimension (bool val) |
void | write_as_dimension (unsigned dim) |
void | set_coordinate_offset (Point p) |
std::vector< std::string > | get_complex_names (const std::vector< std::string > &names) const |
std::vector< std::set< subdomain_id_type > > | get_complex_vars_active_subdomains (const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) const |
void | message (const std::string &msg) |
void | message (const std::string &msg, int i) |
void | read_var_names (ExodusVarType type) |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
Public Attributes | |
int | nemesis_err_flag |
int | num_nodes_global |
int | num_elems_global |
int | num_elem_blks_global |
int | num_node_sets_global |
int | num_side_sets_global |
int | num_proc |
int | num_proc_in_file |
char | ftype |
std::vector< int > | global_sideset_ids |
std::vector< int > | num_global_side_counts |
std::vector< int > | num_global_side_df_counts |
std::vector< int > | global_nodeset_ids |
std::vector< int > | num_global_node_counts |
std::vector< int > | num_global_node_df_counts |
std::vector< int > | global_elem_blk_ids |
std::vector< int > | global_elem_blk_cnts |
std::set< int > | nodes_attached_to_local_elems |
std::map< subdomain_id_type, std::vector< dof_id_type > > | subdomain_map |
std::map< int, std::vector< int > > | block_id_to_elem_connectivity |
int | num_internal_nodes |
int | num_border_nodes |
int | num_external_nodes |
int | num_internal_elems |
int | num_border_elems |
int | num_node_cmaps |
int | num_elem_cmaps |
std::vector< int > | elem_mapi |
std::vector< int > | elem_mapb |
std::vector< int > | node_mapi |
std::vector< int > | node_mapb |
std::vector< int > | node_mape |
std::vector< int > | node_cmap_ids |
std::vector< int > | node_cmap_node_cnts |
std::vector< int > | elem_cmap_ids |
std::vector< int > | elem_cmap_elem_cnts |
std::vector< std::vector< int > > | node_cmap_node_ids |
std::vector< std::vector< int > > | node_cmap_proc_ids |
std::vector< std::vector< int > > | elem_cmap_elem_ids |
std::vector< std::vector< int > > | elem_cmap_side_ids |
std::vector< std::vector< int > > | elem_cmap_proc_ids |
int | ex_id |
int | ex_err |
int | num_dim |
int | num_global_vars |
int | num_nodes |
int | num_elem |
int | num_elem_blk |
int | num_node_sets |
int | num_side_sets |
int | num_elem_this_blk |
int | num_nodes_per_elem |
int | num_attr |
int | num_elem_all_sidesets |
std::vector< int > | block_ids |
std::vector< int > | connect |
std::vector< int > | ss_ids |
std::vector< int > | nodeset_ids |
std::vector< int > | num_sides_per_set |
std::vector< int > | num_nodes_per_set |
std::vector< int > | num_df_per_set |
std::vector< int > | num_node_df_per_set |
std::vector< int > | elem_list |
std::vector< int > | side_list |
std::vector< int > | node_list |
std::vector< int > | id_list |
std::vector< int > | node_num_map |
std::vector< int > | elem_num_map |
std::vector< Real > | x |
std::vector< Real > | y |
std::vector< Real > | z |
std::vector< char > | title |
std::vector< char > | elem_type |
std::map< int, int > | libmesh_elem_num_to_exodus |
std::vector< int > | exodus_elem_num_to_libmesh |
std::map< int, int > | libmesh_node_num_to_exodus |
std::vector< int > | exodus_node_num_to_libmesh |
int | num_time_steps |
std::vector< Real > | time_steps |
int | num_nodal_vars |
std::vector< std::string > | nodal_var_names |
std::vector< Real > | nodal_var_values |
int | num_elem_vars |
std::vector< std::string > | elem_var_names |
std::vector< Real > | elem_var_values |
std::vector< std::string > | global_var_names |
std::map< int, std::string > | id_to_block_names |
std::map< int, std::string > | id_to_ss_names |
std::map< int, std::string > | id_to_ns_names |
bool | verbose |
bool | opened_for_writing |
bool | opened_for_reading |
std::string | current_filename |
Protected Member Functions | |
void | check_existing_vars (ExodusVarType type, std::vector< std::string > &names, std::vector< std::string > &names_from_file) |
void | write_var_names (ExodusVarType type, std::vector< std::string > &names) |
Protected Attributes | |
bool | _run_only_on_proc0 |
bool | _elem_vars_initialized |
bool | _global_vars_initialized |
bool | _nodal_vars_initialized |
bool | _use_mesh_dimension_instead_of_spatial_dimension |
unsigned | _write_as_dimension |
Point | _coordinate_offset |
bool | _single_precision |
const Parallel::Communicator & | _communicator |
Private Types | |
typedef std::map< unsigned, std::set< unsigned > >::iterator | proc_nodes_touched_iterator |
typedef std::map< unsigned, std::set< std::pair< unsigned, unsigned > > >::iterator | proc_border_elem_sets_iterator |
Private Member Functions | |
void | compute_num_global_elem_blocks (const MeshBase &pmesh) |
void | compute_num_global_nodesets (const MeshBase &pmesh) |
void | compute_num_global_sidesets (const MeshBase &pmesh) |
void | build_element_and_node_maps (const MeshBase &pmesh) |
void | compute_border_node_ids (const MeshBase &pmesh) |
void | compute_internal_and_border_elems_and_internal_nodes (const MeshBase &pmesh) |
void | compute_communication_map_parameters () |
void | compute_node_communication_maps () |
void | compute_node_maps () |
void | compute_elem_communication_maps () |
void | compute_element_maps () |
void | write_exodus_initialization_info (const MeshBase &pmesh, const std::string &title) |
Private Attributes | |
std::map< subdomain_id_type, unsigned > | local_subdomain_counts |
std::set< unsigned > | border_node_ids |
std::map< unsigned, std::set< unsigned > > | proc_nodes_touched_intersections |
std::map< unsigned, std::set< std::pair< unsigned, unsigned > > > | proc_border_elem_sets |
std::set< unsigned > | internal_node_ids |
std::set< unsigned > | internal_elem_ids |
std::set< unsigned > | border_elem_ids |
This is the Nemesis_IO_Helper
class. Think of it as a big struct with storage for all the stuff one might want to pull from a Nemesis file. Derived from ExodusII_IO_Helper object, since Nemesis is based on the same file format.
Definition at line 64 of file nemesis_io_helper.h.
|
private |
Typedef for an iterator into the data structure above.
Definition at line 594 of file nemesis_io_helper.h.
|
private |
Typedef for an iterator into the data structure above.
Definition at line 584 of file nemesis_io_helper.h.
|
inherited |
Wraps calls to exII::ex_get_var_names() and exII::ex_get_var_param(). The enumeration controls whether nodal, elemental, or global variable names are read and which class members are filled in. NODAL: num_nodal_vars nodal_var_names ELEMENTAL: num_elem_vars elem_var_names GLOBAL: num_global_vars global_var_names
Enumerator | |
---|---|
NODAL | |
ELEMENTAL | |
GLOBAL |
Definition at line 601 of file exodusII_io_helper.h.
|
explicit |
Constructor.
Definition at line 45 of file nemesis_io_helper.C.
|
virtual |
Destructor.
Definition at line 70 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_update(), and libMesh::ExodusII_IO_Helper::opened_for_writing.
|
private |
This function builds the libmesh -> exodus and exodus -> libmesh node and element maps. These maps allow us to have a consistent numbering scheme within an Exodus file, given an existing globally consistent numbering scheme from LibMesh.
Definition at line 1695 of file nemesis_io_helper.C.
References libMesh::MeshBase::active_local_element_ptr_range(), libMesh::MeshBase::active_local_elements_begin(), libMesh::MeshBase::active_local_elements_end(), libMesh::ExodusII_IO_Helper::ElementMaps::assign_conversion(), block_id_to_elem_connectivity, libMesh::ExodusII_IO_Helper::block_ids, libMesh::Elem::build(), libMesh::MeshBase::elem_ref(), libMesh::ExodusII_IO_Helper::exodus_elem_num_to_libmesh, libMesh::ExodusII_IO_Helper::exodus_node_num_to_libmesh, libMesh::ExodusII_IO_Helper::Conversion::get_canonical_type(), libMesh::ExodusII_IO_Helper::Conversion::get_node_map(), libMesh::index_range(), libMesh::ExodusII_IO_Helper::libmesh_elem_num_to_exodus, libMesh::ExodusII_IO_Helper::libmesh_node_num_to_exodus, local_subdomain_counts, n_nodes, libMesh::Elem::n_nodes(), nodes_attached_to_local_elems, libMesh::ExodusII_IO_Helper::num_nodes, libMesh::ExodusII_IO_Helper::num_nodes_per_elem, libMesh::out, libMesh::ParallelObject::processor_id(), subdomain_map, libMesh::Elem::type(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
protectedinherited |
When appending: during initialization, check that variable names in the file match those you attempt to initialize with.
Definition at line 1814 of file exodusII_io_helper.C.
References libMesh::err, libMesh::Quality::name(), libMesh::out, and libMesh::ExodusII_IO_Helper::read_var_names().
Referenced by libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::initialize_global_variables(), and libMesh::ExodusII_IO_Helper::initialize_nodal_variables().
|
inherited |
Closes the ExodusII
mesh file.
Definition at line 795 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, ex_close(), libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::opened_for_reading, libMesh::ExodusII_IO_Helper::opened_for_writing, and libMesh::ParallelObject::processor_id().
Referenced by ~Nemesis_IO_Helper().
|
inlineinherited |
Parallel::Communicator
object used by this mesh. Definition at line 89 of file parallel_object.h.
References libMesh::ParallelObject::_communicator.
Referenced by libMesh::__libmesh_petsc_diff_solver_jacobian(), libMesh::__libmesh_petsc_diff_solver_monitor(), libMesh::__libmesh_petsc_diff_solver_residual(), libMesh::__libmesh_tao_equality_constraints(), libMesh::__libmesh_tao_equality_constraints_jacobian(), libMesh::__libmesh_tao_gradient(), libMesh::__libmesh_tao_hessian(), libMesh::__libmesh_tao_inequality_constraints(), libMesh::__libmesh_tao_inequality_constraints_jacobian(), libMesh::__libmesh_tao_objective(), libMesh::MeshRefinement::_coarsen_elements(), libMesh::ExactSolution::_compute_error(), libMesh::UniformRefinementEstimator::_estimate_error(), libMesh::BoundaryInfo::_find_id_maps(), libMesh::SlepcEigenSolver< T >::_petsc_shell_matrix_get_diagonal(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_get_diagonal(), libMesh::SlepcEigenSolver< T >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_mult_add(), libMesh::EquationSystems::_read_impl(), libMesh::MeshRefinement::_refine_elements(), libMesh::MeshRefinement::_smooth_flags(), libMesh::PetscDMWrapper::add_dofs_helper(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::ImplicitSystem::add_matrix(), libMesh::System::add_vector(), libMesh::UnstructuredMesh::all_second_order(), libMesh::MeshTools::Modification::all_tri(), libMesh::LaplaceMeshSmoother::allgather_graph(), libMesh::FEMSystem::assemble_qoi(), libMesh::MeshCommunication::assign_global_indices(), libMesh::DofMap::attach_matrix(), libMesh::MeshTools::Generation::build_extrusion(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::PetscDMWrapper::build_section(), libMesh::PetscDMWrapper::build_sf(), libMesh::MeshBase::cache_elem_dims(), libMesh::System::calculate_norm(), libMesh::DofMap::check_dirichlet_bcid_consistency(), libMesh::PetscDMWrapper::check_section_n_dofs(), compute_num_global_elem_blocks(), compute_num_global_nodesets(), compute_num_global_sidesets(), libMesh::Problem_Interface::computeF(), libMesh::Problem_Interface::computeJacobian(), libMesh::Problem_Interface::computePreconditioner(), libMesh::ExodusII_IO::copy_elemental_solution(), libMesh::MeshTools::correct_node_proc_ids(), libMesh::MeshTools::create_bounding_box(), libMesh::MeshTools::create_nodal_bounding_box(), libMesh::MeshRefinement::create_parent_error_vector(), libMesh::MeshTools::create_processor_bounding_box(), libMesh::MeshTools::create_subdomain_bounding_box(), libMesh::MeshCommunication::delete_remote_elements(), libMesh::DofMap::distribute_dofs(), DMlibMeshFunction(), DMlibMeshJacobian(), DMlibMeshSetSystem_libMesh(), DMVariableBounds_libMesh(), libMesh::MeshRefinement::eliminate_unrefined_patches(), libMesh::EpetraVector< T >::EpetraVector(), libMesh::WeightedPatchRecoveryErrorEstimator::estimate_error(), libMesh::PatchRecoveryErrorEstimator::estimate_error(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::AdjointRefinementEstimator::estimate_error(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::MeshRefinement::flag_elements_by_elem_fraction(), libMesh::MeshRefinement::flag_elements_by_error_fraction(), libMesh::MeshRefinement::flag_elements_by_nelem_target(), libMesh::CondensedEigenSystem::get_eigenpair(), libMesh::DofMap::get_info(), libMesh::ImplicitSystem::get_linear_solver(), libMesh::LocationMap< T >::init(), libMesh::TimeSolver::init(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), libMesh::EigenSystem::init_data(), libMesh::EigenSystem::init_matrices(), libMesh::OptimizationSystem::initialize_equality_constraints_storage(), libMesh::OptimizationSystem::initialize_inequality_constraints_storage(), libMesh::MeshTools::libmesh_assert_consistent_distributed(), libMesh::MeshTools::libmesh_assert_consistent_distributed_nodes(), libMesh::MeshTools::libmesh_assert_contiguous_dof_ids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_new_node_procids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Elem >(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_topology_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_valid_boundary_ids(), libMesh::MeshTools::libmesh_assert_valid_dof_ids(), libMesh::MeshTools::libmesh_assert_valid_neighbors(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_flags(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_object_ids(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_p_levels(), libMesh::MeshTools::libmesh_assert_valid_refinement_flags(), libMesh::MeshTools::libmesh_assert_valid_unique_ids(), libMesh::libmesh_petsc_snes_fd_residual(), libMesh::libmesh_petsc_snes_jacobian(), libMesh::libmesh_petsc_snes_mffd_residual(), libMesh::libmesh_petsc_snes_postcheck(), libMesh::libmesh_petsc_snes_residual(), libMesh::libmesh_petsc_snes_residual_helper(), libMesh::MeshRefinement::limit_level_mismatch_at_edge(), libMesh::MeshRefinement::limit_level_mismatch_at_node(), libMesh::MeshRefinement::limit_overrefined_boundary(), libMesh::MeshRefinement::limit_underrefined_boundary(), libMesh::MeshRefinement::make_coarsening_compatible(), libMesh::MeshCommunication::make_elems_parallel_consistent(), libMesh::MeshRefinement::make_flags_parallel_consistent(), libMesh::MeshCommunication::make_new_node_proc_ids_parallel_consistent(), libMesh::MeshCommunication::make_new_nodes_parallel_consistent(), libMesh::MeshCommunication::make_node_ids_parallel_consistent(), libMesh::MeshCommunication::make_node_proc_ids_parallel_consistent(), libMesh::MeshCommunication::make_node_unique_ids_parallel_consistent(), libMesh::MeshCommunication::make_nodes_parallel_consistent(), libMesh::MeshCommunication::make_p_levels_parallel_consistent(), libMesh::MeshRefinement::make_refinement_compatible(), libMesh::FEMSystem::mesh_position_set(), libMesh::DistributedMesh::n_active_elem(), libMesh::MeshTools::n_active_levels(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::CondensedEigenSystem::n_global_non_condensed_dofs(), libMesh::MeshTools::n_levels(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::MeshTools::n_p_levels(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::DistributedMesh::parallel_max_elem_id(), libMesh::DistributedMesh::parallel_max_node_id(), libMesh::ReplicatedMesh::parallel_max_unique_id(), libMesh::DistributedMesh::parallel_max_unique_id(), libMesh::DistributedMesh::parallel_n_elem(), libMesh::DistributedMesh::parallel_n_nodes(), libMesh::SparsityPattern::Build::parallel_sync(), libMesh::MeshTools::paranoid_n_levels(), libMesh::petsc_auto_fieldsplit(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::MeshBase::prepare_for_use(), libMesh::Nemesis_IO::read(), libMesh::XdrIO::read(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), libMesh::System::read_legacy_data(), libMesh::System::read_SCALAR_dofs(), libMesh::XdrIO::read_serialized_bc_names(), libMesh::XdrIO::read_serialized_bcs_helper(), libMesh::System::read_serialized_blocked_dof_objects(), libMesh::XdrIO::read_serialized_connectivity(), libMesh::XdrIO::read_serialized_nodes(), libMesh::XdrIO::read_serialized_nodesets(), libMesh::XdrIO::read_serialized_subdomain_names(), libMesh::System::read_serialized_vector(), libMesh::MeshBase::recalculate_n_partitions(), libMesh::MeshRefinement::refine_and_coarsen_elements(), libMesh::DistributedMesh::renumber_dof_objects(), libMesh::CheckpointIO::select_split_config(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::PetscDiffSolver::setup_petsc_data(), libMesh::LaplaceMeshSmoother::smooth(), libMesh::split_mesh(), libMesh::MeshBase::subdomain_ids(), libMesh::BoundaryInfo::sync(), libMesh::MeshRefinement::test_level_one(), libMesh::MeshRefinement::test_unflagged(), libMesh::MeshTools::total_weight(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::NameBasedIO::write(), libMesh::XdrIO::write(), libMesh::System::write_SCALAR_dofs(), libMesh::XdrIO::write_serialized_bcs_helper(), libMesh::System::write_serialized_blocked_dof_objects(), libMesh::XdrIO::write_serialized_connectivity(), libMesh::XdrIO::write_serialized_nodes(), and libMesh::XdrIO::write_serialized_nodesets().
|
private |
This function constructs the set of border node IDs present on the current mesh. These are nodes which live on the "border" between elements which live on different processors.
Definition at line 1846 of file nemesis_io_helper.C.
References libMesh::MeshBase::active_element_ptr_range(), border_node_ids, libMesh::ParallelObject::n_processors(), num_border_nodes, num_node_cmaps, libMesh::out, proc_nodes_touched_intersections, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
This function determines the communication map parameters which will eventually be written to file
Definition at line 1171 of file nemesis_io_helper.C.
References elem_cmap_elem_cnts, elem_cmap_ids, end, node_cmap_ids, node_cmap_node_cnts, num_elem_cmaps, num_node_cmaps, libMesh::out, proc_border_elem_sets, proc_nodes_touched_intersections, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
This function computes element communication maps (really just packs vectors) in preparation for writing them to file.
Definition at line 1002 of file nemesis_io_helper.C.
References elem_cmap_elem_ids, elem_cmap_ids, elem_cmap_proc_ids, elem_cmap_side_ids, end, libMesh::ExodusII_IO_Helper::libmesh_elem_num_to_exodus, num_elem_cmaps, and proc_border_elem_sets.
Referenced by initialize().
|
private |
This function computes element maps (really just packs vectors) which map the elements to internal and border elements.
Definition at line 967 of file nemesis_io_helper.C.
References border_elem_ids, elem_mapb, elem_mapi, internal_elem_ids, and libMesh::ExodusII_IO_Helper::libmesh_elem_num_to_exodus.
Referenced by initialize().
|
private |
This function constructs the set of border and internal element IDs and internal node IDs present on the current mesh.
Definition at line 1249 of file nemesis_io_helper.C.
References libMesh::MeshBase::active_local_element_ptr_range(), libMesh::ExodusII_IO_Helper::ElementMaps::assign_conversion(), border_elem_ids, border_node_ids, libMesh::ExodusII_IO_Helper::Conversion::get_inverse_side_map(), internal_elem_ids, internal_node_ids, nodes_attached_to_local_elems, num_border_elems, num_border_nodes, num_elem_cmaps, num_internal_elems, num_internal_nodes, libMesh::out, proc_border_elem_sets, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
Compute the node communication maps (really just pack vectors) in preparation for writing them to file.
Definition at line 1096 of file nemesis_io_helper.C.
References end, libMesh::ExodusII_IO_Helper::libmesh_node_num_to_exodus, node_cmap_ids, node_cmap_node_ids, node_cmap_proc_ids, node_set, num_node_cmaps, libMesh::out, proc_nodes_touched_intersections, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
Compute the node maps (really just pack vectors) which map the nodes to internal, border, and external nodes in the file.
Definition at line 1057 of file nemesis_io_helper.C.
References border_node_ids, internal_node_ids, libMesh::ExodusII_IO_Helper::libmesh_node_num_to_exodus, node_mapb, node_mape, and node_mapi.
Referenced by initialize().
|
private |
This function uses global communication routines to determine the number of element blocks across the entire mesh.
Definition at line 1595 of file nemesis_io_helper.C.
References libMesh::MeshBase::active_local_element_ptr_range(), libMesh::Parallel::Communicator::allgather(), libMesh::ParallelObject::comm(), global_elem_blk_cnts, global_elem_blk_ids, local_subdomain_counts, num_elem_blks_global, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::Parallel::Communicator::sum(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
This function uses global communication routines to determine the number of nodesets across the entire mesh.
Definition at line 1484 of file nemesis_io_helper.C.
References libMesh::BoundaryInfo::build_node_list(), libMesh::ParallelObject::comm(), libMesh::MeshBase::get_boundary_info(), libMesh::BoundaryInfo::get_node_boundary_ids(), global_nodeset_ids, libMesh::MeshBase::node_ptr(), num_global_node_counts, num_node_sets_global, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::DofObject::processor_id(), libMesh::Parallel::Communicator::set_union(), libMesh::Parallel::Communicator::sum(), swap(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
|
private |
This function uses global communication routines to determine the number of sidesets across the entire mesh.
Definition at line 1391 of file nemesis_io_helper.C.
References libMesh::BoundaryInfo::build_side_list(), libMesh::ParallelObject::comm(), libMesh::MeshBase::elem_ref(), libMesh::MeshBase::get_boundary_info(), libMesh::BoundaryInfo::get_side_boundary_ids(), global_sideset_ids, num_global_side_counts, num_side_sets_global, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::DofObject::processor_id(), libMesh::Parallel::Communicator::set_union(), libMesh::Parallel::Communicator::sum(), swap(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
std::string libMesh::Nemesis_IO_Helper::construct_nemesis_filename | ( | const std::string & | base_filename | ) |
Given base_filename, foo.e, constructs the Nemesis filename foo.e.X.Y, where X=n. CPUs and Y=processor ID
Definition at line 2648 of file nemesis_io_helper.C.
References libMesh::ParallelObject::n_processors(), libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
overridevirtual |
This function is specialized from ExodusII_IO_Helper to create the nodal coordinates stored on the local piece of the Mesh.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 727 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::ex_id, std::min(), libMesh::ExodusII_IO_Helper::opened_for_writing, libMesh::out, libMesh::Real, and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Get the block number for the given block index.
Definition at line 544 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::block_ids.
Referenced by libMesh::ExodusII_IO_Helper::write_element_values().
|
inherited |
Get the block name for the given block index if supplied in the mesh file. Otherwise an empty string is returned.
Definition at line 553 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::block_ids, and libMesh::ExodusII_IO_Helper::id_to_block_names.
void libMesh::Nemesis_IO_Helper::get_cmap_params | ( | ) |
Definition at line 322 of file nemesis_io_helper.C.
References elem_cmap_elem_cnts, elem_cmap_ids, libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, node_cmap_ids, node_cmap_node_cnts, num_elem_cmaps, num_node_cmaps, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Definition at line 2064 of file exodusII_io_helper.C.
|
inherited |
returns a "tripled" copy of vars_active_subdomains
, which is necessary in the complex-valued case.
Definition at line 2090 of file exodusII_io_helper.C.
void libMesh::Nemesis_IO_Helper::get_eb_info_global | ( | ) |
Definition at line 176 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, global_elem_blk_cnts, global_elem_blk_ids, nemesis_err_flag, num_elem_blks_global, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_elem_cmap | ( | ) |
Definition at line 407 of file nemesis_io_helper.C.
References data, elem_cmap_elem_cnts, elem_cmap_elem_ids, elem_cmap_ids, elem_cmap_proc_ids, elem_cmap_side_ids, libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, num_elem_cmaps, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_elem_map | ( | ) |
Definition at line 254 of file nemesis_io_helper.C.
References elem_mapb, elem_mapi, libMesh::ExodusII_IO_Helper::ex_id, std::min(), nemesis_err_flag, num_border_elems, num_internal_elems, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
HEX27
. Definition at line 314 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::elem_type.
void libMesh::Nemesis_IO_Helper::get_init_global | ( | ) |
Reading functions. These just allocate memory for you and call the Nemesis routines of the same name. They also handle error checking for the Nemesis return value. Be careful calling these at random, some depend on others being called first... Fills: num_nodes_global, num_elems_global, num_elem_blks_global, num_node_sets_global, num_side_sets_global Call after: read_header() Call before: Any other get_* function from this class
Definition at line 85 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, num_elem_blks_global, num_elems_global, num_node_sets_global, num_nodes_global, num_side_sets_global, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_init_info | ( | ) |
Definition at line 205 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, ftype, nemesis_err_flag, num_proc, num_proc_in_file, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_loadbal_param | ( | ) |
Definition at line 224 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, num_border_elems, num_border_nodes, num_elem_cmaps, num_external_nodes, num_internal_elems, num_internal_nodes, num_node_cmaps, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_node_cmap | ( | ) |
Definition at line 365 of file nemesis_io_helper.C.
References data, libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, node_cmap_ids, node_cmap_node_cnts, node_cmap_node_ids, node_cmap_proc_ids, num_node_cmaps, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
void libMesh::Nemesis_IO_Helper::get_node_map | ( | ) |
Definition at line 285 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, node_mapb, node_mape, node_mapi, num_border_nodes, num_external_nodes, num_internal_nodes, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Get the node set id for the given node set index.
Definition at line 580 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::nodeset_ids.
|
inherited |
Get the node set name for the given node set index if supplied in the mesh file. Otherwise an empty string is returned.
Definition at line 589 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::id_to_ns_names, and libMesh::ExodusII_IO_Helper::nodeset_ids.
void libMesh::Nemesis_IO_Helper::get_ns_param_global | ( | ) |
Definition at line 144 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, global_nodeset_ids, nemesis_err_flag, num_global_node_counts, num_global_node_df_counts, num_node_sets_global, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Get the side set id for the given side set index.
Definition at line 562 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ss_ids.
|
inherited |
Get the side set name for the given side set index if supplied in the mesh file. Otherwise an empty string is returned.
Definition at line 571 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::id_to_ss_names, and libMesh::ExodusII_IO_Helper::ss_ids.
void libMesh::Nemesis_IO_Helper::get_ss_param_global | ( | ) |
Fills: global_sideset_ids, num_global_side_counts, num_global_side_df_counts Call after: get_init_global()
Definition at line 108 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, global_sideset_ids, nemesis_err_flag, num_global_side_counts, num_global_side_df_counts, num_side_sets_global, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
overridevirtual |
Specialization of the initialize function from ExodusII_IO_Helper that also writes global initial data to file.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 763 of file nemesis_io_helper.C.
References build_element_and_node_maps(), compute_border_node_ids(), compute_communication_map_parameters(), compute_elem_communication_maps(), compute_element_maps(), compute_internal_and_border_elems_and_internal_nodes(), compute_node_communication_maps(), compute_node_maps(), compute_num_global_elem_blocks(), compute_num_global_nodesets(), compute_num_global_sidesets(), elem_cmap_elem_cnts, elem_cmap_elem_ids, elem_cmap_ids, elem_cmap_proc_ids, elem_cmap_side_ids, elem_mapb, elem_mapi, global_elem_blk_cnts, global_elem_blk_ids, global_nodeset_ids, global_sideset_ids, mesh, libMesh::ParallelObject::n_processors(), node_cmap_ids, node_cmap_node_cnts, node_cmap_node_ids, node_cmap_proc_ids, node_mapb, node_mape, node_mapi, num_border_elems, num_border_nodes, num_elem_blks_global, num_elem_cmaps, num_external_nodes, num_global_node_counts, num_global_node_df_counts, num_global_side_counts, num_global_side_df_counts, num_internal_elems, num_internal_nodes, num_node_cmaps, num_node_sets_global, num_side_sets_global, libMesh::MeshBase::parallel_n_elem(), libMesh::MeshBase::parallel_n_nodes(), put_cmap_params(), put_eb_info_global(), put_elem_cmap(), put_elem_map(), put_init_global(), put_init_info(), put_loadbal_param(), put_node_cmap(), put_node_map(), put_ns_param_global(), put_ss_param_global(), and write_exodus_initialization_info().
|
overridevirtual |
Override the Exodus Helper's implementation of this function so that it works correctly in parallel.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 2531 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::_elem_vars_initialized, libMesh::ExodusII_IO_Helper::check_existing_vars(), libMesh::ExodusII_IO_Helper::elem_var_names, libMesh::ExodusII_IO_Helper::ELEMENTAL, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_elem_var_tab(), global_elem_blk_ids, libMesh::ExodusII_IO_Helper::num_elem_vars, and libMesh::ExodusII_IO_Helper::write_var_names().
|
inherited |
Sets up the global variables
Definition at line 1788 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_global_vars_initialized, libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::check_existing_vars(), libMesh::ExodusII_IO_Helper::GLOBAL, libMesh::ExodusII_IO_Helper::global_var_names, libMesh::ExodusII_IO_Helper::num_global_vars, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::write_var_names().
|
inherited |
Sets up the nodal variables
Definition at line 1760 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_nodal_vars_initialized, libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::check_existing_vars(), libMesh::ExodusII_IO_Helper::NODAL, libMesh::ExodusII_IO_Helper::nodal_var_names, libMesh::ExodusII_IO_Helper::num_nodal_vars, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::write_var_names().
|
inherited |
Definition at line 814 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, and ex_inquire().
Referenced by libMesh::ExodusII_IO_Helper::read_num_time_steps(), libMesh::ExodusII_IO_Helper::read_qa_records(), libMesh::ExodusII_IO_Helper::read_sideset_info(), and libMesh::ExodusII_IO_Helper::write_information_records().
|
inherited |
Prints the message defined in msg
. Can be turned off if verbosity is set to 0.
Definition at line 321 of file exodusII_io_helper.C.
References libMesh::out, and libMesh::ExodusII_IO_Helper::verbose.
Referenced by libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::read_block_info(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::ExodusII_IO_Helper::read_nodes(), libMesh::ExodusII_IO_Helper::read_nodeset(), libMesh::ExodusII_IO_Helper::read_nodeset_info(), libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Prints the message defined in msg
, and appends the number i
to the end of the message. Useful for printing messages in loops. Can be turned off if verbosity is set to 0.
Definition at line 328 of file exodusII_io_helper.C.
References libMesh::out, and libMesh::ExodusII_IO_Helper::verbose.
|
inlineinherited |
Definition at line 95 of file parallel_object.h.
References libMesh::ParallelObject::_communicator, and libMesh::Parallel::Communicator::size().
Referenced by libMesh::BoundaryInfo::_find_id_maps(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::DistributedMesh::add_elem(), libMesh::DistributedMesh::add_node(), libMesh::LaplaceMeshSmoother::allgather_graph(), libMesh::FEMSystem::assembly(), libMesh::AztecLinearSolver< T >::AztecLinearSolver(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::DistributedMesh::clear(), compute_border_node_ids(), construct_nemesis_filename(), libMesh::UnstructuredMesh::create_pid_mesh(), libMesh::MeshTools::create_processor_bounding_box(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::EnsightIO::EnsightIO(), libMesh::MeshBase::get_info(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), initialize(), libMesh::DistributedMesh::insert_elem(), libMesh::MeshTools::libmesh_assert_contiguous_dof_ids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_new_node_procids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Elem >(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_topology_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_valid_boundary_ids(), libMesh::MeshTools::libmesh_assert_valid_dof_ids(), libMesh::MeshTools::libmesh_assert_valid_neighbors(), libMesh::MeshTools::libmesh_assert_valid_refinement_flags(), libMesh::DofMap::local_variable_indices(), libMesh::MeshRefinement::make_coarsening_compatible(), libMesh::MeshBase::n_active_elem_on_proc(), libMesh::MeshBase::n_elem_on_proc(), libMesh::MeshBase::n_nodes_on_proc(), libMesh::MeshBase::partition(), libMesh::PetscLinearSolver< T >::PetscLinearSolver(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::NameBasedIO::read(), libMesh::Nemesis_IO::read(), libMesh::CheckpointIO::read(), libMesh::CheckpointIO::read_connectivity(), libMesh::XdrIO::read_header(), libMesh::CheckpointIO::read_nodes(), libMesh::System::read_parallel_data(), libMesh::System::read_SCALAR_dofs(), libMesh::System::read_serialized_blocked_dof_objects(), libMesh::System::read_serialized_vector(), libMesh::DistributedMesh::renumber_dof_objects(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::GMVIO::write_binary(), libMesh::GMVIO::write_discontinuous_gmv(), libMesh::System::write_parallel_data(), libMesh::System::write_SCALAR_dofs(), libMesh::XdrIO::write_serialized_bcs_helper(), libMesh::System::write_serialized_blocked_dof_objects(), libMesh::XdrIO::write_serialized_connectivity(), libMesh::XdrIO::write_serialized_nodes(), and libMesh::XdrIO::write_serialized_nodesets().
|
inherited |
Opens an ExodusII
mesh file named filename
. If read_only==true, the file will be opened with the EX_READ flag, otherwise it will be opened with the EX_WRITE flag.
Definition at line 335 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::current_filename, libMesh::ExodusII_IO_Helper::ex_id, std::min(), libMesh::ExodusII_IO_Helper::opened_for_reading, libMesh::ExodusII_IO_Helper::opened_for_writing, libMesh::out, libMesh::Real, and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Prints the ExodusII
mesh file header, which includes the mesh title, the number of nodes, number of elements, mesh dimension, number of sidesets, and number of nodesets.
Definition at line 455 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::num_dim, libMesh::ExodusII_IO_Helper::num_elem, libMesh::ExodusII_IO_Helper::num_elem_blk, libMesh::ExodusII_IO_Helper::num_node_sets, libMesh::ExodusII_IO_Helper::num_nodes, libMesh::ExodusII_IO_Helper::num_side_sets, libMesh::out, libMesh::ExodusII_IO_Helper::title, and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Prints the nodal information, by default to libMesh::out
.
Definition at line 509 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::num_nodes, libMesh::ExodusII_IO_Helper::x, libMesh::ExodusII_IO_Helper::y, and libMesh::ExodusII_IO_Helper::z.
|
inlineinherited |
Definition at line 101 of file parallel_object.h.
References libMesh::ParallelObject::_communicator, and libMesh::Parallel::Communicator::rank().
Referenced by libMesh::BoundaryInfo::_find_id_maps(), libMesh::EquationSystems::_read_impl(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::DistributedMesh::add_elem(), libMesh::BoundaryInfo::add_elements(), libMesh::DofMap::add_neighbors_to_send_list(), libMesh::DistributedMesh::add_node(), libMesh::UnstructuredMesh::all_second_order(), libMesh::MeshTools::Modification::all_tri(), libMesh::FEMSystem::assembly(), libMesh::EquationSystems::build_discontinuous_solution_vector(), build_element_and_node_maps(), libMesh::InfElemBuilder::build_inf_elem(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::DistributedMesh::clear(), libMesh::ExodusII_IO_Helper::close(), compute_border_node_ids(), compute_communication_map_parameters(), compute_internal_and_border_elems_and_internal_nodes(), compute_node_communication_maps(), compute_num_global_elem_blocks(), compute_num_global_nodesets(), compute_num_global_sidesets(), construct_nemesis_filename(), libMesh::MeshTools::correct_node_proc_ids(), libMesh::ExodusII_IO_Helper::create(), libMesh::DistributedMesh::delete_elem(), libMesh::DistributedMesh::delete_node(), libMesh::MeshCommunication::delete_remote_elements(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::DistributedMesh::DistributedMesh(), libMesh::DofMap::end_dof(), libMesh::DofMap::end_old_dof(), libMesh::EnsightIO::EnsightIO(), libMesh::MeshFunction::find_element(), libMesh::MeshFunction::find_elements(), libMesh::UnstructuredMesh::find_neighbors(), libMesh::DofMap::first_dof(), libMesh::DofMap::first_old_dof(), get_cmap_params(), get_eb_info_global(), get_elem_cmap(), get_elem_map(), libMesh::MeshBase::get_info(), libMesh::DofMap::get_info(), get_init_global(), get_init_info(), get_loadbal_param(), get_node_cmap(), get_node_map(), get_ns_param_global(), get_ss_param_global(), libMesh::SparsityPattern::Build::handle_vi_vj(), libMesh::SystemSubsetBySubdomain::init(), libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), libMesh::ExodusII_IO_Helper::initialize_global_variables(), libMesh::ExodusII_IO_Helper::initialize_nodal_variables(), libMesh::DistributedMesh::insert_elem(), libMesh::DofMap::is_evaluable(), libMesh::SparsityPattern::Build::join(), libMesh::DofMap::last_dof(), libMesh::MeshTools::libmesh_assert_consistent_distributed(), libMesh::MeshTools::libmesh_assert_consistent_distributed_nodes(), libMesh::MeshTools::libmesh_assert_contiguous_dof_ids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Elem >(), libMesh::MeshTools::libmesh_assert_valid_neighbors(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_object_ids(), libMesh::DofMap::local_variable_indices(), libMesh::MeshRefinement::make_coarsening_compatible(), libMesh::MeshBase::n_active_local_elem(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::DofMap::n_local_dofs(), libMesh::System::n_local_dofs(), libMesh::MeshBase::n_local_elem(), libMesh::MeshBase::n_local_nodes(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::SparsityPattern::Build::operator()(), libMesh::DistributedMesh::own_node(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), put_cmap_params(), put_elem_cmap(), put_elem_map(), put_loadbal_param(), put_node_cmap(), put_node_map(), libMesh::NameBasedIO::read(), libMesh::Nemesis_IO::read(), libMesh::XdrIO::read(), libMesh::CheckpointIO::read(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_global_values(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), libMesh::System::read_legacy_data(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::System::read_parallel_data(), libMesh::System::read_SCALAR_dofs(), libMesh::XdrIO::read_serialized_bc_names(), libMesh::XdrIO::read_serialized_bcs_helper(), libMesh::System::read_serialized_blocked_dof_objects(), libMesh::XdrIO::read_serialized_connectivity(), libMesh::System::read_serialized_data(), libMesh::XdrIO::read_serialized_nodes(), libMesh::XdrIO::read_serialized_nodesets(), libMesh::XdrIO::read_serialized_subdomain_names(), libMesh::System::read_serialized_vector(), libMesh::System::read_serialized_vectors(), libMesh::DistributedMesh::renumber_dof_objects(), libMesh::CheckpointIO::select_split_config(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::LaplaceMeshSmoother::smooth(), libMesh::MeshTools::total_weight(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::Parallel::Packing< T >::unpack(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::NameBasedIO::write(), libMesh::XdrIO::write(), libMesh::CheckpointIO::write(), libMesh::EquationSystems::write(), libMesh::GMVIO::write_discontinuous_gmv(), libMesh::ExodusII_IO::write_element_data(), libMesh::ExodusII_IO_Helper::write_element_values(), libMesh::ExodusII_IO_Helper::write_elements(), libMesh::ExodusII_IO::write_global_data(), libMesh::ExodusII_IO_Helper::write_global_values(), libMesh::System::write_header(), libMesh::ExodusII_IO::write_information_records(), libMesh::ExodusII_IO_Helper::write_information_records(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), libMesh::UCDIO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data_discontinuous(), libMesh::ExodusII_IO_Helper::write_nodal_values(), write_nodesets(), libMesh::ExodusII_IO_Helper::write_nodesets(), libMesh::System::write_parallel_data(), libMesh::System::write_SCALAR_dofs(), libMesh::XdrIO::write_serialized_bc_names(), libMesh::XdrIO::write_serialized_bcs_helper(), libMesh::System::write_serialized_blocked_dof_objects(), libMesh::XdrIO::write_serialized_connectivity(), libMesh::System::write_serialized_data(), libMesh::XdrIO::write_serialized_nodes(), libMesh::XdrIO::write_serialized_nodesets(), libMesh::XdrIO::write_serialized_subdomain_names(), libMesh::System::write_serialized_vector(), libMesh::System::write_serialized_vectors(), write_sidesets(), libMesh::ExodusII_IO_Helper::write_sidesets(), libMesh::ExodusII_IO::write_timestep(), libMesh::ExodusII_IO_Helper::write_timestep(), and libMesh::ExodusII_IO::write_timestep_discontinuous().
void libMesh::Nemesis_IO_Helper::put_cmap_params | ( | std::vector< int > & | node_cmap_ids, |
std::vector< int > & | node_cmap_node_cnts, | ||
std::vector< int > & | elem_cmap_ids, | ||
std::vector< int > & | elem_cmap_elem_cnts | ||
) |
Outputs initial information for communication maps.
Definition at line 573 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, and libMesh::ParallelObject::processor_id().
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_eb_info_global | ( | std::vector< int > & | global_elem_blk_ids, |
std::vector< int > & | global_elem_blk_cnts | ||
) |
Writes global block information to the file .) global_elem_blk_ids - list of block IDs for all blocks present in the mesh .) global_elem_blk_cnts - number of elements in each block for the global mesh
Must be called after put_init_global().
Definition at line 493 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, and nemesis_err_flag.
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_elem_cmap | ( | std::vector< std::vector< int >> & | elem_cmap_elem_ids, |
std::vector< std::vector< int >> & | elem_cmap_side_ids, | ||
std::vector< std::vector< int >> & | elem_cmap_proc_ids | ||
) |
Writes information about elemental communication map.
elem_cmap_elem_ids
, elem_cmap_side_ids
, abd elem_cmap_proc_ids
which can be used when calling this function.Must be called after put_cmap_params().
Definition at line 659 of file nemesis_io_helper.C.
References data, elem_cmap_ids, libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, and libMesh::ParallelObject::processor_id().
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_elem_map | ( | std::vector< int > & | elem_mapi, |
std::vector< int > & | elem_mapb | ||
) |
Outputs IDs of internal and border elements.
Must be called after ne_put_loadbal_param().
Definition at line 680 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, and libMesh::ParallelObject::processor_id().
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_init_global | ( | dof_id_type | num_nodes_global, |
dof_id_type | num_elems_global, | ||
unsigned | num_elem_blks_global, | ||
unsigned | num_node_sets_global, | ||
unsigned | num_side_sets_global | ||
) |
Writes global information including: .) global number of nodes .) global number of elems .) global number of element blocks .) global number of node sets .) global number of side sets
Definition at line 474 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, and nemesis_err_flag.
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_init_info | ( | unsigned | num_proc, |
unsigned | num_proc_in_file, | ||
const char * | ftype | ||
) |
Writing functions. Writes basic info about the partitioning to file .) num_proc - number of processors .) num_proc_in_file - number of processors in the current file - generally equal to 1 .) ftype = "s" for scalar load-balance file, "p" for parallel file
Definition at line 458 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, and nemesis_err_flag.
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_loadbal_param | ( | unsigned | num_internal_nodes, |
unsigned | num_border_nodes, | ||
unsigned | num_external_nodes, | ||
unsigned | num_internal_elems, | ||
unsigned | num_border_elems, | ||
unsigned | num_node_cmaps, | ||
unsigned | num_elem_cmaps | ||
) |
Writes load balance parameters, some of which are described below: .) num_internal_nodes - nodes "wholly" owned by the current processor .) num_border_nodes - nodes local to a processor but residing in an element which also has nodes on other processors .) num_external_nodes - nodes that reside on other processors but whose element "partially" resides on the current processor – we assert this should be zero on reading! .) num_border_elems - elements local to this processor but whose nodes reside on other processors as well. .) processor - ID of the processor for which information is to be written
Definition at line 547 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, and libMesh::ParallelObject::processor_id().
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_n_coord | ( | unsigned | start_node_num, |
unsigned | num_nodes, | ||
std::vector< Real > & | x_coor, | ||
std::vector< Real > & | y_coor, | ||
std::vector< Real > & | z_coor | ||
) |
Writes the specified number of coordinate values starting at the specified index.
Definition at line 697 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, and nemesis_err_flag.
void libMesh::Nemesis_IO_Helper::put_node_cmap | ( | std::vector< std::vector< int >> & | node_cmap_node_ids, |
std::vector< std::vector< int >> & | node_cmap_proc_ids | ||
) |
Outputs all of the nodal communication maps for this processor. Internally, this function loops over all communication maps and calls Nemesis::ne_put_node_cmap() for each one.
.) node_cmap_node_ids = Nodal IDs of the FEM nodes in this communication map .) node_cmap_proc_ids = processor IDs associated with each of the nodes in node_ids
In the Nemesis file, these all appear to be written to the same chunks of data: n_comm_nids and n_comm_proc, but don't rely on these names...
node_cmap_node_ids
and node_cmap_proc_ids
which can be used when calling this function.Must be called after put_cmap_params().
Definition at line 597 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, node_cmap_ids, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_node_map | ( | std::vector< int > & | node_mapi, |
std::vector< int > & | node_mapb, | ||
std::vector< int > & | node_mape | ||
) |
Outputs IDs of internal, border, and external nodes. LibMesh asserts that the number of external nodes is zero in the Nemesis files it reads
Definition at line 642 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, nemesis_err_flag, and libMesh::ParallelObject::processor_id().
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_ns_param_global | ( | std::vector< int > & | global_nodeset_ids, |
std::vector< int > & | num_global_node_counts, | ||
std::vector< int > & | num_global_node_df_counts | ||
) |
This function writes information about global node sets. .) global_nodeset_ids - vector of global node set IDs .) num_global_node_counts - vector of global node counts contained in each global node set .) num_global_df_count - vector of global distribution factors in each global node set
Must be called after put_init_global()
Definition at line 507 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, global_nodeset_ids, and nemesis_err_flag.
Referenced by initialize().
void libMesh::Nemesis_IO_Helper::put_ss_param_global | ( | std::vector< int > & | global_sideset_ids, |
std::vector< int > & | num_global_side_counts, | ||
std::vector< int > & | num_global_side_df_counts | ||
) |
This function writes information about global side sets. .) global_sideset_ids - vector of global side set IDs .) num_global_side_counts - vector of global side counts contained in each global side set .) num_global_df_count - vector of global distribution factors in each global side set
Must be called after put_init_global()
Definition at line 527 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_id, global_sideset_ids, and nemesis_err_flag.
Referenced by initialize().
|
inherited |
Reads information for all of the blocks in the ExodusII
mesh file.
Definition at line 517 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::block_ids, EX_ELEM_BLOCK, libMesh::ExodusII_IO_Helper::ex_err, ex_get_elem_blk_ids(), ex_get_name(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::id_to_block_names, libMesh::ExodusII_IO_Helper::message(), and libMesh::ExodusII_IO_Helper::num_elem_blk.
|
inherited |
Reads all of the element connectivity for block block
in the ExodusII
mesh file.
Definition at line 599 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::block_ids, libMesh::ExodusII_IO_Helper::connect, libMesh::ExodusII_IO_Helper::elem_type, libMesh::ExodusII_IO_Helper::ex_err, ex_get_elem_block(), ex_get_elem_conn(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::num_attr, libMesh::ExodusII_IO_Helper::num_elem_this_blk, libMesh::ExodusII_IO_Helper::num_nodes_per_elem, libMesh::out, and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Reads the optional node_num_map
from the ExodusII
mesh file.
Definition at line 639 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::elem_num_map, libMesh::ExodusII_IO_Helper::ex_err, ex_get_elem_num_map(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), std::min(), libMesh::ExodusII_IO_Helper::num_elem, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Reads elemental values for the variable 'elemental_var_name' at the specified timestep into the 'elem_var_value_map' which is passed in.
Definition at line 1012 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::block_ids, libMesh::ExodusII_IO_Helper::elem_num_map, libMesh::ExodusII_IO_Helper::elem_var_names, libMesh::ExodusII_IO_Helper::ELEMENTAL, libMesh::err, libMesh::ExodusII_IO_Helper::ex_err, ex_get_elem_block(), ex_get_elem_var(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::num_elem, libMesh::ExodusII_IO_Helper::num_elem_blk, libMesh::ExodusII_IO_Helper::num_elem_this_blk, and libMesh::ExodusII_IO_Helper::read_var_names().
|
inherited |
Reads the vector of global variables.
Definition at line 2031 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::ex_err, ex_get_glob_vars(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::num_global_vars, and libMesh::ParallelObject::processor_id().
|
inherited |
Reads an ExodusII
mesh file header.
Definition at line 375 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_init(), ex_get_var_param(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::num_dim, libMesh::ExodusII_IO_Helper::num_elem, libMesh::ExodusII_IO_Helper::num_elem_blk, libMesh::ExodusII_IO_Helper::num_elem_vars, libMesh::ExodusII_IO_Helper::num_global_vars, libMesh::ExodusII_IO_Helper::num_nodal_vars, libMesh::ExodusII_IO_Helper::num_node_sets, libMesh::ExodusII_IO_Helper::num_nodes, libMesh::ExodusII_IO_Helper::num_side_sets, libMesh::ExodusII_IO_Helper::read_num_time_steps(), and libMesh::ExodusII_IO_Helper::title.
|
inherited |
Reads the nodal values for the variable 'nodal_var_name' at the specified time into the 'nodal_var_values' array.
Definition at line 856 of file exodusII_io_helper.C.
References libMesh::err, libMesh::ExodusII_IO_Helper::ex_err, ex_get_nodal_var(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::NODAL, libMesh::ExodusII_IO_Helper::nodal_var_names, libMesh::ExodusII_IO_Helper::nodal_var_values, libMesh::ExodusII_IO_Helper::num_nodes, and libMesh::ExodusII_IO_Helper::read_var_names().
|
inherited |
Reads the optional node_num_map
from the ExodusII
mesh file.
Definition at line 489 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_node_num_map(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), std::min(), libMesh::ExodusII_IO_Helper::node_num_map, libMesh::ExodusII_IO_Helper::num_nodes, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Reads the nodal data (x,y,z coordinates) from the ExodusII
mesh file.
Definition at line 469 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_coord(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::num_nodes, libMesh::ExodusII_IO_Helper::x, libMesh::ExodusII_IO_Helper::y, and libMesh::ExodusII_IO_Helper::z.
|
inherited |
Reads information about nodeset id
and inserts it into the global nodeset array at the position offset
.
Definition at line 765 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_node_set(), ex_get_node_set_param(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::node_list, libMesh::ExodusII_IO_Helper::nodeset_ids, libMesh::ExodusII_IO_Helper::num_node_df_per_set, and libMesh::ExodusII_IO_Helper::num_nodes_per_set.
|
inherited |
Reads information about all of the nodesets in the ExodusII
mesh file.
Definition at line 694 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_name(), ex_get_node_set_ids(), libMesh::ExodusII_IO_Helper::ex_id, EX_NODE_SET, libMesh::ExodusII_IO_Helper::id_to_ns_names, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::nodeset_ids, libMesh::ExodusII_IO_Helper::num_node_df_per_set, libMesh::ExodusII_IO_Helper::num_node_sets, and libMesh::ExodusII_IO_Helper::num_nodes_per_set.
|
inherited |
Reads the number of timesteps currently stored in the Exodus file and stores it in the num_time_steps variable.
Definition at line 848 of file exodusII_io_helper.C.
References EX_INQ_TIME, libMesh::ExodusII_IO_Helper::inquire(), and libMesh::ExodusII_IO_Helper::num_time_steps.
Referenced by libMesh::ExodusII_IO_Helper::read_header(), and libMesh::ExodusII_IO_Helper::read_time_steps().
|
inherited |
Reads the QA records from an ExodusII file. We can use this to detect when e.g. CUBIT 14+ was used to generate a Mesh file, and work around certain known bugs in that version.
Definition at line 405 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_qa(), libMesh::ExodusII_IO_Helper::ex_id, EX_INQ_QA, libMesh::ExodusII_IO_Helper::inquire(), libMesh::out, and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Reads information about sideset id
and inserts it into the global sideset array at the position offset
.
Definition at line 722 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::elem_list, libMesh::ExodusII_IO_Helper::ex_err, ex_get_side_set(), ex_get_side_set_param(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::id_list, libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::num_df_per_set, libMesh::ExodusII_IO_Helper::num_sides_per_set, libMesh::ExodusII_IO_Helper::side_list, and libMesh::ExodusII_IO_Helper::ss_ids.
|
inherited |
Reads information about all of the sidesets in the ExodusII
mesh file.
Definition at line 661 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::elem_list, libMesh::ExodusII_IO_Helper::ex_err, ex_get_name(), ex_get_side_set_ids(), libMesh::ExodusII_IO_Helper::ex_id, EX_INQ_SS_ELEM_LEN, EX_SIDE_SET, libMesh::ExodusII_IO_Helper::id_list, libMesh::ExodusII_IO_Helper::id_to_ss_names, libMesh::ExodusII_IO_Helper::inquire(), libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::num_df_per_set, libMesh::ExodusII_IO_Helper::num_elem_all_sidesets, libMesh::ExodusII_IO_Helper::num_side_sets, libMesh::ExodusII_IO_Helper::num_sides_per_set, libMesh::ExodusII_IO_Helper::side_list, and libMesh::ExodusII_IO_Helper::ss_ids.
|
inherited |
Reads and stores the timesteps in the 'time_steps' array.
Definition at line 833 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, ex_get_all_times(), libMesh::ExodusII_IO_Helper::ex_id, libMesh::ExodusII_IO_Helper::num_time_steps, libMesh::ExodusII_IO_Helper::read_num_time_steps(), and libMesh::ExodusII_IO_Helper::time_steps.
|
inherited |
Definition at line 896 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::elem_var_names, libMesh::ExodusII_IO_Helper::ELEMENTAL, libMesh::ExodusII_IO_Helper::GLOBAL, libMesh::ExodusII_IO_Helper::global_var_names, libMesh::ExodusII_IO_Helper::NODAL, libMesh::ExodusII_IO_Helper::nodal_var_names, libMesh::ExodusII_IO_Helper::num_elem_vars, libMesh::ExodusII_IO_Helper::num_global_vars, libMesh::ExodusII_IO_Helper::num_nodal_vars, and libMesh::ExodusII_IO_Helper::read_var_names_impl().
Referenced by libMesh::ExodusII_IO_Helper::check_existing_vars(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), and libMesh::ExodusII_IO_Helper::read_nodal_var_values().
|
inherited |
Allows you to set a vector that is added to the coordinates of all of the nodes. Effectively, this "moves" the mesh to a particular position
Definition at line 2058 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_coordinate_offset.
|
inherited |
Sets the underlying value of the boolean flag _use_mesh_dimension_instead_of_spatial_dimension. By default, the value of this flag is false.
See the ExodusII_IO class documentation for a detailed description of this flag.
Definition at line 2044 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_use_mesh_dimension_instead_of_spatial_dimension.
|
inherited |
Sets the value of _write_as_dimension.
This directly controls the num_dim which is written to the Exodus file. If non-zero, this value supersedes all other dimensions, including: 1.) MeshBase::spatial_dimension() 2.) MeshBase::mesh_dimension() 3.) Any value passed to use_mesh_dimension_instead_of_spatial_dimension() This is useful/necessary for working around a bug in Paraview which prevents the "Plot Over Line" filter from working on 1D meshes.
Definition at line 2051 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_write_as_dimension.
|
inherited |
Writes the vector of values to the element variables.
Definition at line 1865 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::_single_precision, libMesh::MeshBase::active_element_ptr_range(), data, libMesh::ExodusII_IO_Helper::ex_err, ex_get_var_param(), libMesh::ExodusII_IO_Helper::ex_id, ex_put_elem_var(), ex_update(), libMesh::ExodusII_IO_Helper::get_block_id(), mesh, libMesh::MeshBase::n_elem(), libMesh::MeshTools::n_elem(), libMesh::ExodusII_IO_Helper::num_elem_vars, and libMesh::ParallelObject::processor_id().
void libMesh::Nemesis_IO_Helper::write_element_values | ( | const MeshBase & | mesh, |
const NumericVector< Number > & | parallel_soln, | ||
const std::vector< std::string > & | names, | ||
int | timestep, | ||
const std::vector< std::set< subdomain_id_type >> & | vars_active_subdomains | ||
) |
Writes the vector of elemental variable values, one variable and one subdomain at a time.
Definition at line 2580 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_elem_var(), ex_update(), global_elem_blk_ids, if(), libMesh::NumericVector< T >::localize(), mesh, and subdomain_map.
|
overridevirtual |
This function is specialized to write the connectivity.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 2344 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ElementMaps::assign_conversion(), block_id_to_elem_connectivity, libMesh::MeshBase::elem_ref(), EX_ELEM_BLOCK, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_elem_block(), ex_put_elem_conn(), ex_put_elem_num_map(), ex_put_names(), libMesh::ExodusII_IO_Helper::exodus_elem_num_to_libmesh, libMesh::ExodusII_IO_Helper::Conversion::exodus_elem_type(), libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), global_elem_blk_ids, mesh, libMesh::Elem::n_nodes(), num_elem_blks_global, libMesh::ExodusII_IO_Helper::num_nodes_per_elem, libMesh::ExodusII_IO_Helper::NamesData::push_back_entry(), and subdomain_map.
|
private |
This function writes exodus-specific initialization information. This information is slightly different when you are working with Nemesis, as it depends on some global information being known.
Definition at line 930 of file nemesis_io_helper.C.
References libMesh::MeshBase::active_local_elements_begin(), libMesh::MeshBase::active_local_elements_end(), libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_init(), global_nodeset_ids, global_sideset_ids, libMesh::ExodusII_IO_Helper::num_dim, libMesh::ExodusII_IO_Helper::num_elem, libMesh::ExodusII_IO_Helper::num_elem_blk, num_elem_blks_global, libMesh::ExodusII_IO_Helper::num_node_sets, libMesh::ExodusII_IO_Helper::num_nodes, and libMesh::ExodusII_IO_Helper::num_side_sets.
Referenced by initialize().
|
inherited |
Writes the vector of global variables.
Definition at line 2009 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_glob_vars(), ex_update(), libMesh::ExodusII_IO_Helper::num_global_vars, and libMesh::ParallelObject::processor_id().
|
inherited |
Writes the vector of information records.
Definition at line 1970 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::err, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, EX_INQ_INFO, ex_put_info(), ex_update(), libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), libMesh::ExodusII_IO_Helper::inquire(), libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::NamesData::push_back_entry().
|
overridevirtual |
This function is specialized from ExodusII_IO_Helper to write only the nodal coordinates stored on the local piece of the Mesh.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 2285 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_coord(), ex_put_node_num_map(), libMesh::ExodusII_IO_Helper::exodus_node_num_to_libmesh, mesh, libMesh::ExodusII_IO_Helper::x, libMesh::ExodusII_IO_Helper::y, and libMesh::ExodusII_IO_Helper::z.
void libMesh::Nemesis_IO_Helper::write_nodal_solution | ( | const NumericVector< Number > & | parallel_soln, |
const std::vector< std::string > & | names, | ||
int | timestep, | ||
const std::vector< std::string > & | output_names | ||
) |
Takes a parallel solution vector containing the node-major solution vector for all variables and outputs it to the files.
parallel_soln | |
names | A vector containing the names of all variables in parallel_soln. |
timestep | To be passed to the ExodusII_IO_Helper::write_nodal_values() function. |
output_names | A vector containing the names of variables in parallel_soln that should actually be written (whitelist). |
Definition at line 2469 of file nemesis_io_helper.C.
References std::abs(), libMesh::ExodusII_IO_Helper::exodus_node_num_to_libmesh, libMesh::NumericVector< T >::localize(), libMesh::ExodusII_IO_Helper::num_nodes, and libMesh::ExodusII_IO_Helper::write_nodal_values().
void libMesh::Nemesis_IO_Helper::write_nodal_solution | ( | const std::vector< Number > & | values, |
const std::vector< std::string > & | names, | ||
int | timestep | ||
) |
Takes a solution vector containing the solution for all variables and outputs it to the files
Definition at line 2431 of file nemesis_io_helper.C.
References std::abs(), libMesh::ExodusII_IO_Helper::exodus_node_num_to_libmesh, libMesh::ExodusII_IO_Helper::num_nodes, value, and libMesh::ExodusII_IO_Helper::write_nodal_values().
|
inherited |
Writes the vector of values to a nodal variable.
Definition at line 1948 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_nodal_var(), ex_update(), libMesh::ExodusII_IO_Helper::num_nodes, and libMesh::ParallelObject::processor_id().
Referenced by write_nodal_solution().
|
overridevirtual |
Writes the nodesets for this processor.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 1965 of file nemesis_io_helper.C.
References libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, EX_NODE_SET, ex_put_names(), ex_put_node_set(), ex_put_node_set_param(), global_nodeset_ids, libMesh::ExodusII_IO_Helper::libmesh_node_num_to_exodus, mesh, libMesh::out, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::verbose.
|
overridevirtual |
Writes the sidesets for this processor.
Reimplemented from libMesh::ExodusII_IO_Helper.
Definition at line 2116 of file nemesis_io_helper.C.
References libMesh::Elem::active_family_tree_by_side(), libMesh::ExodusII_IO_Helper::ElementMaps::assign_conversion(), libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_names(), ex_put_side_set(), ex_put_side_set_param(), EX_SIDE_SET, libMesh::ExodusII_IO_Helper::Conversion::get_inverse_side_map(), global_sideset_ids, libMesh::ExodusII_IO_Helper::libmesh_elem_num_to_exodus, mesh, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::DofObject::processor_id(), libMesh::Elem::type(), and libMesh::ExodusII_IO_Helper::verbose.
|
inherited |
Writes the time for the timestep
Definition at line 1843 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::_run_only_on_proc0, libMesh::ExodusII_IO_Helper::_single_precision, libMesh::ExodusII_IO_Helper::ex_err, libMesh::ExodusII_IO_Helper::ex_id, ex_put_time(), ex_update(), and libMesh::ParallelObject::processor_id().
|
protectedinherited |
Wraps calls to exII::ex_put_var_names() and exII::ex_put_var_param(). The enumeration controls whether nodal, elemental, or global variable names are read and which class members are filled in.
Definition at line 956 of file exodusII_io_helper.C.
References libMesh::ExodusII_IO_Helper::ELEMENTAL, libMesh::ExodusII_IO_Helper::GLOBAL, libMesh::ExodusII_IO_Helper::NODAL, libMesh::ExodusII_IO_Helper::num_elem_vars, libMesh::ExodusII_IO_Helper::num_global_vars, libMesh::ExodusII_IO_Helper::num_nodal_vars, and libMesh::ExodusII_IO_Helper::write_var_names_impl().
Referenced by libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::initialize_global_variables(), and libMesh::ExodusII_IO_Helper::initialize_nodal_variables().
|
protectedinherited |
Definition at line 107 of file parallel_object.h.
Referenced by libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::ParallelObject::comm(), libMesh::ParallelObject::n_processors(), libMesh::ParallelObject::operator=(), and libMesh::ParallelObject::processor_id().
|
protectedinherited |
Definition at line 640 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::set_coordinate_offset(), and libMesh::ExodusII_IO_Helper::write_nodal_coordinates().
|
protectedinherited |
Definition at line 622 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_element_variables(), and initialize_element_variables().
|
protectedinherited |
Definition at line 625 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_global_variables().
|
protectedinherited |
Definition at line 628 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_nodal_variables().
|
protectedinherited |
Definition at line 619 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::create(), libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), libMesh::ExodusII_IO_Helper::initialize_global_variables(), libMesh::ExodusII_IO_Helper::initialize_nodal_variables(), libMesh::ExodusII_IO_Helper::read_global_values(), libMesh::ExodusII_IO_Helper::write_element_values(), libMesh::ExodusII_IO_Helper::write_elements(), libMesh::ExodusII_IO_Helper::write_global_values(), libMesh::ExodusII_IO_Helper::write_information_records(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_values(), libMesh::ExodusII_IO_Helper::write_nodesets(), libMesh::ExodusII_IO_Helper::write_sidesets(), and libMesh::ExodusII_IO_Helper::write_timestep().
|
protectedinherited |
Definition at line 643 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::create(), create(), libMesh::ExodusII_IO_Helper::open(), libMesh::ExodusII_IO_Helper::write_element_values(), libMesh::ExodusII_IO_Helper::write_global_values(), write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_values(), and libMesh::ExodusII_IO_Helper::write_timestep().
|
protectedinherited |
Definition at line 633 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize(), and libMesh::ExodusII_IO_Helper::use_mesh_dimension_instead_of_spatial_dimension().
|
protectedinherited |
Definition at line 637 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize(), and libMesh::ExodusII_IO_Helper::write_as_dimension().
std::map<int, std::vector<int> > libMesh::Nemesis_IO_Helper::block_id_to_elem_connectivity |
This is the block connectivity, i.e. for each subdomain (block) there is an element connectivity list. This map associates the block ID to that vector.
Definition at line 434 of file nemesis_io_helper.h.
Referenced by build_element_and_node_maps(), and write_elements().
|
inherited |
Definition at line 474 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), libMesh::ExodusII_IO_Helper::get_block_id(), libMesh::ExodusII_IO_Helper::get_block_name(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), libMesh::ExodusII_IO_Helper::read_block_info(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), and libMesh::ExodusII_IO_Helper::write_elements().
|
private |
A set of border elem IDs for this processor.
Definition at line 609 of file nemesis_io_helper.h.
Referenced by compute_element_maps(), and compute_internal_and_border_elems_and_internal_nodes().
|
private |
The set which will eventually contain the IDs of "border nodes". These are nodes that lie on the boundary between one or more processors.
Definition at line 572 of file nemesis_io_helper.h.
Referenced by compute_border_node_ids(), compute_internal_and_border_elems_and_internal_nodes(), and compute_node_maps().
|
inherited |
Definition at line 477 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_elem_in_block(), and libMesh::ExodusII_IO_Helper::write_elements().
|
inherited |
Definition at line 591 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::create(), and libMesh::ExodusII_IO_Helper::open().
std::vector<int> libMesh::Nemesis_IO_Helper::elem_cmap_elem_cnts |
Definition at line 536 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), get_cmap_params(), get_elem_cmap(), and initialize().
std::vector<std::vector<int> > libMesh::Nemesis_IO_Helper::elem_cmap_elem_ids |
3 vectors of vectors for storing element communication IDs for this processor. There will be num_elem_cmaps rows, row i will have elem_cmap_elem_cnts[i] entries. To be used with Nemesis::ne_get_elem_cmap().
Definition at line 556 of file nemesis_io_helper.h.
Referenced by compute_elem_communication_maps(), get_elem_cmap(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::elem_cmap_ids |
Definition at line 535 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), compute_elem_communication_maps(), get_cmap_params(), get_elem_cmap(), initialize(), and put_elem_cmap().
std::vector<std::vector<int> > libMesh::Nemesis_IO_Helper::elem_cmap_proc_ids |
Definition at line 558 of file nemesis_io_helper.h.
Referenced by compute_elem_communication_maps(), get_elem_cmap(), and initialize().
std::vector<std::vector<int> > libMesh::Nemesis_IO_Helper::elem_cmap_side_ids |
Definition at line 557 of file nemesis_io_helper.h.
Referenced by compute_elem_communication_maps(), get_elem_cmap(), and initialize().
|
inherited |
Definition at line 498 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
std::vector<int> libMesh::Nemesis_IO_Helper::elem_mapb |
Vector which stores border element IDs. Will have length num_border_elems. To be used with Nemesis::ne_get_elem_map().
Definition at line 501 of file nemesis_io_helper.h.
Referenced by compute_element_maps(), get_elem_map(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::elem_mapi |
Vector which stores internal element IDs. Will have length num_internal_elems. To be used with Nemesis::ne_get_elem_map().
Definition at line 494 of file nemesis_io_helper.h.
Referenced by compute_element_maps(), get_elem_map(), and initialize().
|
inherited |
Definition at line 513 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), and libMesh::ExodusII_IO_Helper::write_elements().
|
inherited |
Definition at line 528 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::ExodusII_IO_Helper(), libMesh::ExodusII_IO_Helper::get_elem_type(), and libMesh::ExodusII_IO_Helper::read_elem_in_block().
|
inherited |
Definition at line 559 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), and libMesh::ExodusII_IO_Helper::read_var_names().
|
inherited |
Definition at line 562 of file exodusII_io_helper.h.
|
inherited |
Definition at line 438 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::inquire(), libMesh::ExodusII_IO_Helper::read_block_info(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), libMesh::ExodusII_IO_Helper::read_global_values(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_nodal_var_values(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::ExodusII_IO_Helper::read_nodes(), libMesh::ExodusII_IO_Helper::read_nodeset(), libMesh::ExodusII_IO_Helper::read_nodeset_info(), libMesh::ExodusII_IO_Helper::read_qa_records(), libMesh::ExodusII_IO_Helper::read_sideset(), libMesh::ExodusII_IO_Helper::read_sideset_info(), libMesh::ExodusII_IO_Helper::read_time_steps(), libMesh::ExodusII_IO_Helper::read_var_names_impl(), libMesh::ExodusII_IO_Helper::write_element_values(), write_element_values(), write_elements(), libMesh::ExodusII_IO_Helper::write_elements(), write_exodus_initialization_info(), libMesh::ExodusII_IO_Helper::write_global_values(), libMesh::ExodusII_IO_Helper::write_information_records(), write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_values(), write_nodesets(), libMesh::ExodusII_IO_Helper::write_nodesets(), write_sidesets(), libMesh::ExodusII_IO_Helper::write_sidesets(), libMesh::ExodusII_IO_Helper::write_timestep(), libMesh::ExodusII_IO_Helper::write_var_names_impl(), and ~Nemesis_IO_Helper().
|
inherited |
Definition at line 435 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::create(), create(), get_cmap_params(), get_eb_info_global(), get_elem_cmap(), get_elem_map(), get_init_global(), get_init_info(), get_loadbal_param(), get_node_cmap(), get_node_map(), get_ns_param_global(), get_ss_param_global(), libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::inquire(), libMesh::ExodusII_IO_Helper::open(), put_cmap_params(), put_eb_info_global(), put_elem_cmap(), put_elem_map(), put_init_global(), put_init_info(), put_loadbal_param(), put_n_coord(), put_node_cmap(), put_node_map(), put_ns_param_global(), put_ss_param_global(), libMesh::ExodusII_IO_Helper::read_block_info(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), libMesh::ExodusII_IO_Helper::read_global_values(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_nodal_var_values(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::ExodusII_IO_Helper::read_nodes(), libMesh::ExodusII_IO_Helper::read_nodeset(), libMesh::ExodusII_IO_Helper::read_nodeset_info(), libMesh::ExodusII_IO_Helper::read_qa_records(), libMesh::ExodusII_IO_Helper::read_sideset(), libMesh::ExodusII_IO_Helper::read_sideset_info(), libMesh::ExodusII_IO_Helper::read_time_steps(), libMesh::ExodusII_IO_Helper::read_var_names_impl(), libMesh::ExodusII_IO_Helper::write_element_values(), write_element_values(), write_elements(), libMesh::ExodusII_IO_Helper::write_elements(), write_exodus_initialization_info(), libMesh::ExodusII_IO_Helper::write_global_values(), libMesh::ExodusII_IO_Helper::write_information_records(), write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), libMesh::ExodusII_IO_Helper::write_nodal_values(), write_nodesets(), libMesh::ExodusII_IO_Helper::write_nodesets(), write_sidesets(), libMesh::ExodusII_IO_Helper::write_sidesets(), libMesh::ExodusII_IO_Helper::write_timestep(), libMesh::ExodusII_IO_Helper::write_var_names_impl(), and ~Nemesis_IO_Helper().
|
inherited |
Definition at line 533 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), and write_elements().
|
inherited |
Definition at line 538 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), write_nodal_coordinates(), and write_nodal_solution().
char libMesh::Nemesis_IO_Helper::ftype |
The type of file to be written. Either 's', for a scalar load-balance file, or 'p' for a parallel file. To be used with Nemesis::ne_get_init_info().
Definition at line 386 of file nemesis_io_helper.h.
Referenced by get_init_info().
std::vector<int> libMesh::Nemesis_IO_Helper::global_elem_blk_cnts |
Definition at line 418 of file nemesis_io_helper.h.
Referenced by compute_num_global_elem_blocks(), get_eb_info_global(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::global_elem_blk_ids |
Read the global element block IDs and counts. These vectors will eventually have num_elem_blks_global entries. To be used with Nemesis::ne_get_eb_info_global().
Definition at line 417 of file nemesis_io_helper.h.
Referenced by compute_num_global_elem_blocks(), get_eb_info_global(), initialize(), initialize_element_variables(), write_element_values(), and write_elements().
std::vector<int> libMesh::Nemesis_IO_Helper::global_nodeset_ids |
Containers for reading global nodeset information. One vector entry per nodeset. Each vector will eventually have num_node_sets_global entries, and will be used in calls to Nemesis::ne_get_ns_param_global().
It's an error to call ne_get_ns_param_global when num_node_sets_global==0
Definition at line 407 of file nemesis_io_helper.h.
Referenced by compute_num_global_nodesets(), get_ns_param_global(), initialize(), put_ns_param_global(), write_exodus_initialization_info(), and write_nodesets().
std::vector<int> libMesh::Nemesis_IO_Helper::global_sideset_ids |
Containers for reading global sideset (boundary conditions) information. Each vector will eventually have num_side_sets_global entries, and be used in calls to Nemesis::ne_get_ss_param_global().
It's an error to call ne_get_ss_param_global when num_side_sets_global==0
Definition at line 395 of file nemesis_io_helper.h.
Referenced by compute_num_global_sidesets(), get_ss_param_global(), initialize(), put_ss_param_global(), write_exodus_initialization_info(), and write_sidesets().
|
inherited |
Definition at line 565 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_global_variables(), and libMesh::ExodusII_IO_Helper::read_var_names().
|
inherited |
Definition at line 507 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Definition at line 568 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::get_block_name(), and libMesh::ExodusII_IO_Helper::read_block_info().
|
inherited |
Definition at line 570 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::get_node_set_name(), and libMesh::ExodusII_IO_Helper::read_nodeset_info().
|
inherited |
Definition at line 569 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::get_side_set_name(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
private |
A set of internal elem IDs for this processor.
Definition at line 604 of file nemesis_io_helper.h.
Referenced by compute_element_maps(), and compute_internal_and_border_elems_and_internal_nodes().
|
private |
A set of internal node IDs for this processor.
Definition at line 599 of file nemesis_io_helper.h.
Referenced by compute_internal_and_border_elems_and_internal_nodes(), and compute_node_maps().
|
inherited |
Definition at line 532 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), compute_elem_communication_maps(), compute_element_maps(), libMesh::ExodusII_IO_Helper::write_elements(), write_sidesets(), and libMesh::ExodusII_IO_Helper::write_sidesets().
|
inherited |
Definition at line 537 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), compute_node_communication_maps(), compute_node_maps(), libMesh::ExodusII_IO_Helper::write_elements(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), and write_nodesets().
|
private |
This map keeps track of the number of elements in each subdomain (block) for this processor.
Definition at line 566 of file nemesis_io_helper.h.
Referenced by build_element_and_node_maps(), and compute_num_global_elem_blocks().
int libMesh::Nemesis_IO_Helper::nemesis_err_flag |
Member data All (?) Nemesis functions return an int. If it's negative that signals an error! Internally, we use the ExodusII_IO_Helper::check_err() function to check for errors.
Definition at line 356 of file nemesis_io_helper.h.
Referenced by get_cmap_params(), get_eb_info_global(), get_elem_cmap(), get_elem_map(), get_init_global(), get_init_info(), get_loadbal_param(), get_node_cmap(), get_node_map(), get_ns_param_global(), get_ss_param_global(), put_cmap_params(), put_eb_info_global(), put_elem_cmap(), put_elem_map(), put_init_global(), put_init_info(), put_loadbal_param(), put_n_coord(), put_node_cmap(), put_node_map(), put_ns_param_global(), and put_ss_param_global().
|
inherited |
Definition at line 550 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_nodal_variables(), libMesh::ExodusII_IO_Helper::read_nodal_var_values(), and libMesh::ExodusII_IO_Helper::read_var_names().
|
inherited |
Definition at line 553 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_nodal_var_values().
std::vector<int> libMesh::Nemesis_IO_Helper::node_cmap_ids |
Vectors for storing the communication map parameters. Each will eventually have length num_node_cmaps OR num_elem_cmaps as appropriate. For use with Nemesis::ne_get_cmap_params().
Definition at line 533 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), compute_node_communication_maps(), get_cmap_params(), get_node_cmap(), initialize(), and put_node_cmap().
std::vector<int> libMesh::Nemesis_IO_Helper::node_cmap_node_cnts |
Definition at line 534 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), get_cmap_params(), get_node_cmap(), and initialize().
std::vector<std::vector<int> > libMesh::Nemesis_IO_Helper::node_cmap_node_ids |
2 vectors of vectors for storing the node communication IDs for this processor. There will be num_node_cmaps rows, row i will have node_cmap_node_cnts[i] entries. To be used with Nemesis::ne_get_node_cmap().
Remark: node_cmap_proc_ids is a vector, all entries of which are = node_cmap_ids[i] Not sure what the point of that is...
Definition at line 547 of file nemesis_io_helper.h.
Referenced by compute_node_communication_maps(), get_node_cmap(), and initialize().
std::vector<std::vector<int> > libMesh::Nemesis_IO_Helper::node_cmap_proc_ids |
Definition at line 548 of file nemesis_io_helper.h.
Referenced by compute_node_communication_maps(), get_node_cmap(), and initialize().
|
inherited |
Definition at line 504 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_nodeset().
std::vector<int> libMesh::Nemesis_IO_Helper::node_mapb |
Vector which stores border node IDs. Will have length num_border_nodes. To be used with Nemesis::ne_get_node_map().
Definition at line 517 of file nemesis_io_helper.h.
Referenced by compute_node_maps(), get_node_map(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::node_mape |
Vector which stores external node IDs. Will have length num_external_nodes. To be used with Nemesis::ne_get_node_map().
Definition at line 524 of file nemesis_io_helper.h.
Referenced by compute_node_maps(), get_node_map(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::node_mapi |
Vector which stores internal node IDs. Will have length num_internal_nodes. To be used with Nemesis::ne_get_node_map().
Definition at line 510 of file nemesis_io_helper.h.
Referenced by compute_node_maps(), get_node_map(), and initialize().
|
inherited |
Definition at line 510 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_node_num_map(), and libMesh::ExodusII_IO_Helper::write_nodal_coordinates().
std::set<int> libMesh::Nemesis_IO_Helper::nodes_attached_to_local_elems |
libMesh numbered node ids attached to local elems.
Definition at line 423 of file nemesis_io_helper.h.
Referenced by build_element_and_node_maps(), and compute_internal_and_border_elems_and_internal_nodes().
|
inherited |
Definition at line 483 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::get_node_set_id(), libMesh::ExodusII_IO_Helper::get_node_set_name(), libMesh::ExodusII_IO_Helper::read_nodeset(), and libMesh::ExodusII_IO_Helper::read_nodeset_info().
|
inherited |
Definition at line 468 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_elem_in_block().
int libMesh::Nemesis_IO_Helper::num_border_elems |
The number of border FEM elements. Elements local to this processor but whose FEM nodes reside on other processors as well. To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 471 of file nemesis_io_helper.h.
Referenced by compute_internal_and_border_elems_and_internal_nodes(), get_elem_map(), get_loadbal_param(), and initialize().
int libMesh::Nemesis_IO_Helper::num_border_nodes |
The number of FEM nodes local to a processor but residing in an element which also has FEM nodes on other processors. To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 451 of file nemesis_io_helper.h.
Referenced by compute_border_node_ids(), compute_internal_and_border_elems_and_internal_nodes(), get_loadbal_param(), get_node_map(), and initialize().
|
inherited |
Definition at line 492 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Definition at line 441 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::print_header(), libMesh::ExodusII_IO_Helper::read_header(), and write_exodus_initialization_info().
|
inherited |
Definition at line 450 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::print_header(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), libMesh::ExodusII_IO_Helper::read_header(), and write_exodus_initialization_info().
|
inherited |
Definition at line 471 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Definition at line 453 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::initialize_element_variables(), libMesh::ExodusII_IO_Helper::print_header(), libMesh::ExodusII_IO_Helper::read_block_info(), libMesh::ExodusII_IO_Helper::read_elemental_var_values(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::write_elements(), and write_exodus_initialization_info().
int libMesh::Nemesis_IO_Helper::num_elem_blks_global |
Definition at line 364 of file nemesis_io_helper.h.
Referenced by compute_num_global_elem_blocks(), get_eb_info_global(), get_init_global(), initialize(), write_elements(), and write_exodus_initialization_info().
int libMesh::Nemesis_IO_Helper::num_elem_cmaps |
The number of elemental communication maps for this processor. (One per neighboring proc?) To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 485 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), compute_elem_communication_maps(), compute_internal_and_border_elems_and_internal_nodes(), get_cmap_params(), get_elem_cmap(), get_loadbal_param(), and initialize().
|
inherited |
Definition at line 462 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_elem_in_block(), and libMesh::ExodusII_IO_Helper::read_elemental_var_values().
|
inherited |
Definition at line 556 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_element_variables(), initialize_element_variables(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_var_names(), libMesh::ExodusII_IO_Helper::write_element_values(), and libMesh::ExodusII_IO_Helper::write_var_names().
int libMesh::Nemesis_IO_Helper::num_elems_global |
Definition at line 363 of file nemesis_io_helper.h.
Referenced by get_init_global().
int libMesh::Nemesis_IO_Helper::num_external_nodes |
The number of FEM nodes that reside on another processor but whose element partially resides on the current processor. To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 458 of file nemesis_io_helper.h.
Referenced by get_loadbal_param(), get_node_map(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::num_global_node_counts |
Definition at line 408 of file nemesis_io_helper.h.
Referenced by compute_num_global_nodesets(), get_ns_param_global(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::num_global_node_df_counts |
Definition at line 409 of file nemesis_io_helper.h.
Referenced by get_ns_param_global(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::num_global_side_counts |
Definition at line 396 of file nemesis_io_helper.h.
Referenced by compute_num_global_sidesets(), get_ss_param_global(), and initialize().
std::vector<int> libMesh::Nemesis_IO_Helper::num_global_side_df_counts |
Definition at line 397 of file nemesis_io_helper.h.
Referenced by get_ss_param_global(), and initialize().
|
inherited |
Definition at line 444 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_global_variables(), libMesh::ExodusII_IO_Helper::read_global_values(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_var_names(), libMesh::ExodusII_IO_Helper::write_global_values(), and libMesh::ExodusII_IO_Helper::write_var_names().
int libMesh::Nemesis_IO_Helper::num_internal_elems |
The number of internal FEM elements. Elements local to this processor. To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 464 of file nemesis_io_helper.h.
Referenced by compute_internal_and_border_elems_and_internal_nodes(), get_elem_map(), get_loadbal_param(), and initialize().
int libMesh::Nemesis_IO_Helper::num_internal_nodes |
To be used with the Nemesis::ne_get_loadbal_param() routine. The number of FEM nodes contained in FEM elements wholly owned by the current processor. To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 444 of file nemesis_io_helper.h.
Referenced by compute_internal_and_border_elems_and_internal_nodes(), get_loadbal_param(), get_node_map(), and initialize().
|
inherited |
Definition at line 547 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::initialize_nodal_variables(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_var_names(), and libMesh::ExodusII_IO_Helper::write_var_names().
int libMesh::Nemesis_IO_Helper::num_node_cmaps |
The number of nodal communication maps for this processor. (One per neighboring proc?) To be used with the Nemesis::ne_get_loadbal_param() routine.
Definition at line 478 of file nemesis_io_helper.h.
Referenced by compute_border_node_ids(), compute_communication_map_parameters(), compute_node_communication_maps(), get_cmap_params(), get_loadbal_param(), get_node_cmap(), and initialize().
|
inherited |
Definition at line 495 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_nodeset(), and libMesh::ExodusII_IO_Helper::read_nodeset_info().
|
inherited |
int libMesh::Nemesis_IO_Helper::num_node_sets_global |
Definition at line 365 of file nemesis_io_helper.h.
Referenced by compute_num_global_nodesets(), get_init_global(), get_ns_param_global(), and initialize().
|
inherited |
Definition at line 447 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), libMesh::ExodusII_IO_Helper::initialize(), libMesh::ExodusII_IO_Helper::print_header(), libMesh::ExodusII_IO_Helper::print_nodes(), libMesh::ExodusII_IO_Helper::read_header(), libMesh::ExodusII_IO_Helper::read_nodal_var_values(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::ExodusII_IO_Helper::read_nodes(), write_exodus_initialization_info(), libMesh::ExodusII_IO_Helper::write_nodal_coordinates(), write_nodal_solution(), and libMesh::ExodusII_IO_Helper::write_nodal_values().
int libMesh::Nemesis_IO_Helper::num_nodes_global |
Global initial information. The names are self-explanatory for the most part. Used with Nemesis::ne_get_init_global().
Definition at line 362 of file nemesis_io_helper.h.
Referenced by get_init_global().
|
inherited |
Definition at line 465 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), write_elements(), and libMesh::ExodusII_IO_Helper::write_elements().
|
inherited |
Definition at line 489 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_nodeset(), and libMesh::ExodusII_IO_Helper::read_nodeset_info().
int libMesh::Nemesis_IO_Helper::num_proc |
The number of processors for which the NEMESIS I file was created. To be used with Nemesis::ne_get_init_info().
Definition at line 372 of file nemesis_io_helper.h.
Referenced by get_init_info().
int libMesh::Nemesis_IO_Helper::num_proc_in_file |
The number of processors for which the NEMESIS I file stores information. This is generally equal to 1 (1 CPU/file) at least for the splitting Derek gave us. To be used with Nemesis::ne_get_init_info().
Definition at line 379 of file nemesis_io_helper.h.
Referenced by get_init_info().
|
inherited |
int libMesh::Nemesis_IO_Helper::num_side_sets_global |
Definition at line 366 of file nemesis_io_helper.h.
Referenced by compute_num_global_sidesets(), get_init_global(), get_ss_param_global(), and initialize().
|
inherited |
Definition at line 486 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Definition at line 541 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_num_time_steps(), and libMesh::ExodusII_IO_Helper::read_time_steps().
|
inherited |
Definition at line 581 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::close(), and libMesh::ExodusII_IO_Helper::open().
|
inherited |
Definition at line 577 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::close(), libMesh::ExodusII_IO_Helper::create(), create(), libMesh::ExodusII_IO_Helper::open(), and ~Nemesis_IO_Helper().
|
private |
Map between processor ID and (element,side) pairs bordering that processor ID.
Definition at line 589 of file nemesis_io_helper.h.
Referenced by compute_communication_map_parameters(), compute_elem_communication_maps(), and compute_internal_and_border_elems_and_internal_nodes().
|
private |
Another map to store sets of intersections with each other processor (other than ourself, of course). A node which appears in one of these vectors belongs to element owned by at least this processor and one other.
Definition at line 579 of file nemesis_io_helper.h.
Referenced by compute_border_node_ids(), compute_communication_map_parameters(), and compute_node_communication_maps().
|
inherited |
Definition at line 501 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
|
inherited |
Definition at line 480 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::get_side_set_id(), libMesh::ExodusII_IO_Helper::get_side_set_name(), libMesh::ExodusII_IO_Helper::read_sideset(), and libMesh::ExodusII_IO_Helper::read_sideset_info().
std::map<subdomain_id_type, std::vector<dof_id_type> > libMesh::Nemesis_IO_Helper::subdomain_map |
Map of subdomains to element numbers.
Definition at line 428 of file nemesis_io_helper.h.
Referenced by build_element_and_node_maps(), write_element_values(), and write_elements().
|
inherited |
Definition at line 544 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::read_time_steps().
|
inherited |
Definition at line 525 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::ExodusII_IO_Helper(), libMesh::ExodusII_IO_Helper::print_header(), and libMesh::ExodusII_IO_Helper::read_header().
|
inherited |
Definition at line 573 of file exodusII_io_helper.h.
Referenced by build_element_and_node_maps(), compute_border_node_ids(), compute_communication_map_parameters(), compute_internal_and_border_elems_and_internal_nodes(), compute_node_communication_maps(), compute_num_global_elem_blocks(), compute_num_global_nodesets(), compute_num_global_sidesets(), construct_nemesis_filename(), libMesh::ExodusII_IO_Helper::create(), create(), get_cmap_params(), get_eb_info_global(), get_elem_cmap(), get_elem_map(), get_init_global(), get_init_info(), get_loadbal_param(), get_node_cmap(), get_node_map(), get_ns_param_global(), get_ss_param_global(), libMesh::ExodusII_IO_Helper::message(), libMesh::ExodusII_IO_Helper::open(), libMesh::ExodusII_IO_Helper::print_header(), put_node_cmap(), libMesh::ExodusII_IO_Helper::read_elem_in_block(), libMesh::ExodusII_IO_Helper::read_elem_num_map(), libMesh::ExodusII_IO_Helper::read_node_num_map(), libMesh::ExodusII_IO_Helper::read_qa_records(), libMesh::ExodusII_IO_Helper::read_var_names_impl(), libMesh::ExodusII_IO_Helper::write_elements(), write_nodesets(), write_sidesets(), and libMesh::ExodusII_IO_Helper::write_var_names_impl().
|
inherited |
Definition at line 516 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::print_nodes(), libMesh::ExodusII_IO_Helper::read_nodes(), write_nodal_coordinates(), and libMesh::ExodusII_IO_Helper::write_nodal_coordinates().
|
inherited |
Definition at line 519 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::print_nodes(), libMesh::ExodusII_IO_Helper::read_nodes(), write_nodal_coordinates(), and libMesh::ExodusII_IO_Helper::write_nodal_coordinates().
|
inherited |
Definition at line 522 of file exodusII_io_helper.h.
Referenced by libMesh::ExodusII_IO_Helper::print_nodes(), libMesh::ExodusII_IO_Helper::read_nodes(), write_nodal_coordinates(), and libMesh::ExodusII_IO_Helper::write_nodal_coordinates().