libMesh
|
This is the ExodusII_IO_Helper
class.
More...
#include <exodusII_io_helper.h>
Classes | |
class | Conversion |
struct | MappedInputVector |
This class facilitates reading in vectors from Exodus file that may be of a different floating point type than Real. More... | |
struct | MappedOutputVector |
This class facilitates inline conversion of an input data vector to a different precision level, depending on the underlying type of Real and whether or not the single_precision flag is set. More... | |
class | NamesData |
This class is useful for managing anything that requires a char ** input/output in ExodusII file. More... | |
Public Types | |
enum | ExodusVarType { NODAL =0, ELEMENTAL =1, GLOBAL =2, SIDESET =3, NODESET =4, ELEMSET =5 } |
Wraps calls to exII::ex_get_var_names() and exII::ex_get_var_param(). More... | |
Public Member Functions | |
ExodusII_IO_Helper (const ParallelObject &parent, bool v=false, bool run_only_on_proc0=true, bool single_precision=false) | |
Constructor. More... | |
ExodusII_IO_Helper (const ExodusII_IO_Helper &)=default | |
Special functions. More... | |
ExodusII_IO_Helper (ExodusII_IO_Helper &&)=default | |
virtual | ~ExodusII_IO_Helper () |
ExodusII_IO_Helper & | operator= (const ExodusII_IO_Helper &)=delete |
This class contains references so it can't be default copy/move-assigned. More... | |
ExodusII_IO_Helper & | operator= (ExodusII_IO_Helper &&)=delete |
const char * | get_elem_type () const |
void | set_add_sides (bool add_sides) |
Sets whether or not to write extra "side" elements. More... | |
bool | get_add_sides () |
void | open (const char *filename, bool read_only) |
Opens an ExodusII mesh file named filename . More... | |
ExodusHeaderInfo | read_header () const |
Reads an ExodusII mesh file header, leaving this object's internal data structures unchanged. More... | |
void | read_and_store_header_info () |
Reads an ExodusII mesh file header, and stores required information on this object. More... | |
void | read_qa_records () |
Reads the QA records from an ExodusII file. More... | |
void | print_header () |
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. More... | |
void | read_nodes () |
Reads the nodal data (x,y,z coordinates) from the ExodusII mesh file. More... | |
void | read_node_num_map () |
Reads the optional node_num_map from the ExodusII mesh file. More... | |
void | read_bex_cv_blocks () |
Reads the optional bex_cv_blocks from the ExodusII mesh file. More... | |
void | print_nodes (std::ostream &out_stream=libMesh::out) |
Prints the nodal information, by default to libMesh::out . More... | |
void | read_block_info () |
Reads information for all of the blocks in the ExodusII mesh file. More... | |
int | get_block_id (int index) |
Get the block number for the given block index. More... | |
std::string | get_block_name (int index) |
Get the block name for the given block index if supplied in the mesh file. More... | |
int | get_side_set_id (int index) |
Get the side set id for the given side set index. More... | |
std::string | get_side_set_name (int index) |
Get the side set name for the given side set index if supplied in the mesh file. More... | |
int | get_node_set_id (int index) |
Get the node set id for the given node set index. More... | |
std::string | get_node_set_name (int index) |
Get the node set name for the given node set index if supplied in the mesh file. More... | |
void | read_elem_in_block (int block) |
Reads all of the element connectivity for block block in the ExodusII mesh file. More... | |
void | read_edge_blocks (MeshBase &mesh) |
Read in edge blocks, storing information in the BoundaryInfo object. More... | |
void | read_elem_num_map () |
Reads the optional node_num_map from the ExodusII mesh file. More... | |
void | read_sideset_info () |
Reads information about all of the sidesets in the ExodusII mesh file. More... | |
void | read_nodeset_info () |
Reads information about all of the nodesets in the ExodusII mesh file. More... | |
void | read_elemset_info () |
Reads information about all of the elemsets in the ExodusII mesh file. More... | |
void | read_sideset (int id, int offset) |
Reads information about sideset id and inserts it into the global sideset array at the position offset . More... | |
void | read_elemset (int id, int offset) |
Reads information about elemset id and inserts it into the global elemset array at the position offset . More... | |
void | read_all_nodesets () |
New API that reads all nodesets simultaneously. More... | |
void | close () noexcept |
Closes the ExodusII mesh file. More... | |
void | read_time_steps () |
Reads and stores the timesteps in the 'time_steps' array. More... | |
void | read_num_time_steps () |
Reads the number of timesteps currently stored in the Exodus file and stores it in the num_time_steps variable. More... | |
void | read_nodal_var_values (std::string nodal_var_name, int time_step) |
Reads the nodal values for the variable 'nodal_var_name' at the specified time into the 'nodal_var_values' array. More... | |
void | read_elemental_var_values (std::string elemental_var_name, int time_step, std::map< dof_id_type, Real > &elem_var_value_map) |
Reads elemental values for the variable 'elemental_var_name' at the specified timestep into the 'elem_var_value_map' which is passed in. More... | |
virtual void | create (std::string filename) |
Opens an ExodusII mesh file named filename for writing. More... | |
virtual void | initialize (std::string title, const MeshBase &mesh, bool use_discontinuous=false) |
Initializes the Exodus file. More... | |
virtual void | write_nodal_coordinates (const MeshBase &mesh, bool use_discontinuous=false) |
Writes the nodal coordinates contained in "mesh". More... | |
virtual void | write_elements (const MeshBase &mesh, bool use_discontinuous=false) |
Writes the elements contained in "mesh". More... | |
virtual void | write_sidesets (const MeshBase &mesh) |
Writes the sidesets contained in "mesh". More... | |
virtual void | write_nodesets (const MeshBase &mesh) |
Writes the nodesets contained in "mesh". More... | |
virtual void | initialize_element_variables (std::vector< std::string > names, const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) |
Sets up the nodal variables. More... | |
void | initialize_nodal_variables (std::vector< std::string > names) |
Sets up the nodal variables. More... | |
void | initialize_global_variables (std::vector< std::string > names) |
Sets up the global variables. More... | |
void | write_timestep (int timestep, Real time) |
Writes the time for the timestep. More... | |
void | write_elemsets (const MeshBase &mesh) |
Write elemsets stored on the Mesh to the exo file. More... | |
void | write_sideset_data (const MeshBase &mesh, int timestep, const std::vector< std::string > &var_names, const std::vector< std::set< boundary_id_type >> &side_ids, const std::vector< std::map< BoundaryInfo::BCTuple, Real >> &bc_vals) |
Write sideset data for the requested timestep. More... | |
void | read_sideset_data (const MeshBase &mesh, int timestep, std::vector< std::string > &var_names, std::vector< std::set< boundary_id_type >> &side_ids, std::vector< std::map< BoundaryInfo::BCTuple, Real >> &bc_vals) |
Read sideset variables, if any, into the provided data structures. More... | |
void | get_sideset_data_indices (const MeshBase &mesh, std::map< BoundaryInfo::BCTuple, unsigned int > &bc_array_indices) |
Similar to read_sideset_data(), but instead of creating one std::map per sideset per variable, creates a single map of (elem, side, boundary_id) tuples, and stores the exo file array indexing for any/all sideset variables on that sideset (they are all the same). More... | |
void | write_nodeset_data (int timestep, const std::vector< std::string > &var_names, const std::vector< std::set< boundary_id_type >> &node_boundary_ids, const std::vector< std::map< BoundaryInfo::NodeBCTuple, Real >> &bc_vals) |
Write nodeset data for the requested timestep. More... | |
void | read_nodeset_data (int timestep, std::vector< std::string > &var_names, std::vector< std::set< boundary_id_type >> &node_boundary_ids, std::vector< std::map< BoundaryInfo::NodeBCTuple, Real >> &bc_vals) |
Read nodeset variables, if any, into the provided data structures. More... | |
void | get_nodeset_data_indices (std::map< BoundaryInfo::NodeBCTuple, unsigned int > &bc_array_indices) |
Similar to read_nodeset_data(), but instead of creating one std::map per nodeset per variable, creates a single map of (node_id, boundary_id) tuples, and stores the exo file array indexing for any/all nodeset variables on that nodeset (they are all the same). More... | |
void | write_elemset_data (int timestep, const std::vector< std::string > &var_names, const std::vector< std::set< elemset_id_type >> &elemset_ids_in, const std::vector< std::map< std::pair< dof_id_type, elemset_id_type >, Real >> &elemset_vals) |
Write elemset data for the requested timestep. More... | |
void | read_elemset_data (int timestep, std::vector< std::string > &var_names, std::vector< std::set< elemset_id_type >> &elemset_ids_in, std::vector< std::map< std::pair< dof_id_type, elemset_id_type >, Real >> &elemset_vals) |
Read elemset variables, if any, into the provided data structures. More... | |
void | get_elemset_data_indices (std::map< std::pair< dof_id_type, elemset_id_type >, unsigned int > &elemset_array_indices) |
Similar to read_elemset_data(), but instead of creating one std::map per elemset per variable, creates a single map of (elem_id, elemset_id) tuples, and stores the exo file array indexing for any/all elemset variables on that elemset (they are all the same). More... | |
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) |
Writes the vector of values to the element variables. More... | |
void | write_element_values_element_major (const MeshBase &mesh, const std::vector< Real > &values, int timestep, const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains, const std::vector< std::string > &derived_var_names, const std::map< subdomain_id_type, std::vector< std::string >> &subdomain_to_var_names) |
Same as the function above, but assume the input 'values' vector is in element-major order, i.e. More... | |
void | write_nodal_values (int var_id, const std::vector< Real > &values, int timestep) |
Writes the vector of values to a nodal variable. More... | |
void | write_information_records (const std::vector< std::string > &records) |
Writes the vector of information records. More... | |
void | write_global_values (const std::vector< Real > &values, int timestep) |
Writes the vector of global variables. More... | |
void | update () |
Uses ex_update() to flush buffers to file. More... | |
void | read_global_values (std::vector< Real > &values, int timestep) |
Reads the vector of global variables. More... | |
void | use_mesh_dimension_instead_of_spatial_dimension (bool val) |
Sets the underlying value of the boolean flag _use_mesh_dimension_instead_of_spatial_dimension. More... | |
void | set_hdf5_writing (bool write_hdf5) |
Set to true (the default) to write files in an HDF5-based file format (when HDF5 is available), or to false to write files in the old NetCDF3-based format. More... | |
void | write_as_dimension (unsigned dim) |
Sets the value of _write_as_dimension. More... | |
void | set_coordinate_offset (Point p) |
Allows you to set a vector that is added to the coordinates of all of the nodes. More... | |
std::vector< std::string > | get_complex_names (const std::vector< std::string > &names, bool write_complex_abs) const |
std::vector< std::set< subdomain_id_type > > | get_complex_vars_active_subdomains (const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains, bool write_complex_abs) const |
returns a "tripled" copy of vars_active_subdomains , which is necessary in the complex-valued case. More... | |
std::map< subdomain_id_type, std::vector< std::string > > | get_complex_subdomain_to_var_names (const std::map< subdomain_id_type, std::vector< std::string >> &subdomain_to_var_names, bool write_complex_abs) const |
Takes a map from subdomain id -> vector of active variable names as input and returns a corresponding map where the original variable names have been replaced by their complex counterparts. More... | |
void | message (std::string_view msg) |
Prints the message defined in msg . More... | |
void | message (std::string_view msg, int i) |
Prints the message defined in msg , and appends the number i to the end of the message. More... | |
int | end_elem_id () const |
void | read_var_names (ExodusVarType type) |
const ExodusII_IO_Helper::Conversion & | get_conversion (const ElemType type) const |
const ExodusII_IO_Helper::Conversion & | get_conversion (std::string type_str) const |
dof_id_type | node_id_to_vec_id (dof_id_type n) const |
dof_id_type | added_node_offset_on (processor_id_type p) const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
Static Public Member Functions | |
static int | get_exodus_version () |
Protected Member Functions | |
void | check_existing_vars (ExodusVarType type, std::vector< std::string > &names, std::vector< std::string > &names_from_file) |
When appending: during initialization, check that variable names in the file match those you attempt to initialize with. More... | |
void | write_var_names (ExodusVarType type, const std::vector< std::string > &names) |
Wraps calls to exII::ex_put_var_names() and exII::ex_put_var_param(). More... | |
virtual void | read_var_names_impl (const char *var_type, int &count, std::vector< std::string > &result) |
read_var_names() dispatches to this function. More... | |
Protected Attributes | |
bool | _run_only_on_proc0 |
bool | _opened_by_create |
bool | _elem_vars_initialized |
bool | _global_vars_initialized |
bool | _nodal_vars_initialized |
bool | _use_mesh_dimension_instead_of_spatial_dimension |
bool | _write_hdf5 |
int | _end_elem_id |
unsigned | _write_as_dimension |
Point | _coordinate_offset |
bool | _single_precision |
std::vector< dof_id_type > | _added_side_node_offsets |
If we're adding "fake" sides to visualize SIDE_DISCONTINUOUS variables, _added_side_node_offsets[p] gives us the total solution vector offset to use on processor p+1 from the nodes on those previous ranks' sides. More... | |
std::vector< dof_id_type > | _true_node_offsets |
If we're adding "fake" sides to visualize SIDE_DISCONTINUOUS variables, we also need to know how many real nodes from previous ranks are taking up space in a solution vector. More... | |
const Parallel::Communicator & | _communicator |
Private Member Functions | |
void | write_var_names_impl (const char *var_type, int &count, const std::vector< std::string > &names) |
write_var_names() dispatches to this function. More... | |
void | init_element_equivalence_map () |
void | init_conversion_map () |
Private Attributes | |
bool | _add_sides = false |
Set to true iff we want to write separate "side" elements too. More... | |
std::map< std::string, ElemType > | element_equivalence_map |
Defines equivalence classes of Exodus element types that map to libmesh ElemTypes. More... | |
std::map< int, std::map< ElemType, ExodusII_IO_Helper::Conversion > > | conversion_map |
Associates libMesh ElemTypes with node/face/edge/etc. More... | |
This is the ExodusII_IO_Helper
class.
This class hides the implementation details of interfacing with the Exodus binary format.
Definition at line 73 of file exodusII_io_helper.h.
Wraps calls to exII::ex_get_var_names() and exII::ex_get_var_param().
The enumeration controls whether nodal, elemental, global, etc. 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 SIDESET: num_sideset_vars sideset_var_names NODESET: num_nodeset_vars nodeset_var_names
Enumerator | |
---|---|
NODAL | |
ELEMENTAL | |
GLOBAL | |
SIDESET | |
NODESET | |
ELEMSET |
Definition at line 881 of file exodusII_io_helper.h.
libMesh::ExodusII_IO_Helper::ExodusII_IO_Helper | ( | const ParallelObject & | parent, |
bool | v = false , |
||
bool | run_only_on_proc0 = true , |
||
bool | single_precision = false |
||
) |
Constructor.
Automatically initializes all the private members of the class. Also allows you to set the verbosity level to v=true (on) or v=false (off). The second argument, if true, tells the class to only perform its actions if running on processor zero. If you initialize this to false, the writing methods will run on all processors instead.
Definition at line 257 of file exodusII_io_helper.C.
References elem_type, init_conversion_map(), init_element_equivalence_map(), and title.
|
default |
Special functions.
This class does not manage any dynamically allocated resources (file pointers, etc.) so it should be default copy/move constructable, but I don't know if any existing code actually uses these operations.
|
default |
|
virtualdefault |
|
inline |
Definition at line 915 of file exodusII_io_helper.h.
References _added_side_node_offsets, _true_node_offsets, and libMesh::libmesh_assert().
|
protected |
When appending: during initialization, check that variable names in the file match those you attempt to initialize with.
Definition at line 3353 of file exodusII_io_helper.C.
References libMesh::err, libMesh::Quality::name(), and read_var_names().
Referenced by initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), initialize_global_variables(), and initialize_nodal_variables().
|
noexcept |
Closes the ExodusII
mesh file.
This function is called from the ExodusII_IO destructor, so it should not throw an exception.
Definition at line 1772 of file exodusII_io_helper.C.
References _opened_by_create, _run_only_on_proc0, ex_err, ex_id, message(), opened_for_reading, opened_for_writing, and libMesh::ParallelObject::processor_id().
Referenced by libMesh::Nemesis_IO_Helper::~Nemesis_IO_Helper().
|
inlineinherited |
Parallel::Communicator
object used by this mesh. Definition at line 97 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::Partitioner::_find_global_index_by_pid_map(), libMesh::BoundaryInfo::_find_id_maps(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_get_diagonal(), libMesh::SlepcEigenSolver< libMesh::Number >::_petsc_shell_matrix_get_diagonal(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_mult(), libMesh::SlepcEigenSolver< libMesh::Number >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_mult_add(), libMesh::MeshRefinement::_refine_elements(), libMesh::MeshRefinement::_smooth_flags(), libMesh::DofMap::add_constraints_to_send_list(), add_cube_convex_hull_to_mesh(), libMesh::PetscDMWrapper::add_dofs_helper(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::TransientRBConstruction::add_IC_to_RB_space(), libMesh::RBEIMEvaluation::add_interpolation_data(), libMesh::CondensedEigenSystem::add_matrices(), libMesh::EigenSystem::add_matrices(), libMesh::System::add_matrix(), libMesh::RBConstruction::add_scaled_matrix_and_vector(), libMesh::System::add_variable(), libMesh::System::add_variables(), libMesh::System::add_vector(), libMesh::MeshTools::Modification::all_tri(), libMesh::LaplaceMeshSmoother::allgather_graph(), libMesh::DofMap::allgather_recursive_constraints(), libMesh::TransientRBConstruction::allocate_data_structures(), libMesh::RBConstruction::allocate_data_structures(), libMesh::TransientRBConstruction::assemble_affine_expansion(), libMesh::AdvectionSystem::assemble_claw_rhs(), libMesh::FEMSystem::assemble_qoi(), libMesh::Nemesis_IO::assert_symmetric_cmaps(), libMesh::MeshCommunication::assign_global_indices(), libMesh::Partitioner::assign_partitioning(), libMesh::MeshTools::Generation::build_extrusion(), libMesh::Partitioner::build_graph(), 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_data(), libMesh::System::calculate_norm(), libMesh::DofMap::check_dirichlet_bcid_consistency(), libMesh::RBConstruction::compute_Fq_representor_innerprods(), libMesh::RBConstruction::compute_max_error_bound(), libMesh::Nemesis_IO_Helper::compute_num_global_elem_blocks(), libMesh::Nemesis_IO_Helper::compute_num_global_nodesets(), libMesh::Nemesis_IO_Helper::compute_num_global_sidesets(), libMesh::RBConstruction::compute_output_dual_innerprods(), libMesh::RBConstruction::compute_residual_dual_norm_slow(), libMesh::RBSCMConstruction::compute_SCM_bounds_on_training_set(), libMesh::DofMap::computed_sparsity_already(), libMesh::Problem_Interface::computeF(), libMesh::Problem_Interface::computeJacobian(), libMesh::Problem_Interface::computePreconditioner(), libMesh::ContinuationSystem::ContinuationSystem(), libMesh::MeshBase::copy_constraint_rows(), libMesh::ExodusII_IO::copy_elemental_solution(), libMesh::ExodusII_IO::copy_nodal_solution(), libMesh::ExodusII_IO::copy_scalar_solution(), libMesh::CondensedEigenSystem::copy_super_to_sub(), libMesh::MeshTools::correct_node_proc_ids(), libMesh::MeshTools::create_bounding_box(), libMesh::DofMap::create_dof_constraints(), 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::PetscMatrix< T >::create_submatrix_nosort(), create_wrapped_function(), libMesh::MeshCommunication::delete_remote_elements(), libMesh::RBEIMEvaluation::distribute_bfs(), DMlibMeshFunction(), DMlibMeshJacobian(), DMlibMeshSetSystem_libMesh(), DMVariableBounds_libMesh(), libMesh::DTKSolutionTransfer::DTKSolutionTransfer(), libMesh::MeshRefinement::eliminate_unrefined_patches(), libMesh::RBEIMConstruction::enrich_eim_approximation_on_interiors(), libMesh::RBEIMConstruction::enrich_eim_approximation_on_nodes(), libMesh::RBEIMConstruction::enrich_eim_approximation_on_sides(), libMesh::TransientRBConstruction::enrich_RB_space(), libMesh::EpetraVector< T >::EpetraVector(), AssembleOptimization::equality_constraints(), libMesh::PatchRecoveryErrorEstimator::estimate_error(), libMesh::WeightedPatchRecoveryErrorEstimator::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_error_tolerance(), libMesh::MeshRefinement::flag_elements_by_mean_stddev(), libMesh::MeshRefinement::flag_elements_by_nelem_target(), libMesh::RBEIMEvaluation::gather_bfs(), libMesh::DofMap::gather_constraints(), libMesh::MeshfreeInterpolation::gather_remote_data(), libMesh::CondensedEigenSystem::get_eigenpair(), libMesh::RBEIMEvaluation::get_eim_basis_function_node_value(), libMesh::RBEIMEvaluation::get_eim_basis_function_side_value(), libMesh::RBEIMEvaluation::get_eim_basis_function_value(), libMesh::MeshBase::get_info(), libMesh::System::get_info(), libMesh::DofMap::get_info(), libMesh::RBEIMEvaluation::get_interior_basis_functions_as_vecs(), libMesh::ImplicitSystem::get_linear_solver(), libMesh::RBEIMConstruction::get_max_abs_value(), libMesh::RBEIMConstruction::get_node_max_abs_value(), libMesh::RBEIMEvaluation::get_parametrized_function_node_value(), libMesh::RBEIMEvaluation::get_parametrized_function_side_value(), libMesh::RBEIMEvaluation::get_parametrized_function_value(), libMesh::RBEIMConstruction::get_random_point(), AssembleOptimization::inequality_constraints(), AssembleOptimization::inequality_constraints_jacobian(), libMesh::LocationMap< T >::init(), libMesh::TimeSolver::init(), libMesh::StaticCondensation::init(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), libMesh::AdvectionSystem::init_data(), libMesh::ClawSystem::init_data(), libMesh::PetscDMWrapper::init_petscdm(), initialize(), libMesh::OptimizationSystem::initialize_equality_constraints_storage(), libMesh::OptimizationSystem::initialize_inequality_constraints_storage(), libMesh::RBEIMConstruction::initialize_parametrized_functions_in_training_set(), libMesh::RBEIMConstruction::inner_product(), integrate_function(), libMesh::MeshTools::libmesh_assert_consistent_distributed(), libMesh::MeshTools::libmesh_assert_consistent_distributed_nodes(), libMesh::MeshTools::libmesh_assert_contiguous_dof_ids(), libMesh::MeshTools::libmesh_assert_equal_connectivity(), libMesh::MeshTools::libmesh_assert_equal_points(), 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_constraint_rows(), 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_linesearch_shellfunc(), libMesh::libmesh_petsc_preconditioner_apply(), libMesh::libmesh_petsc_recalculate_monitor(), libMesh::libmesh_petsc_snes_fd_residual(), libMesh::libmesh_petsc_snes_jacobian(), libMesh::libmesh_petsc_snes_mffd_interface(), libMesh::libmesh_petsc_snes_mffd_residual(), libMesh::libmesh_petsc_snes_postcheck(), libMesh::libmesh_petsc_snes_precheck(), 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::LinearImplicitSystem::LinearImplicitSystem(), main(), 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_bcids_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::TransientRBConstruction::mass_matrix_scaled_matvec(), libMesh::FEMSystem::mesh_position_set(), libMesh::TriangulatorInterface::MeshedHole::MeshedHole(), LinearElasticityWithContact::move_mesh(), libMesh::DistributedMesh::n_active_elem(), libMesh::MeshTools::n_active_levels(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::MeshTools::n_connected_components(), libMesh::DofMap::n_constrained_dofs(), libMesh::MeshBase::n_constraint_rows(), libMesh::DofMap::n_dofs(), libMesh::DofMap::n_dofs_per_processor(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::CondensedEigenSystem::n_global_non_condensed_dofs(), libMesh::MeshTools::n_levels(), MixedOrderTest::n_neighbor_links(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::SparsityPattern::Build::n_nonzeros(), libMesh::MeshTools::n_p_levels(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::RBEIMEvaluation::node_distribute_bfs(), libMesh::RBEIMEvaluation::node_gather_bfs(), libMesh::RBEIMConstruction::node_inner_product(), libMesh::MeshBase::operator==(), 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::BoundaryInfo::parallel_sync_node_ids(), libMesh::BoundaryInfo::parallel_sync_side_ids(), libMesh::MeshTools::paranoid_n_levels(), libMesh::Partitioner::partition(), libMesh::Partitioner::partition_unpartitioned_elements(), libMesh::petsc_auto_fieldsplit(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::MeshBase::prepare_for_use(), libMesh::MeshBase::print_constraint_rows(), libMesh::DofMap::print_dof_constraints(), libMesh::DofMap::process_mesh_constraint_rows(), libMesh::Partitioner::processor_pairs_to_interface_nodes(), libMesh::InterMeshProjection::project_system_vectors(), FEMParameters::read(), libMesh::Nemesis_IO::read(), libMesh::XdrIO::read(), libMesh::EquationSystems::read(), libMesh::ExodusII_IO::read_header(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), libMesh::RBEIMEvaluation::read_in_interior_basis_functions(), libMesh::RBEIMEvaluation::read_in_node_basis_functions(), libMesh::RBEIMEvaluation::read_in_side_basis_functions(), libMesh::RBEvaluation::read_in_vectors_from_multiple_files(), libMesh::System::read_legacy_data(), libMesh::TransientRBConstruction::read_riesz_representors_from_files(), libMesh::RBConstruction::read_riesz_representors_from_files(), 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::Nemesis_IO_Helper::read_var_names_impl(), libMesh::MeshBase::recalculate_n_partitions(), libMesh::MeshRefinement::refine_and_coarsen_elements(), libMesh::SimplexRefiner::refine_via_edges(), libMesh::StaticCondensationDofMap::reinit(), libMesh::DistributedMesh::renumber_dof_objects(), libMesh::DistributedMesh::renumber_nodes_and_elements(), LinearElasticityWithContact::residual_and_jacobian(), OverlappingAlgebraicGhostingTest::run_ghosting_test(), OverlappingCouplingGhostingTest::run_sparsity_pattern_test(), scale_mesh_and_plot(), libMesh::DofMap::scatter_constraints(), libMesh::CheckpointIO::select_split_config(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::send_and_insert_dof_values(), libMesh::TransientRBConstruction::set_error_temporal_data(), libMesh::Partitioner::set_interface_node_processor_ids_BFS(), libMesh::Partitioner::set_interface_node_processor_ids_linear(), libMesh::Partitioner::set_interface_node_processor_ids_petscpartitioner(), libMesh::Partitioner::set_node_processor_ids(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::Partitioner::set_parent_processor_ids(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::PetscDiffSolver::setup_petsc_data(), libMesh::RBEIMEvaluation::side_distribute_bfs(), libMesh::RBEIMEvaluation::side_gather_bfs(), libMesh::RBEIMConstruction::side_inner_product(), libMesh::Partitioner::single_partition(), libMesh::LaplaceMeshSmoother::smooth(), libMesh::VariationalMeshSmoother::smooth(), libMesh::ClawSystem::solve_conservation_law(), libMesh::split_mesh(), libMesh::RBEIMConstruction::store_eim_solutions_for_training_set(), libMesh::MeshBase::subdomain_ids(), libMesh::BoundaryInfo::sync(), ConstraintOperatorTest::test1DCoarseningNewNodes(), ConstraintOperatorTest::test1DCoarseningOperator(), libMesh::MeshRefinement::test_level_one(), MeshfunctionDFEM::test_mesh_function_dfem(), MeshfunctionDFEM::test_mesh_function_dfem_grad(), MeshFunctionTest::test_p_level(), libMesh::MeshRefinement::test_unflagged(), DofMapTest::testBadElemFECombo(), SystemsTest::testBlockRestrictedVarNDofs(), BoundaryInfoTest::testBoundaryOnChildrenErrors(), VolumeTest::testC0PolygonMethods(), VolumeTest::testC0PolyhedronMethods(), ConstraintOperatorTest::testCoreform(), ConnectedComponentsTest::testEdge(), MeshInputTest::testExodusIGASidesets(), MeshTriangulationTest::testFoundCenters(), PointLocatorTest::testLocator(), BoundaryInfoTest::testMesh(), PointLocatorTest::testPlanar(), MeshTriangulationTest::testPoly2TriRefinementBase(), SystemsTest::testProjectCubeWithMeshFunction(), BoundaryInfoTest::testRenumber(), CheckpointIOTest::testSplitter(), MeshInputTest::testTetgenIO(), MeshTriangulationTest::testTriangulatorInterp(), MeshTriangulationTest::testTriangulatorMeshedHoles(), MeshTriangulationTest::testTriangulatorRoundHole(), libMesh::MeshTools::total_weight(), libMesh::RBConstruction::train_reduced_basis_with_POD(), libMesh::MeshFunctionSolutionTransfer::transfer(), libMesh::MeshfreeSolutionTransfer::transfer(), libMesh::Poly2TriTriangulator::triangulate(), libMesh::TransientRBConstruction::truth_assembly(), libMesh::RBConstruction::truth_assembly(), libMesh::MeshRefinement::uniformly_coarsen(), update_current_local_solution(), libMesh::TransientRBConstruction::update_RB_initial_condition_all_N(), libMesh::TransientRBConstruction::update_RB_system_matrices(), libMesh::RBConstruction::update_RB_system_matrices(), libMesh::TransientRBConstruction::update_residual_terms(), libMesh::RBConstruction::update_residual_terms(), libMesh::MeshTools::volume(), libMesh::STLIO::write(), libMesh::NameBasedIO::write(), libMesh::XdrIO::write(), libMesh::VTKIO::write_nodal_data(), libMesh::RBEIMEvaluation::write_out_interior_basis_functions(), libMesh::RBEIMEvaluation::write_out_node_basis_functions(), libMesh::RBEIMEvaluation::write_out_side_basis_functions(), libMesh::RBEvaluation::write_out_vectors(), libMesh::TransientRBConstruction::write_riesz_representors_to_files(), libMesh::RBConstruction::write_riesz_representors_to_files(), 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(), libMesh::XdrIO::write_serialized_nodesets(), libMesh::RBDataSerialization::RBEvaluationSerialization::write_to_file(), libMesh::RBDataSerialization::TransientRBEvaluationSerialization::write_to_file(), libMesh::RBDataSerialization::RBEIMEvaluationSerialization::write_to_file(), and libMesh::RBDataSerialization::RBSCMEvaluationSerialization::write_to_file().
|
virtual |
Opens an ExodusII
mesh file named filename
for writing.
Definition at line 2145 of file exodusII_io_helper.C.
References _opened_by_create, _run_only_on_proc0, _single_precision, _write_hdf5, current_filename, ex_id, opened_for_writing, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::Real, and verbose.
|
inline |
Definition at line 1301 of file exodusII_io_helper.h.
References _end_elem_id, elem_num_map, and num_elem.
|
inline |
Definition at line 1295 of file exodusII_io_helper.h.
References _add_sides.
Get the block number for the given block index.
Definition at line 1090 of file exodusII_io_helper.C.
References block_ids.
Referenced by write_element_values(), and write_element_values_element_major().
std::string libMesh::ExodusII_IO_Helper::get_block_name | ( | int | index | ) |
Get the block name for the given block index if supplied in the mesh file.
Otherwise an empty string is returned.
Definition at line 1099 of file exodusII_io_helper.C.
References block_ids, and id_to_block_names.
std::vector< std::string > libMesh::ExodusII_IO_Helper::get_complex_names | ( | const std::vector< std::string > & | names, |
bool | write_complex_abs | ||
) | const |
Definition at line 4698 of file exodusII_io_helper.C.
References libMesh::Quality::name().
std::map< subdomain_id_type, std::vector< std::string > > libMesh::ExodusII_IO_Helper::get_complex_subdomain_to_var_names | ( | const std::map< subdomain_id_type, std::vector< std::string >> & | subdomain_to_var_names, |
bool | write_complex_abs | ||
) | const |
Takes a map from subdomain id -> vector of active variable names as input and returns a corresponding map where the original variable names have been replaced by their complex counterparts.
Used by the ExodusII_IO::write_element_data_from_discontinuous_nodal_data() function.
Definition at line 4744 of file exodusII_io_helper.C.
std::vector< std::set< subdomain_id_type > > libMesh::ExodusII_IO_Helper::get_complex_vars_active_subdomains | ( | const std::vector< std::set< subdomain_id_type >> & | vars_active_subdomains, |
bool | write_complex_abs | ||
) | const |
returns a "tripled" copy of vars_active_subdomains
, which is necessary in the complex-valued case.
Definition at line 4721 of file exodusII_io_helper.C.
const ExodusII_IO_Helper::Conversion & libMesh::ExodusII_IO_Helper::get_conversion | ( | const ElemType | type | ) | const |
Definition at line 542 of file exodusII_io_helper.C.
References conversion_map, and num_dim.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Nemesis_IO_Helper::compute_internal_and_border_elems_and_internal_nodes(), get_conversion(), get_sideset_data_indices(), read_edge_blocks(), read_elem_in_block(), read_sideset_data(), libMesh::Nemesis_IO_Helper::write_elements(), write_elements(), write_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), and write_sidesets().
const ExodusII_IO_Helper::Conversion & libMesh::ExodusII_IO_Helper::get_conversion | ( | std::string | type_str | ) | const |
Definition at line 549 of file exodusII_io_helper.C.
References element_equivalence_map, and get_conversion().
const char * libMesh::ExodusII_IO_Helper::get_elem_type | ( | ) | const |
HEX27
. Definition at line 556 of file exodusII_io_helper.C.
References elem_type.
void libMesh::ExodusII_IO_Helper::get_elemset_data_indices | ( | std::map< std::pair< dof_id_type, elemset_id_type >, unsigned int > & | elemset_array_indices | ) |
Similar to read_elemset_data(), but instead of creating one std::map per elemset per variable, creates a single map of (elem_id, elemset_id) tuples, and stores the exo file array indexing for any/all elemset variables on that elemset (they are all the same).
Definition at line 4142 of file exodusII_io_helper.C.
References elemset_ids, elemset_list, num_elem_sets, and num_elems_per_set.
|
static |
Definition at line 314 of file exodusII_io_helper.C.
Referenced by libMesh::ExodusII_IO::get_exodus_version().
Get the node set id for the given node set index.
Definition at line 1126 of file exodusII_io_helper.C.
References nodeset_ids.
std::string libMesh::ExodusII_IO_Helper::get_node_set_name | ( | int | index | ) |
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 1135 of file exodusII_io_helper.C.
References id_to_ns_names, and nodeset_ids.
void libMesh::ExodusII_IO_Helper::get_nodeset_data_indices | ( | std::map< BoundaryInfo::NodeBCTuple, unsigned int > & | bc_array_indices | ) |
Similar to read_nodeset_data(), but instead of creating one std::map per nodeset per variable, creates a single map of (node_id, boundary_id) tuples, and stores the exo file array indexing for any/all nodeset variables on that nodeset (they are all the same).
Definition at line 4284 of file exodusII_io_helper.C.
References node_sets_node_list, nodeset_ids, num_node_sets, and num_nodes_per_set.
Get the side set id for the given side set index.
Definition at line 1108 of file exodusII_io_helper.C.
References ss_ids.
std::string libMesh::ExodusII_IO_Helper::get_side_set_name | ( | int | index | ) |
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 1117 of file exodusII_io_helper.C.
References id_to_ss_names, and ss_ids.
void libMesh::ExodusII_IO_Helper::get_sideset_data_indices | ( | const MeshBase & | mesh, |
std::map< BoundaryInfo::BCTuple, unsigned int > & | bc_array_indices | ||
) |
Similar to read_sideset_data(), but instead of creating one std::map per sideset per variable, creates a single map of (elem, side, boundary_id) tuples, and stores the exo file array indexing for any/all sideset variables on that sideset (they are all the same).
This function does not actually call exII::ex_get_sset_var() to get values, and can be useful if only the original ordering of (elem, side) pairs in the exo file is required in cases where a separate approach is used to read the sideset data arrays.
Definition at line 3757 of file exodusII_io_helper.C.
References elem_list, libMesh::MeshBase::elem_ptr(), get_conversion(), libMesh::ExodusII_IO_Helper::Conversion::get_side_map(), mesh, num_side_sets, num_sides_per_set, side_list, ss_ids, and libMesh::Elem::type().
|
private |
Definition at line 322 of file exodusII_io_helper.C.
References libMesh::Elem::build(), conversion_map, libMesh::EDGE2, libMesh::EDGE3, libMesh::EDGE4, libMesh::HEX20, libMesh::HEX27, libMesh::HEX8, libMesh::NODEELEM, libMesh::PRISM15, libMesh::PRISM18, libMesh::PRISM20, libMesh::PRISM21, libMesh::PRISM6, libMesh::PYRAMID13, libMesh::PYRAMID14, libMesh::PYRAMID18, libMesh::PYRAMID5, libMesh::QUAD4, libMesh::QUAD8, libMesh::QUAD9, libMesh::QUADSHELL4, libMesh::QUADSHELL8, libMesh::QUADSHELL9, libMesh::TET10, libMesh::TET14, libMesh::TET4, libMesh::TRI3, libMesh::TRI3SUBDIVISION, libMesh::TRI6, libMesh::TRI7, and libMesh::TRISHELL3.
Referenced by ExodusII_IO_Helper().
|
private |
Definition at line 419 of file exodusII_io_helper.C.
References libMesh::EDGE2, libMesh::EDGE3, libMesh::EDGE4, element_equivalence_map, libMesh::HEX20, libMesh::HEX27, libMesh::HEX8, libMesh::NODEELEM, libMesh::PRISM15, libMesh::PRISM18, libMesh::PRISM20, libMesh::PRISM21, libMesh::PRISM6, libMesh::PYRAMID13, libMesh::PYRAMID14, libMesh::PYRAMID18, libMesh::PYRAMID5, libMesh::QUAD4, libMesh::QUAD8, libMesh::QUAD9, libMesh::QUADSHELL4, libMesh::QUADSHELL8, libMesh::QUADSHELL9, libMesh::TET10, libMesh::TET14, libMesh::TET4, libMesh::TRI3, libMesh::TRI6, libMesh::TRI7, and libMesh::TRISHELL3.
Referenced by ExodusII_IO_Helper().
|
virtual |
Initializes the Exodus file.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 2205 of file exodusII_io_helper.C.
References _add_sides, _added_side_node_offsets, _run_only_on_proc0, _true_node_offsets, _use_mesh_dimension_instead_of_spatial_dimension, _write_as_dimension, TIMPI::Communicator::allgather(), libMesh::BoundaryInfo::build_node_boundary_ids(), libMesh::BoundaryInfo::build_shellface_boundary_ids(), libMesh::BoundaryInfo::build_side_boundary_ids(), libMesh::ParallelObject::comm(), distance(), libMesh::err, ex_err, ex_id, libMesh::MeshBase::get_boundary_info(), libMesh::BoundaryInfo::get_edge_boundary_ids(), libMesh::BoundaryInfo::get_nodeset_name_map(), libMesh::BoundaryInfo::get_sideset_name_map(), libMesh::MeshBase::has_elem_integer(), libMesh::make_range(), libMesh::MeshBase::max_node_id(), mesh, libMesh::MeshBase::mesh_dimension(), libMesh::MeshBase::n_active_elem(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::MeshBase::n_elemsets(), libMesh::ParallelObject::n_processors(), num_dim, num_edge, num_edge_blk, num_elem, num_elem_blk, num_elem_sets, num_node_sets, num_nodes, num_side_sets, libMesh::ParallelObject::processor_id(), libMesh::EquationSystems::redundant_added_side(), libMesh::MeshBase::spatial_dimension(), and TIMPI::Communicator::sum().
|
virtual |
Sets up the nodal variables.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 3232 of file exodusII_io_helper.C.
References _elem_vars_initialized, _run_only_on_proc0, block_ids, check_existing_vars(), distance(), elem_var_names, ELEMENTAL, ex_err, ex_id, libMesh::index_range(), num_elem_blk, num_elem_vars, libMesh::ParallelObject::processor_id(), and write_var_names().
void libMesh::ExodusII_IO_Helper::initialize_global_variables | ( | std::vector< std::string > | names | ) |
Sets up the global variables.
Definition at line 3327 of file exodusII_io_helper.C.
References _global_vars_initialized, _run_only_on_proc0, check_existing_vars(), GLOBAL, global_var_names, num_global_vars, libMesh::ParallelObject::processor_id(), and write_var_names().
void libMesh::ExodusII_IO_Helper::initialize_nodal_variables | ( | std::vector< std::string > | names | ) |
Sets up the nodal variables.
Definition at line 3299 of file exodusII_io_helper.C.
References _nodal_vars_initialized, _run_only_on_proc0, check_existing_vars(), NODAL, nodal_var_names, num_nodal_vars, libMesh::ParallelObject::processor_id(), and write_var_names().
void libMesh::ExodusII_IO_Helper::message | ( | std::string_view | msg | ) |
Prints the message defined in msg
.
Can be turned off if verbosity is set to 0.
Definition at line 563 of file exodusII_io_helper.C.
References libMesh::out, and verbose.
Referenced by close(), read_and_store_header_info(), read_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_elemset(), read_elemset_info(), read_node_num_map(), read_nodes(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_info(), read_sideset(), and read_sideset_info().
void libMesh::ExodusII_IO_Helper::message | ( | std::string_view | msg, |
int | i | ||
) |
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 570 of file exodusII_io_helper.C.
References libMesh::out, and verbose.
|
inlineinherited |
Definition at line 103 of file parallel_object.h.
References libMesh::ParallelObject::_communicator, libMesh::libmesh_assert(), and TIMPI::Communicator::size().
Referenced by libMesh::Partitioner::_find_global_index_by_pid_map(), libMesh::BoundaryInfo::_find_id_maps(), libMesh::DofMap::add_constraints_to_send_list(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::DistributedMesh::add_elem(), libMesh::DofMap::add_neighbors_to_send_list(), libMesh::DistributedMesh::add_node(), libMesh::System::add_vector(), libMesh::LaplaceMeshSmoother::allgather_graph(), libMesh::DofMap::allgather_recursive_constraints(), libMesh::FEMSystem::assembly(), libMesh::Nemesis_IO::assert_symmetric_cmaps(), libMesh::Partitioner::assign_partitioning(), libMesh::AztecLinearSolver< T >::AztecLinearSolver(), libMesh::Partitioner::build_graph(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::DistributedMesh::clear(), libMesh::DistributedMesh::clear_elems(), libMesh::Nemesis_IO_Helper::compute_border_node_ids(), libMesh::Nemesis_IO_Helper::construct_nemesis_filename(), libMesh::UnstructuredMesh::copy_nodes_and_elements(), libMesh::ExodusII_IO::copy_scalar_solution(), libMesh::Nemesis_IO::copy_scalar_solution(), libMesh::UnstructuredMesh::create_pid_mesh(), libMesh::MeshTools::create_processor_bounding_box(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_scalar_dofs(), libMesh::DistributedMesh::DistributedMesh(), libMesh::EnsightIO::EnsightIO(), libMesh::RBEIMEvaluation::gather_bfs(), libMesh::MeshBase::get_info(), libMesh::StaticCondensation::init(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_petscdm(), libMesh::Nemesis_IO_Helper::initialize(), 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::DofMap::n_dofs_per_processor(), libMesh::MeshBase::n_elem_on_proc(), libMesh::MeshBase::n_nodes_on_proc(), libMesh::RBEIMEvaluation::node_gather_bfs(), libMesh::Partitioner::partition(), libMesh::MeshBase::partition(), libMesh::Partitioner::partition_unpartitioned_elements(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::DofMap::prepare_send_list(), libMesh::MeshBase::print_constraint_rows(), libMesh::DofMap::print_dof_constraints(), 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::Partitioner::repartition(), OverlappingFunctorTest::run_partitioner_test(), libMesh::DofMap::scatter_constraints(), libMesh::DistributedMesh::set_next_unique_id(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), WriteVecAndScalar::setupTests(), libMesh::RBEIMEvaluation::side_gather_bfs(), DistributedMeshTest::testRemoteElemError(), CheckpointIOTest::testSplitter(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::GMVIO::write_binary(), libMesh::GMVIO::write_discontinuous_gmv(), write_nodal_coordinates(), libMesh::VTKIO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data(), 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().
|
inline |
Definition at line 896 of file exodusII_io_helper.h.
References _added_side_node_offsets, _true_node_offsets, and libMesh::libmesh_assert().
void libMesh::ExodusII_IO_Helper::open | ( | const char * | filename, |
bool | read_only | ||
) |
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 662 of file exodusII_io_helper.C.
References _single_precision, current_filename, ex_id, opened_for_reading, opened_for_writing, libMesh::out, libMesh::Real, and verbose.
|
delete |
This class contains references so it can't be default copy/move-assigned.
|
delete |
void libMesh::ExodusII_IO_Helper::print_header | ( | ) |
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 831 of file exodusII_io_helper.C.
References num_dim, num_elem, num_elem_blk, num_elem_sets, num_node_sets, num_nodes, num_side_sets, libMesh::out, title, and verbose.
void libMesh::ExodusII_IO_Helper::print_nodes | ( | std::ostream & | out_stream = libMesh::out | ) |
Prints the nodal information, by default to libMesh::out
.
Definition at line 1032 of file exodusII_io_helper.C.
References num_nodes, x, y, and z.
|
inlineinherited |
Definition at line 114 of file parallel_object.h.
References libMesh::ParallelObject::_communicator, and TIMPI::Communicator::rank().
Referenced by libMesh::BoundaryInfo::_find_id_maps(), 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::MeshTools::Modification::all_tri(), libMesh::DofMap::allgather_recursive_constraints(), libMesh::FEMSystem::assembly(), libMesh::Nemesis_IO::assert_symmetric_cmaps(), libMesh::Partitioner::assign_partitioning(), libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Partitioner::build_graph(), libMesh::InfElemBuilder::build_inf_elem(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::MeshFunction::check_found_elem(), libMesh::DistributedMesh::clear(), libMesh::DistributedMesh::clear_elems(), close(), libMesh::Nemesis_IO_Helper::compute_border_node_ids(), libMesh::Nemesis_IO_Helper::compute_communication_map_parameters(), libMesh::Nemesis_IO_Helper::compute_internal_and_border_elems_and_internal_nodes(), libMesh::RBConstruction::compute_max_error_bound(), libMesh::Nemesis_IO_Helper::compute_node_communication_maps(), libMesh::Nemesis_IO_Helper::compute_num_global_elem_blocks(), libMesh::Nemesis_IO_Helper::compute_num_global_nodesets(), libMesh::Nemesis_IO_Helper::compute_num_global_sidesets(), libMesh::Nemesis_IO_Helper::construct_nemesis_filename(), libMesh::ExodusII_IO::copy_elemental_solution(), libMesh::ExodusII_IO::copy_nodal_solution(), libMesh::ExodusII_IO::copy_scalar_solution(), libMesh::Nemesis_IO::copy_scalar_solution(), libMesh::MeshTools::correct_node_proc_ids(), create(), libMesh::DistributedMesh::delete_elem(), libMesh::MeshCommunication::delete_remote_elements(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_scalar_dofs(), libMesh::DistributedMesh::DistributedMesh(), libMesh::DofMapBase::end_dof(), libMesh::DofMapBase::end_old_dof(), libMesh::EnsightIO::EnsightIO(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::SubFunctor::find_dofs_to_send(), libMesh::UnstructuredMesh::find_neighbors(), libMesh::DofMapBase::first_dof(), libMesh::DofMapBase::first_old_dof(), libMesh::RBEIMEvaluation::gather_bfs(), libMesh::Nemesis_IO_Helper::get_cmap_params(), libMesh::Nemesis_IO_Helper::get_eb_info_global(), libMesh::Nemesis_IO_Helper::get_elem_cmap(), libMesh::Nemesis_IO_Helper::get_elem_map(), libMesh::MeshBase::get_info(), libMesh::DofMap::get_info(), libMesh::Nemesis_IO_Helper::get_init_global(), libMesh::Nemesis_IO_Helper::get_init_info(), libMesh::RBEIMEvaluation::get_interior_basis_functions_as_vecs(), libMesh::Nemesis_IO_Helper::get_loadbal_param(), libMesh::DofMap::get_local_constraints(), libMesh::MeshBase::get_local_constraints(), libMesh::Nemesis_IO_Helper::get_node_cmap(), libMesh::Nemesis_IO_Helper::get_node_map(), libMesh::Nemesis_IO_Helper::get_ns_param_global(), libMesh::Nemesis_IO_Helper::get_ss_param_global(), libMesh::SparsityPattern::Build::handle_vi_vj(), libMesh::LaplaceMeshSmoother::init(), libMesh::SystemSubsetBySubdomain::init(), HeatSystem::init_data(), initialize(), initialize_element_variables(), initialize_global_variables(), initialize_nodal_variables(), libMesh::DistributedMesh::insert_elem(), libMesh::DofMap::is_evaluable(), libMesh::SparsityPattern::Build::join(), libMesh::TransientRBEvaluation::legacy_write_offline_data_to_files(), libMesh::RBSCMEvaluation::legacy_write_offline_data_to_files(), libMesh::RBEvaluation::legacy_write_offline_data_to_files(), 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(), main(), libMesh::MeshRefinement::make_coarsening_compatible(), AugmentSparsityOnInterface::mesh_reinit(), libMesh::TriangulatorInterface::MeshedHole::MeshedHole(), libMesh::MeshBase::n_active_local_elem(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::MeshTools::n_connected_components(), libMesh::MeshBase::n_constraint_rows(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::DofMapBase::n_local_dofs(), libMesh::MeshBase::n_local_elem(), libMesh::MeshBase::n_local_nodes(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::RBEIMEvaluation::node_gather_bfs(), libMesh::DistributedMesh::own_node(), libMesh::BoundaryInfo::parallel_sync_node_ids(), libMesh::BoundaryInfo::parallel_sync_side_ids(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::MeshBase::print_constraint_rows(), libMesh::DofMap::print_dof_constraints(), libMesh::DofMap::process_mesh_constraint_rows(), libMesh::Nemesis_IO_Helper::put_cmap_params(), libMesh::Nemesis_IO_Helper::put_elem_cmap(), libMesh::Nemesis_IO_Helper::put_elem_map(), libMesh::Nemesis_IO_Helper::put_loadbal_param(), libMesh::Nemesis_IO_Helper::put_node_cmap(), libMesh::Nemesis_IO_Helper::put_node_map(), libMesh::NameBasedIO::read(), libMesh::Nemesis_IO::read(), libMesh::XdrIO::read(), libMesh::CheckpointIO::read(), libMesh::EquationSystems::read(), read_elem_num_map(), read_global_values(), libMesh::ExodusII_IO::read_header(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), libMesh::System::read_legacy_data(), libMesh::DynaIO::read_mesh(), read_node_num_map(), libMesh::System::read_parallel_data(), libMesh::TransientRBConstruction::read_riesz_representors_from_files(), libMesh::RBConstruction::read_riesz_representors_from_files(), 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::Nemesis_IO_Helper::read_var_names_impl(), libMesh::SimplexRefiner::refine_via_edges(), libMesh::StaticCondensationDofMap::reinit(), libMesh::DistributedMesh::renumber_dof_objects(), libMesh::DistributedMesh::renumber_nodes_and_elements(), libMesh::DofMap::scatter_constraints(), libMesh::CheckpointIO::select_split_config(), libMesh::DistributedMesh::set_next_unique_id(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::RBEIMEvaluation::side_gather_bfs(), ExodusTest< elem_type >::test_read_gold(), ExodusTest< elem_type >::test_write(), MeshInputTest::testAbaqusRead(), MeshInputTest::testBadGmsh(), MeshInputTest::testCopyElementSolutionImpl(), MeshInputTest::testCopyElementVectorImpl(), MeshInputTest::testCopyNodalSolutionImpl(), DefaultCouplingTest::testCoupling(), PointNeighborCouplingTest::testCoupling(), MeshInputTest::testDynaFileMappings(), MeshInputTest::testDynaNoSplines(), MeshInputTest::testDynaReadElem(), MeshInputTest::testDynaReadPatch(), MeshInputTest::testExodusFileMappings(), MeshInputTest::testExodusIGASidesets(), MeshInputTest::testExodusWriteElementDataFromDiscontinuousNodalData(), MeshInputTest::testGmshBCIDOverlap(), MeshInputTest::testGoodGmsh(), MeshInputTest::testGoodSTL(), MeshInputTest::testGoodSTLBinary(), MeshInputTest::testLowOrderEdgeBlocks(), SystemsTest::testProjectMatrix3D(), BoundaryInfoTest::testShellFaceConstraints(), MeshInputTest::testSingleElementImpl(), WriteVecAndScalar::testSolution(), CheckpointIOTest::testSplitter(), MeshInputTest::testTetgenIO(), libMesh::MeshTools::total_weight(), libMesh::NetGenMeshInterface::triangulate(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::DTKAdapter::update_variable_values(), libMesh::MeshTools::volume(), libMesh::STLIO::write(), libMesh::NameBasedIO::write(), libMesh::XdrIO::write(), libMesh::CheckpointIO::write(), libMesh::EquationSystems::write(), libMesh::GMVIO::write_discontinuous_gmv(), libMesh::ExodusII_IO::write_element_data(), write_element_values(), write_element_values_element_major(), write_elements(), write_elemset_data(), write_elemsets(), libMesh::ExodusII_IO::write_global_data(), write_global_values(), libMesh::System::write_header(), libMesh::ExodusII_IO::write_information_records(), write_information_records(), write_nodal_coordinates(), libMesh::UCDIO::write_nodal_data(), libMesh::VTKIO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data_common(), libMesh::ExodusII_IO::write_nodal_data_discontinuous(), write_nodal_values(), write_nodeset_data(), libMesh::Nemesis_IO_Helper::write_nodesets(), write_nodesets(), libMesh::RBEIMEvaluation::write_out_interior_basis_functions(), libMesh::RBEIMEvaluation::write_out_node_basis_functions(), libMesh::RBEIMEvaluation::write_out_side_basis_functions(), write_output_solvedata(), libMesh::System::write_parallel_data(), libMesh::RBConstruction::write_riesz_representors_to_files(), 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_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), write_sidesets(), libMesh::ExodusII_IO::write_timestep(), write_timestep(), and libMesh::ExodusII_IO::write_timestep_discontinuous().
void libMesh::ExodusII_IO_Helper::read_all_nodesets | ( | ) |
New API that reads all nodesets simultaneously.
This may be slightly faster than reading them one at a time. Calls ex_get_concat_node_sets() under the hood.
Definition at line 1702 of file exodusII_io_helper.C.
References _single_precision, libMesh::ExodusII_IO_Helper::MappedInputVector::data(), ex_err, ex_id, id_to_ns_names, node_sets_dist_fact, node_sets_dist_index, node_sets_node_index, node_sets_node_list, nodeset_ids, num_node_df_per_set, num_node_sets, and num_nodes_per_set.
Referenced by write_nodeset_data().
void libMesh::ExodusII_IO_Helper::read_and_store_header_info | ( | ) |
Reads an ExodusII
mesh file header, and stores required information on this object.
Definition at line 736 of file exodusII_io_helper.C.
References ex_err, ex_id, header_info, message(), num_elem_vars, num_elemset_vars, num_global_vars, num_nodal_vars, num_nodeset_vars, num_sideset_vars, read_header(), and read_num_time_steps().
void libMesh::ExodusII_IO_Helper::read_bex_cv_blocks | ( | ) |
Reads the optional bex_cv_blocks
from the ExodusII
mesh file.
Definition at line 921 of file exodusII_io_helper.C.
References bex_dense_constraint_vecs, ex_err, ex_id, and libMesh::make_range().
void libMesh::ExodusII_IO_Helper::read_block_info | ( | ) |
Reads information for all of the blocks in the ExodusII
mesh file.
Definition at line 1040 of file exodusII_io_helper.C.
References block_ids, edge_block_ids, ex_err, ex_id, id_to_block_names, id_to_edge_block_names, message(), num_edge_blk, and num_elem_blk.
void libMesh::ExodusII_IO_Helper::read_edge_blocks | ( | MeshBase & | mesh | ) |
Read in edge blocks, storing information in the BoundaryInfo object.
Definition at line 1303 of file exodusII_io_helper.C.
References libMesh::BoundaryInfo::add_edge(), libMesh::Elem::build(), connect, edge_block_ids, libMesh::BoundaryInfo::edgeset_name(), libMesh::MeshBase::elem_ptr(), elem_type, ex_err, ex_id, libMesh::FIRST, libMesh::Elem::first_order_equivalent_type(), libMesh::MeshBase::get_boundary_info(), get_conversion(), id_to_edge_block_names, mesh, message(), node_num_map, libMesh::MeshBase::node_ptr(), and num_edge_blk.
void libMesh::ExodusII_IO_Helper::read_elem_in_block | ( | int | block | ) |
Reads all of the element connectivity for block block
in the ExodusII
mesh file.
Definition at line 1145 of file exodusII_io_helper.C.
References bex_cv_conn, bex_num_elem_cvs, block_ids, connect, elem_type, ex_err, ex_id, get_conversion(), libMesh::libmesh_assert(), message(), num_attr, num_elem_this_blk, num_nodes_per_elem, libMesh::out, and verbose.
void libMesh::ExodusII_IO_Helper::read_elem_num_map | ( | ) |
Reads the optional node_num_map
from the ExodusII
mesh file.
Definition at line 1473 of file exodusII_io_helper.C.
References _end_elem_id, elem_num_map, ex_err, ex_id, message(), num_elem, libMesh::out, libMesh::ParallelObject::processor_id(), and verbose.
void libMesh::ExodusII_IO_Helper::read_elemental_var_values | ( | std::string | elemental_var_name, |
int | time_step, | ||
std::map< dof_id_type, Real > & | elem_var_value_map | ||
) |
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 2057 of file exodusII_io_helper.C.
References _single_precision, block_ids, elem_num_map, elem_var_names, ELEMENTAL, libMesh::err, ex_err, ex_id, num_elem_blk, num_elem_this_blk, and read_var_names().
Reads information about elemset id
and inserts it into the global elemset array at the position offset
.
Definition at line 1657 of file exodusII_io_helper.C.
References elemset_id_list, elemset_ids, elemset_list, ex_err, ex_id, message(), num_elem_df_per_set, and num_elems_per_set.
Referenced by write_elemset_data().
void libMesh::ExodusII_IO_Helper::read_elemset_data | ( | int | timestep, |
std::vector< std::string > & | var_names, | ||
std::vector< std::set< elemset_id_type >> & | elemset_ids_in, | ||
std::vector< std::map< std::pair< dof_id_type, elemset_id_type >, Real >> & | elemset_vals | ||
) |
Read elemset variables, if any, into the provided data structures.
Definition at line 4033 of file exodusII_io_helper.C.
References _single_precision, ELEMSET, elemset_ids, elemset_list, elemset_var_names, ex_err, ex_id, num_elem_sets, num_elems_per_set, num_elemset_vars, and read_var_names().
void libMesh::ExodusII_IO_Helper::read_elemset_info | ( | ) |
Reads information about all of the elemsets in the ExodusII
mesh file.
Definition at line 1570 of file exodusII_io_helper.C.
References elemset_id_list, elemset_ids, elemset_list, ex_err, ex_id, id_to_elemset_names, message(), num_elem_all_elemsets, num_elem_df_per_set, num_elem_sets, and num_elems_per_set.
Referenced by write_elemset_data().
Reads the vector of global variables.
Definition at line 4649 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, num_global_vars, and libMesh::ParallelObject::processor_id().
ExodusHeaderInfo libMesh::ExodusII_IO_Helper::read_header | ( | ) | const |
Reads an ExodusII
mesh file header, leaving this object's internal data structures unchanged.
Definition at line 706 of file exodusII_io_helper.C.
References ex_id, libMesh::ExodusHeaderInfo::num_dim, libMesh::ExodusHeaderInfo::num_edge, libMesh::ExodusHeaderInfo::num_edge_blk, libMesh::ExodusHeaderInfo::num_elem, libMesh::ExodusHeaderInfo::num_elem_blk, libMesh::ExodusHeaderInfo::num_elem_sets, libMesh::ExodusHeaderInfo::num_node_sets, libMesh::ExodusHeaderInfo::num_nodes, libMesh::ExodusHeaderInfo::num_side_sets, and libMesh::ExodusHeaderInfo::title.
Referenced by read_and_store_header_info().
void libMesh::ExodusII_IO_Helper::read_nodal_var_values | ( | std::string | nodal_var_name, |
int | time_step | ||
) |
Reads the nodal values for the variable 'nodal_var_name' at the specified time into the 'nodal_var_values' array.
Definition at line 1836 of file exodusII_io_helper.C.
References _single_precision, libMesh::err, ex_err, ex_id, NODAL, nodal_var_names, nodal_var_values, node_num_map, num_nodes, and read_var_names().
void libMesh::ExodusII_IO_Helper::read_node_num_map | ( | ) |
Reads the optional node_num_map
from the ExodusII
mesh file.
Definition at line 897 of file exodusII_io_helper.C.
References ex_err, ex_id, message(), node_num_map, num_nodes, libMesh::out, libMesh::ParallelObject::processor_id(), and verbose.
void libMesh::ExodusII_IO_Helper::read_nodes | ( | ) |
Reads the nodal data (x,y,z coordinates) from the ExodusII
mesh file.
Definition at line 846 of file exodusII_io_helper.C.
References _single_precision, ex_err, ex_id, libMesh::index_range(), message(), num_nodes, w, x, y, and z.
void libMesh::ExodusII_IO_Helper::read_nodeset_data | ( | int | timestep, |
std::vector< std::string > & | var_names, | ||
std::vector< std::set< boundary_id_type >> & | node_boundary_ids, | ||
std::vector< std::map< BoundaryInfo::NodeBCTuple, Real >> & | bc_vals | ||
) |
Read nodeset variables, if any, into the provided data structures.
Definition at line 4185 of file exodusII_io_helper.C.
References _single_precision, ex_err, ex_id, node_sets_node_list, NODESET, nodeset_ids, nodeset_var_names, num_node_sets, num_nodes_per_set, num_nodeset_vars, and read_var_names().
void libMesh::ExodusII_IO_Helper::read_nodeset_info | ( | ) |
Reads information about all of the nodesets in the ExodusII
mesh file.
Definition at line 1541 of file exodusII_io_helper.C.
References ex_err, ex_id, id_to_ns_names, message(), nodeset_ids, num_node_df_per_set, num_node_sets, and num_nodes_per_set.
void libMesh::ExodusII_IO_Helper::read_num_time_steps | ( | ) |
Reads the number of timesteps currently stored in the Exodus file and stores it in the num_time_steps variable.
Definition at line 1828 of file exodusII_io_helper.C.
References num_time_steps.
Referenced by read_and_store_header_info(), and read_time_steps().
void libMesh::ExodusII_IO_Helper::read_qa_records | ( | ) |
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 770 of file exodusII_io_helper.C.
References ex_err, ex_id, libMesh::make_range(), libMesh::out, and verbose.
Reads information about sideset id
and inserts it into the global sideset array at the position offset
.
Definition at line 1610 of file exodusII_io_helper.C.
References elem_list, ex_err, ex_id, id_list, message(), num_df_per_set, num_sides_per_set, side_list, and ss_ids.
Referenced by write_sideset_data().
void libMesh::ExodusII_IO_Helper::read_sideset_data | ( | const MeshBase & | mesh, |
int | timestep, | ||
std::vector< std::string > & | var_names, | ||
std::vector< std::set< boundary_id_type >> & | side_ids, | ||
std::vector< std::map< BoundaryInfo::BCTuple, Real >> & | bc_vals | ||
) |
Read sideset variables, if any, into the provided data structures.
Definition at line 3653 of file exodusII_io_helper.C.
References _single_precision, elem_list, libMesh::MeshBase::elem_ptr(), ex_err, ex_id, get_conversion(), libMesh::ExodusII_IO_Helper::Conversion::get_side_map(), mesh, num_side_sets, num_sides_per_set, num_sideset_vars, read_var_names(), side_list, SIDESET, sideset_var_names, ss_ids, and libMesh::Elem::type().
void libMesh::ExodusII_IO_Helper::read_sideset_info | ( | ) |
Reads information about all of the sidesets in the ExodusII
mesh file.
Definition at line 1506 of file exodusII_io_helper.C.
References elem_list, ex_err, ex_id, id_list, id_to_ss_names, message(), num_df_per_set, num_elem_all_sidesets, num_side_sets, num_sides_per_set, side_list, and ss_ids.
Referenced by write_sideset_data().
void libMesh::ExodusII_IO_Helper::read_time_steps | ( | ) |
Reads and stores the timesteps in the 'time_steps' array.
Definition at line 1811 of file exodusII_io_helper.C.
References _single_precision, ex_err, ex_id, num_time_steps, read_num_time_steps(), and time_steps.
void libMesh::ExodusII_IO_Helper::read_var_names | ( | ExodusVarType | type | ) |
Definition at line 1897 of file exodusII_io_helper.C.
References elem_var_names, ELEMENTAL, ELEMSET, elemset_var_names, GLOBAL, global_var_names, NODAL, nodal_var_names, NODESET, nodeset_var_names, num_elem_vars, num_elemset_vars, num_global_vars, num_nodal_vars, num_nodeset_vars, num_sideset_vars, read_var_names_impl(), SIDESET, and sideset_var_names.
Referenced by check_existing_vars(), read_elemental_var_values(), read_elemset_data(), read_nodal_var_values(), read_nodeset_data(), and read_sideset_data().
|
protectedvirtual |
read_var_names() dispatches to this function.
We need to override it slightly for Nemesis.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 1926 of file exodusII_io_helper.C.
References ex_err, ex_id, libMesh::ExodusII_IO_Helper::NamesData::get_char_star(), libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), libMesh::out, and verbose.
Referenced by read_var_names(), and libMesh::Nemesis_IO_Helper::read_var_names_impl().
|
inline |
Sets whether or not to write extra "side" elements.
This is useful for plotting SIDE_DISCONTINUOUS data.
Definition at line 1289 of file exodusII_io_helper.h.
References _add_sides.
void libMesh::ExodusII_IO_Helper::set_coordinate_offset | ( | Point | p | ) |
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 4691 of file exodusII_io_helper.C.
References _coordinate_offset.
void libMesh::ExodusII_IO_Helper::set_hdf5_writing | ( | bool | write_hdf5 | ) |
Set to true (the default) to write files in an HDF5-based file format (when HDF5 is available), or to false to write files in the old NetCDF3-based format.
If HDF5 is unavailable, this setting does nothing.
Definition at line 4676 of file exodusII_io_helper.C.
References _write_hdf5.
void libMesh::ExodusII_IO_Helper::update | ( | ) |
Uses ex_update() to flush buffers to file.
Definition at line 4641 of file exodusII_io_helper.C.
Referenced by libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), write_global_values(), write_information_records(), write_nodal_values(), and write_timestep().
void libMesh::ExodusII_IO_Helper::use_mesh_dimension_instead_of_spatial_dimension | ( | bool | val | ) |
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 4670 of file exodusII_io_helper.C.
References _use_mesh_dimension_instead_of_spatial_dimension.
void libMesh::ExodusII_IO_Helper::write_as_dimension | ( | unsigned | dim | ) |
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 4684 of file exodusII_io_helper.C.
References _write_as_dimension, and dim.
void libMesh::ExodusII_IO_Helper::write_element_values | ( | const MeshBase & | mesh, |
const std::vector< Real > & | values, | ||
int | timestep, | ||
const std::vector< std::set< subdomain_id_type >> & | vars_active_subdomains | ||
) |
Writes the vector of values to the element variables.
The 'values' vector is assumed to be in the order: {(u1, u2, u3, ..., uN), (v1, v2, v3, ..., vN), (w1, w2, w3, ..., wN)} where N is the number of elements.
This ordering is produced by calls to ES::build_elemental_solution_vector(). ES::build_discontinuous_solution_vector(), on the other hand, produces an element-major ordering. See the function below for that case.
Definition at line 4329 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, get_block_id(), mesh, libMesh::MeshTools::n_elem(), libMesh::MeshBase::n_elem(), num_elem_vars, libMesh::ParallelObject::processor_id(), and update().
void libMesh::ExodusII_IO_Helper::write_element_values_element_major | ( | const MeshBase & | mesh, |
const std::vector< Real > & | values, | ||
int | timestep, | ||
const std::vector< std::set< subdomain_id_type >> & | vars_active_subdomains, | ||
const std::vector< std::string > & | derived_var_names, | ||
const std::map< subdomain_id_type, std::vector< std::string >> & | subdomain_to_var_names | ||
) |
Same as the function above, but assume the input 'values' vector is in element-major order, i.e.
{(u1,v1,w1), (u2,v2,w2), ... (uN,vN,wN)} This function is called by ExodusII_IO::write_element_data_from_discontinuous_nodal_data() because ES::build_discontinuous_solution_vector() builds the solution vector in this order.
Definition at line 4414 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, libMesh::ExodusII_IO_Helper::MappedOutputVector::data(), distance(), ex_err, ex_id, get_block_id(), mesh, num_elem_vars, libMesh::ParallelObject::processor_id(), and update().
|
virtual |
Writes the elements contained in "mesh".
FIXME: This only works for Meshes having a single type of element in each subdomain!
If use_discontinuous
is true, we break apart elements, so that shared nodes on faces/edges/vertices can take different values from different elements. This is useful for plotting discontinuous underlying variables
If _add_sides
is true, we also output side elements, so that shared nodes on edges/vertices can take different values from different elements. This is useful for plotting SIDE_DISCONTINUOUS representing e.g. inter-element fluxes.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 2539 of file exodusII_io_helper.C.
References _add_sides, _run_only_on_proc0, block_ids, libMesh::BoundaryInfo::build_edge_list(), libMesh::Elem::build_edge_ptr(), connect, elem_num_map, libMesh::MeshBase::elem_ptr(), libMesh::MeshBase::elem_ref(), libMesh::Utility::enum_to_string(), ex_err, ex_id, libMesh::MeshBase::get_boundary_info(), libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), get_conversion(), libMesh::BoundaryInfo::get_edgeset_name(), libMesh::index_range(), libMesh::invalid_uint, libMesh::libmesh_assert(), libmesh_elem_num_to_exodus, libMesh::libmesh_ignore(), libmesh_node_num_to_exodus, libMesh::Elem::local_edge_node(), libMesh::MeshBase::max_elem_id(), libMesh::MeshBase::max_node_id(), mesh, libMesh::Elem::node_id(), num_edge_blk, num_elem, num_elem_blk, num_elem_this_blk, num_nodes_per_elem, libMesh::ParallelObject::processor_id(), libMesh::ExodusII_IO_Helper::NamesData::push_back_entry(), libMesh::EquationSystems::redundant_added_side(), libMesh::MeshBase::subdomain_name(), libMesh::Elem::type(), and libMesh::Elem::type_to_n_nodes_map.
void libMesh::ExodusII_IO_Helper::write_elemset_data | ( | int | timestep, |
const std::vector< std::string > & | var_names, | ||
const std::vector< std::set< elemset_id_type >> & | elemset_ids_in, | ||
const std::vector< std::map< std::pair< dof_id_type, elemset_id_type >, Real >> & | elemset_vals | ||
) |
Write elemset data for the requested timestep.
Definition at line 3910 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ELEMSET, elemset_ids, elemset_list, ex_err, ex_id, libMesh::index_range(), num_elem_sets, num_elems_per_set, libMesh::ParallelObject::processor_id(), read_elemset(), read_elemset_info(), and write_var_names().
void libMesh::ExodusII_IO_Helper::write_elemsets | ( | const MeshBase & | mesh | ) |
Write elemsets stored on the Mesh to the exo file.
Definition at line 3416 of file exodusII_io_helper.C.
References _run_only_on_proc0, ex_err, ex_id, libMesh::MeshBase::get_elem_integer_index(), libMesh::MeshBase::get_elemsets(), libMesh::MeshBase::has_elem_integer(), libmesh_elem_num_to_exodus, mesh, libMesh::MeshBase::n_elemsets(), num_elem_sets, and libMesh::ParallelObject::processor_id().
void libMesh::ExodusII_IO_Helper::write_global_values | ( | const std::vector< Real > & | values, |
int | timestep | ||
) |
Writes the vector of global variables.
Definition at line 4617 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, num_global_vars, libMesh::ParallelObject::processor_id(), and update().
void libMesh::ExodusII_IO_Helper::write_information_records | ( | const std::vector< std::string > & | records | ) |
Writes the vector of information records.
Definition at line 4579 of file exodusII_io_helper.C.
References _run_only_on_proc0, libMesh::err, ex_err, ex_id, libMesh::ParallelObject::processor_id(), and update().
|
virtual |
Writes the nodal coordinates contained in "mesh".
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 2402 of file exodusII_io_helper.C.
References _add_sides, _coordinate_offset, _run_only_on_proc0, _single_precision, libMesh::ExodusII_IO_Helper::MappedOutputVector::data(), ex_err, ex_id, libMesh::DofObject::id(), libMesh::index_range(), libmesh_node_num_to_exodus, mesh, libMesh::ParallelObject::n_processors(), node_num_map, num_nodes, libMesh::ParallelObject::processor_id(), libMesh::EquationSystems::redundant_added_side(), x, y, and z.
void libMesh::ExodusII_IO_Helper::write_nodal_values | ( | int | var_id, |
const std::vector< Real > & | values, | ||
int | timestep | ||
) |
Writes the vector of values to a nodal variable.
Definition at line 4551 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, num_nodes, libMesh::ParallelObject::processor_id(), and update().
Referenced by libMesh::Nemesis_IO_Helper::write_nodal_solution().
void libMesh::ExodusII_IO_Helper::write_nodeset_data | ( | int | timestep, |
const std::vector< std::string > & | var_names, | ||
const std::vector< std::set< boundary_id_type >> & | node_boundary_ids, | ||
const std::vector< std::map< BoundaryInfo::NodeBCTuple, Real >> & | bc_vals | ||
) |
Write nodeset data for the requested timestep.
Definition at line 3805 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, libMesh::index_range(), node_sets_node_index, node_sets_node_list, NODESET, nodeset_ids, num_node_sets, num_nodes_per_set, libMesh::ParallelObject::processor_id(), read_all_nodesets(), and write_var_names().
|
virtual |
Writes the nodesets contained in "mesh".
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 3128 of file exodusII_io_helper.C.
References _run_only_on_proc0, libMesh::BoundaryInfo::build_node_boundary_ids(), libMesh::BoundaryInfo::build_node_list(), ex_err, ex_id, libMesh::MeshBase::get_boundary_info(), libMesh::BoundaryInfo::get_nodeset_name(), libMesh::BoundaryInfo::get_nodeset_name_map(), mesh, node_sets_node_index, node_sets_node_list, nodeset_ids, num_node_df_per_set, num_nodes_per_set, and libMesh::ParallelObject::processor_id().
void libMesh::ExodusII_IO_Helper::write_sideset_data | ( | const MeshBase & | mesh, |
int | timestep, | ||
const std::vector< std::string > & | var_names, | ||
const std::vector< std::set< boundary_id_type >> & | side_ids, | ||
const std::vector< std::map< BoundaryInfo::BCTuple, Real >> & | bc_vals | ||
) |
Write sideset data for the requested timestep.
Definition at line 3513 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, elem_list, libMesh::MeshBase::elem_ptr(), ex_err, ex_id, get_conversion(), libMesh::ExodusII_IO_Helper::Conversion::get_side_map(), libMesh::index_range(), libmesh_elem_num_to_exodus, mesh, num_side_sets, num_sides_per_set, libMesh::ParallelObject::processor_id(), read_sideset(), read_sideset_info(), side_id, side_list, SIDESET, ss_ids, libMesh::Elem::type(), and write_var_names().
|
virtual |
Writes the sidesets contained in "mesh".
We need to build up active elements if AMR is enabled and add them to the exodus sidesets instead of the potentially inactive "parent" elements
We need to build up active elements if AMR is enabled and add them to the exodus sidesets instead of the potentially inactive "parent" elements
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 3004 of file exodusII_io_helper.C.
References _run_only_on_proc0, libMesh::Elem::active_family_tree_by_side(), libMesh::BoundaryInfo::build_shellface_boundary_ids(), libMesh::BoundaryInfo::build_shellface_list(), libMesh::BoundaryInfo::build_side_boundary_ids(), libMesh::BoundaryInfo::build_side_list(), libMesh::MeshBase::elem_ptr(), libMesh::MeshBase::elem_ref(), ex_err, ex_id, libMesh::MeshBase::get_boundary_info(), get_conversion(), libMesh::BoundaryInfo::get_sideset_name(), libMesh::BoundaryInfo::get_sideset_name_map(), libmesh_elem_num_to_exodus, mesh, libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::NamesData::push_back_entry().
Writes the time for the timestep.
Definition at line 3393 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, libMesh::ParallelObject::processor_id(), and update().
|
protected |
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 1967 of file exodusII_io_helper.C.
References ELEMENTAL, ELEMSET, GLOBAL, NODAL, NODESET, num_elem_vars, num_elemset_vars, num_global_vars, num_nodal_vars, num_nodeset_vars, num_sideset_vars, SIDESET, and write_var_names_impl().
Referenced by initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), initialize_global_variables(), initialize_nodal_variables(), write_elemset_data(), write_nodeset_data(), and write_sideset_data().
|
private |
write_var_names() dispatches to this function.
Definition at line 2007 of file exodusII_io_helper.C.
References ex_err, ex_id, libMesh::ExodusII_IO_Helper::NamesData::get_char_star(), libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), num_nodes, libMesh::out, libMesh::ExodusII_IO_Helper::NamesData::push_back_entry(), and verbose.
Referenced by write_var_names().
|
private |
Set to true iff we want to write separate "side" elements too.
Definition at line 1060 of file exodusII_io_helper.h.
Referenced by get_add_sides(), initialize(), set_add_sides(), write_elements(), and write_nodal_coordinates().
|
protected |
If we're adding "fake" sides to visualize SIDE_DISCONTINUOUS variables, _added_side_node_offsets[p] gives us the total solution vector offset to use on processor p+1 from the nodes on those previous ranks' sides.
Definition at line 982 of file exodusII_io_helper.h.
Referenced by added_node_offset_on(), initialize(), and node_id_to_vec_id().
|
protectedinherited |
Definition at line 120 of file parallel_object.h.
Referenced by libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::StaticCondensation::close(), libMesh::ParallelObject::comm(), libMesh::CondensedEigenSystem::initialize_condensed_matrices(), libMesh::ParallelObject::n_processors(), libMesh::ParallelObject::operator=(), libMesh::ParallelObject::processor_id(), libMesh::BoundaryInfo::regenerate_id_sets(), and libMesh::StaticCondensationDofMap::reinit().
|
protected |
Definition at line 971 of file exodusII_io_helper.h.
Referenced by set_coordinate_offset(), and write_nodal_coordinates().
|
protected |
Definition at line 946 of file exodusII_io_helper.h.
Referenced by initialize_element_variables(), and libMesh::Nemesis_IO_Helper::initialize_element_variables().
|
protected |
Definition at line 964 of file exodusII_io_helper.h.
Referenced by end_elem_id(), and read_elem_num_map().
|
protected |
Definition at line 949 of file exodusII_io_helper.h.
Referenced by initialize_global_variables().
|
protected |
Definition at line 952 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables().
|
protected |
Definition at line 943 of file exodusII_io_helper.h.
|
protected |
Definition at line 940 of file exodusII_io_helper.h.
Referenced by close(), create(), initialize(), initialize_element_variables(), initialize_global_variables(), initialize_nodal_variables(), read_global_values(), write_element_values(), write_element_values_element_major(), write_elements(), write_elemset_data(), write_elemsets(), write_global_values(), write_information_records(), write_nodal_coordinates(), write_nodal_values(), write_nodeset_data(), write_nodesets(), write_sideset_data(), write_sidesets(), and write_timestep().
|
protected |
Definition at line 974 of file exodusII_io_helper.h.
Referenced by create(), open(), read_all_nodesets(), read_elemental_var_values(), read_elemset_data(), read_global_values(), read_nodal_var_values(), read_nodes(), read_nodeset_data(), read_sideset_data(), read_time_steps(), libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), write_elemset_data(), write_global_values(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), write_nodal_coordinates(), write_nodal_values(), write_nodeset_data(), write_sideset_data(), and write_timestep().
|
protected |
If we're adding "fake" sides to visualize SIDE_DISCONTINUOUS variables, we also need to know how many real nodes from previous ranks are taking up space in a solution vector.
Definition at line 989 of file exodusII_io_helper.h.
Referenced by added_node_offset_on(), initialize(), and node_id_to_vec_id().
|
protected |
Definition at line 957 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::initialize(), initialize(), and use_mesh_dimension_instead_of_spatial_dimension().
|
protected |
Definition at line 968 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::initialize(), initialize(), and write_as_dimension().
|
protected |
Definition at line 961 of file exodusII_io_helper.h.
Referenced by create(), and set_hdf5_writing().
std::vector<std::vector<long unsigned int> > libMesh::ExodusII_IO_Helper::bex_cv_conn |
Definition at line 786 of file exodusII_io_helper.h.
Referenced by read_elem_in_block().
std::vector<std::vector<std::vector<Real> > > libMesh::ExodusII_IO_Helper::bex_dense_constraint_vecs |
Definition at line 790 of file exodusII_io_helper.h.
Referenced by read_bex_cv_blocks().
unsigned int libMesh::ExodusII_IO_Helper::bex_num_elem_cvs |
Definition at line 783 of file exodusII_io_helper.h.
Referenced by read_elem_in_block().
std::vector<int> libMesh::ExodusII_IO_Helper::block_ids |
Definition at line 698 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), get_block_id(), get_block_name(), initialize_element_variables(), read_block_info(), read_elem_in_block(), read_elemental_var_values(), and write_elements().
std::vector<int> libMesh::ExodusII_IO_Helper::connect |
Definition at line 704 of file exodusII_io_helper.h.
Referenced by read_edge_blocks(), read_elem_in_block(), and write_elements().
|
private |
Associates libMesh ElemTypes with node/face/edge/etc.
mappings of the corresponding Exodus element types.
We have to map based on both ElemType and mesh dimension, because Exodus treats "TRI" side numbering in two different ways depending on whether a triangle is embedded in a 2D or a 3D mesh.
Definition at line 1084 of file exodusII_io_helper.h.
Referenced by get_conversion(), and init_conversion_map().
std::string libMesh::ExodusII_IO_Helper::current_filename |
Definition at line 869 of file exodusII_io_helper.h.
std::vector<int> libMesh::ExodusII_IO_Helper::edge_block_ids |
Definition at line 701 of file exodusII_io_helper.h.
Referenced by read_block_info(), and read_edge_blocks().
std::vector<int> libMesh::ExodusII_IO_Helper::elem_list |
Definition at line 750 of file exodusII_io_helper.h.
Referenced by get_sideset_data_indices(), read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
std::vector<int> libMesh::ExodusII_IO_Helper::elem_num_map |
Definition at line 768 of file exodusII_io_helper.h.
Referenced by end_elem_id(), read_elem_num_map(), read_elemental_var_values(), and write_elements().
std::vector<char> libMesh::ExodusII_IO_Helper::elem_type |
Definition at line 793 of file exodusII_io_helper.h.
Referenced by ExodusII_IO_Helper(), get_elem_type(), read_edge_blocks(), and read_elem_in_block().
std::vector<std::string> libMesh::ExodusII_IO_Helper::elem_var_names |
Definition at line 826 of file exodusII_io_helper.h.
Referenced by initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), read_elemental_var_values(), and read_var_names().
std::vector<Real> libMesh::ExodusII_IO_Helper::elem_var_values |
Definition at line 829 of file exodusII_io_helper.h.
|
private |
Defines equivalence classes of Exodus element types that map to libmesh ElemTypes.
Definition at line 1073 of file exodusII_io_helper.h.
Referenced by get_conversion(), and init_element_equivalence_map().
std::vector<int> libMesh::ExodusII_IO_Helper::elemset_id_list |
Definition at line 762 of file exodusII_io_helper.h.
Referenced by read_elemset(), and read_elemset_info().
std::vector<int> libMesh::ExodusII_IO_Helper::elemset_ids |
Definition at line 713 of file exodusII_io_helper.h.
Referenced by get_elemset_data_indices(), read_elemset(), read_elemset_data(), read_elemset_info(), and write_elemset_data().
std::vector<int> libMesh::ExodusII_IO_Helper::elemset_list |
Definition at line 759 of file exodusII_io_helper.h.
Referenced by get_elemset_data_indices(), read_elemset(), read_elemset_data(), read_elemset_info(), and write_elemset_data().
std::vector<std::string> libMesh::ExodusII_IO_Helper::elemset_var_names |
Definition at line 841 of file exodusII_io_helper.h.
Referenced by read_elemset_data(), and read_var_names().
int libMesh::ExodusII_IO_Helper::ex_err |
Definition at line 630 of file exodusII_io_helper.h.
Referenced by close(), initialize(), initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), read_all_nodesets(), read_and_store_header_info(), read_bex_cv_blocks(), read_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_elemental_var_values(), read_elemset(), read_elemset_data(), read_elemset_info(), read_global_values(), read_nodal_var_values(), read_node_num_map(), read_nodes(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_data(), read_nodeset_info(), read_qa_records(), read_sideset(), read_sideset_data(), read_sideset_info(), read_time_steps(), read_var_names_impl(), update(), libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), libMesh::Nemesis_IO_Helper::write_elements(), write_elements(), write_elemset_data(), write_elemsets(), libMesh::Nemesis_IO_Helper::write_exodus_initialization_info(), write_global_values(), write_information_records(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), write_nodal_coordinates(), write_nodal_values(), write_nodeset_data(), libMesh::Nemesis_IO_Helper::write_nodesets(), write_nodesets(), write_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), write_sidesets(), write_timestep(), write_var_names_impl(), and libMesh::Nemesis_IO_Helper::~Nemesis_IO_Helper().
int libMesh::ExodusII_IO_Helper::ex_id |
Definition at line 627 of file exodusII_io_helper.h.
Referenced by close(), create(), libMesh::Nemesis_IO_Helper::get_cmap_params(), libMesh::Nemesis_IO_Helper::get_eb_info_global(), libMesh::Nemesis_IO_Helper::get_elem_cmap(), libMesh::Nemesis_IO_Helper::get_elem_map(), libMesh::Nemesis_IO_Helper::get_init_global(), libMesh::Nemesis_IO_Helper::get_init_info(), libMesh::Nemesis_IO_Helper::get_loadbal_param(), libMesh::Nemesis_IO_Helper::get_node_cmap(), libMesh::Nemesis_IO_Helper::get_node_map(), libMesh::Nemesis_IO_Helper::get_ns_param_global(), libMesh::Nemesis_IO_Helper::get_ss_param_global(), initialize(), initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), open(), libMesh::Nemesis_IO_Helper::put_cmap_params(), libMesh::Nemesis_IO_Helper::put_eb_info_global(), libMesh::Nemesis_IO_Helper::put_elem_cmap(), libMesh::Nemesis_IO_Helper::put_elem_map(), libMesh::Nemesis_IO_Helper::put_init_global(), libMesh::Nemesis_IO_Helper::put_init_info(), libMesh::Nemesis_IO_Helper::put_loadbal_param(), libMesh::Nemesis_IO_Helper::put_node_cmap(), libMesh::Nemesis_IO_Helper::put_node_map(), libMesh::Nemesis_IO_Helper::put_ns_param_global(), libMesh::Nemesis_IO_Helper::put_ss_param_global(), read_all_nodesets(), read_and_store_header_info(), read_bex_cv_blocks(), read_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_elemental_var_values(), read_elemset(), read_elemset_data(), read_elemset_info(), read_global_values(), read_header(), read_nodal_var_values(), read_node_num_map(), read_nodes(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_data(), read_nodeset_info(), read_qa_records(), read_sideset(), read_sideset_data(), read_sideset_info(), read_time_steps(), read_var_names_impl(), update(), libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), libMesh::Nemesis_IO_Helper::write_elements(), write_elements(), write_elemset_data(), write_elemsets(), libMesh::Nemesis_IO_Helper::write_exodus_initialization_info(), write_global_values(), write_information_records(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), write_nodal_coordinates(), write_nodal_values(), write_nodeset_data(), libMesh::Nemesis_IO_Helper::write_nodesets(), write_nodesets(), write_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), write_sidesets(), write_timestep(), write_var_names_impl(), and libMesh::Nemesis_IO_Helper::~Nemesis_IO_Helper().
std::vector<int> libMesh::ExodusII_IO_Helper::exodus_elem_num_to_libmesh |
Definition at line 798 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), and libMesh::Nemesis_IO_Helper::write_elements().
std::vector<int> libMesh::ExodusII_IO_Helper::exodus_node_num_to_libmesh |
Definition at line 803 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), and libMesh::Nemesis_IO_Helper::write_nodal_solution().
std::vector<std::string> libMesh::ExodusII_IO_Helper::global_var_names |
Definition at line 832 of file exodusII_io_helper.h.
Referenced by initialize_global_variables(), and read_var_names().
ExodusHeaderInfo libMesh::ExodusII_IO_Helper::header_info |
Definition at line 633 of file exodusII_io_helper.h.
Referenced by read_and_store_header_info().
std::vector<int> libMesh::ExodusII_IO_Helper::id_list |
Definition at line 756 of file exodusII_io_helper.h.
Referenced by read_sideset(), and read_sideset_info().
std::map<int, std::string> libMesh::ExodusII_IO_Helper::id_to_block_names |
Definition at line 844 of file exodusII_io_helper.h.
Referenced by get_block_name(), and read_block_info().
std::map<int, std::string> libMesh::ExodusII_IO_Helper::id_to_edge_block_names |
Definition at line 845 of file exodusII_io_helper.h.
Referenced by read_block_info(), and read_edge_blocks().
std::map<int, std::string> libMesh::ExodusII_IO_Helper::id_to_elemset_names |
Definition at line 848 of file exodusII_io_helper.h.
Referenced by read_elemset_info().
std::map<int, std::string> libMesh::ExodusII_IO_Helper::id_to_ns_names |
Definition at line 847 of file exodusII_io_helper.h.
Referenced by get_node_set_name(), read_all_nodesets(), and read_nodeset_info().
std::map<int, std::string> libMesh::ExodusII_IO_Helper::id_to_ss_names |
Definition at line 846 of file exodusII_io_helper.h.
Referenced by get_side_set_name(), and read_sideset_info().
std::map<dof_id_type, dof_id_type> libMesh::ExodusII_IO_Helper::libmesh_elem_num_to_exodus |
Definition at line 797 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Nemesis_IO_Helper::compute_elem_communication_maps(), libMesh::Nemesis_IO_Helper::compute_element_maps(), write_elements(), write_elemsets(), write_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), and write_sidesets().
std::map<dof_id_type, dof_id_type> libMesh::ExodusII_IO_Helper::libmesh_node_num_to_exodus |
Definition at line 802 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Nemesis_IO_Helper::compute_node_communication_maps(), libMesh::Nemesis_IO_Helper::compute_node_maps(), write_elements(), write_nodal_coordinates(), libMesh::Nemesis_IO_Helper::write_nodal_solution(), and libMesh::Nemesis_IO_Helper::write_nodesets().
std::vector<std::string> libMesh::ExodusII_IO_Helper::nodal_var_names |
Definition at line 815 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables(), read_nodal_var_values(), and read_var_names().
std::map<dof_id_type, Real> libMesh::ExodusII_IO_Helper::nodal_var_values |
Definition at line 820 of file exodusII_io_helper.h.
Referenced by read_nodal_var_values().
std::vector<int> libMesh::ExodusII_IO_Helper::node_num_map |
Definition at line 765 of file exodusII_io_helper.h.
Referenced by read_edge_blocks(), read_nodal_var_values(), read_node_num_map(), and write_nodal_coordinates().
std::vector<Real> libMesh::ExodusII_IO_Helper::node_sets_dist_fact |
Definition at line 747 of file exodusII_io_helper.h.
Referenced by read_all_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::node_sets_dist_index |
Definition at line 739 of file exodusII_io_helper.h.
Referenced by read_all_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::node_sets_node_index |
Definition at line 735 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), write_nodeset_data(), and write_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::node_sets_node_list |
Definition at line 743 of file exodusII_io_helper.h.
Referenced by get_nodeset_data_indices(), read_all_nodesets(), read_nodeset_data(), write_nodeset_data(), and write_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::nodeset_ids |
Definition at line 710 of file exodusII_io_helper.h.
Referenced by get_node_set_id(), get_node_set_name(), get_nodeset_data_indices(), read_all_nodesets(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_data(), read_nodeset_info(), write_nodeset_data(), and write_nodesets().
std::vector<std::string> libMesh::ExodusII_IO_Helper::nodeset_var_names |
Definition at line 838 of file exodusII_io_helper.h.
Referenced by read_nodeset_data(), and read_var_names().
int libMesh::ExodusII_IO_Helper::num_attr |
Definition at line 689 of file exodusII_io_helper.h.
Referenced by read_elem_in_block().
std::vector<int> libMesh::ExodusII_IO_Helper::num_df_per_set |
Definition at line 725 of file exodusII_io_helper.h.
Referenced by read_sideset(), and read_sideset_info().
int& libMesh::ExodusII_IO_Helper::num_dim |
Definition at line 639 of file exodusII_io_helper.h.
Referenced by get_conversion(), libMesh::Nemesis_IO_Helper::initialize(), initialize(), print_header(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int& libMesh::ExodusII_IO_Helper::num_edge |
Definition at line 655 of file exodusII_io_helper.h.
Referenced by initialize().
int& libMesh::ExodusII_IO_Helper::num_edge_blk |
Definition at line 659 of file exodusII_io_helper.h.
Referenced by initialize(), read_block_info(), read_edge_blocks(), and write_elements().
int& libMesh::ExodusII_IO_Helper::num_elem |
Definition at line 645 of file exodusII_io_helper.h.
Referenced by end_elem_id(), initialize(), print_header(), read_elem_num_map(), write_elements(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int libMesh::ExodusII_IO_Helper::num_elem_all_elemsets |
Definition at line 695 of file exodusII_io_helper.h.
Referenced by read_elemset_info().
int libMesh::ExodusII_IO_Helper::num_elem_all_sidesets |
Definition at line 692 of file exodusII_io_helper.h.
Referenced by read_sideset_info().
int& libMesh::ExodusII_IO_Helper::num_elem_blk |
Definition at line 652 of file exodusII_io_helper.h.
Referenced by initialize(), initialize_element_variables(), print_header(), read_block_info(), read_elemental_var_values(), write_elements(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
std::vector<int> libMesh::ExodusII_IO_Helper::num_elem_df_per_set |
Definition at line 731 of file exodusII_io_helper.h.
Referenced by read_elemset(), and read_elemset_info().
int& libMesh::ExodusII_IO_Helper::num_elem_sets |
Definition at line 668 of file exodusII_io_helper.h.
Referenced by get_elemset_data_indices(), initialize(), print_header(), read_elemset_data(), read_elemset_info(), write_elemset_data(), and write_elemsets().
int libMesh::ExodusII_IO_Helper::num_elem_this_blk |
Definition at line 683 of file exodusII_io_helper.h.
Referenced by read_elem_in_block(), read_elemental_var_values(), and write_elements().
int libMesh::ExodusII_IO_Helper::num_elem_vars |
Definition at line 823 of file exodusII_io_helper.h.
Referenced by initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), read_and_store_header_info(), read_var_names(), write_element_values(), write_element_values_element_major(), and write_var_names().
std::vector<int> libMesh::ExodusII_IO_Helper::num_elems_per_set |
Definition at line 722 of file exodusII_io_helper.h.
Referenced by get_elemset_data_indices(), read_elemset(), read_elemset_data(), read_elemset_info(), and write_elemset_data().
int libMesh::ExodusII_IO_Helper::num_elemset_vars |
Definition at line 680 of file exodusII_io_helper.h.
Referenced by read_and_store_header_info(), read_elemset_data(), read_var_names(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_global_vars |
Definition at line 671 of file exodusII_io_helper.h.
Referenced by initialize_global_variables(), read_and_store_header_info(), read_global_values(), read_var_names(), write_global_values(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_nodal_vars |
Definition at line 812 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables(), read_and_store_header_info(), read_var_names(), and write_var_names().
std::vector<int> libMesh::ExodusII_IO_Helper::num_node_df_per_set |
Definition at line 728 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_info(), and write_nodesets().
int& libMesh::ExodusII_IO_Helper::num_node_sets |
Definition at line 662 of file exodusII_io_helper.h.
Referenced by get_nodeset_data_indices(), initialize(), print_header(), read_all_nodesets(), read_nodeset_data(), read_nodeset_info(), libMesh::Nemesis_IO_Helper::write_exodus_initialization_info(), and write_nodeset_data().
int& libMesh::ExodusII_IO_Helper::num_nodes |
Definition at line 642 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), initialize(), print_header(), print_nodes(), read_nodal_var_values(), read_node_num_map(), read_nodes(), libMesh::Nemesis_IO_Helper::write_exodus_initialization_info(), write_nodal_coordinates(), libMesh::Nemesis_IO_Helper::write_nodal_solution(), write_nodal_values(), and write_var_names_impl().
int libMesh::ExodusII_IO_Helper::num_nodes_per_elem |
Definition at line 686 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), read_elem_in_block(), libMesh::Nemesis_IO_Helper::write_elements(), and write_elements().
std::vector<int> libMesh::ExodusII_IO_Helper::num_nodes_per_set |
Definition at line 719 of file exodusII_io_helper.h.
Referenced by get_nodeset_data_indices(), read_all_nodesets(), libMesh::Nemesis_IO_Helper::read_nodeset(), read_nodeset_data(), read_nodeset_info(), write_nodeset_data(), and write_nodesets().
int libMesh::ExodusII_IO_Helper::num_nodeset_vars |
Definition at line 677 of file exodusII_io_helper.h.
Referenced by read_and_store_header_info(), read_nodeset_data(), read_var_names(), and write_var_names().
int& libMesh::ExodusII_IO_Helper::num_side_sets |
Definition at line 665 of file exodusII_io_helper.h.
Referenced by get_sideset_data_indices(), initialize(), print_header(), read_sideset_data(), read_sideset_info(), libMesh::Nemesis_IO_Helper::write_exodus_initialization_info(), and write_sideset_data().
std::vector<int> libMesh::ExodusII_IO_Helper::num_sides_per_set |
Definition at line 716 of file exodusII_io_helper.h.
Referenced by get_sideset_data_indices(), read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
int libMesh::ExodusII_IO_Helper::num_sideset_vars |
Definition at line 674 of file exodusII_io_helper.h.
Referenced by read_and_store_header_info(), read_sideset_data(), read_var_names(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_time_steps |
Definition at line 806 of file exodusII_io_helper.h.
Referenced by read_num_time_steps(), and read_time_steps().
bool libMesh::ExodusII_IO_Helper::opened_for_reading |
Definition at line 859 of file exodusII_io_helper.h.
bool libMesh::ExodusII_IO_Helper::opened_for_writing |
Definition at line 855 of file exodusII_io_helper.h.
Referenced by close(), create(), open(), and libMesh::Nemesis_IO_Helper::~Nemesis_IO_Helper().
std::vector<int> libMesh::ExodusII_IO_Helper::side_list |
Definition at line 753 of file exodusII_io_helper.h.
Referenced by get_sideset_data_indices(), read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
std::vector<std::string> libMesh::ExodusII_IO_Helper::sideset_var_names |
Definition at line 835 of file exodusII_io_helper.h.
Referenced by read_sideset_data(), and read_var_names().
std::vector<int> libMesh::ExodusII_IO_Helper::ss_ids |
Definition at line 707 of file exodusII_io_helper.h.
Referenced by get_side_set_id(), get_side_set_name(), get_sideset_data_indices(), read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
std::vector<Real> libMesh::ExodusII_IO_Helper::time_steps |
Definition at line 809 of file exodusII_io_helper.h.
Referenced by read_time_steps().
std::vector<char>& libMesh::ExodusII_IO_Helper::title |
Definition at line 636 of file exodusII_io_helper.h.
Referenced by ExodusII_IO_Helper(), and print_header().
bool libMesh::ExodusII_IO_Helper::verbose |
Definition at line 851 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::Nemesis_IO_Helper::compute_border_node_ids(), libMesh::Nemesis_IO_Helper::compute_communication_map_parameters(), libMesh::Nemesis_IO_Helper::compute_internal_and_border_elems_and_internal_nodes(), libMesh::Nemesis_IO_Helper::compute_node_communication_maps(), libMesh::Nemesis_IO_Helper::compute_num_global_elem_blocks(), libMesh::Nemesis_IO_Helper::compute_num_global_nodesets(), libMesh::Nemesis_IO_Helper::compute_num_global_sidesets(), libMesh::Nemesis_IO_Helper::construct_nemesis_filename(), create(), libMesh::Nemesis_IO_Helper::get_cmap_params(), libMesh::Nemesis_IO_Helper::get_eb_info_global(), libMesh::Nemesis_IO_Helper::get_elem_cmap(), libMesh::Nemesis_IO_Helper::get_elem_map(), libMesh::Nemesis_IO_Helper::get_init_global(), libMesh::Nemesis_IO_Helper::get_init_info(), libMesh::Nemesis_IO_Helper::get_loadbal_param(), libMesh::Nemesis_IO_Helper::get_node_cmap(), libMesh::Nemesis_IO_Helper::get_node_map(), libMesh::Nemesis_IO_Helper::get_ns_param_global(), libMesh::Nemesis_IO_Helper::get_ss_param_global(), message(), open(), print_header(), libMesh::Nemesis_IO_Helper::put_node_cmap(), read_elem_in_block(), read_elem_num_map(), read_node_num_map(), read_qa_records(), read_var_names_impl(), libMesh::Nemesis_IO_Helper::write_nodesets(), libMesh::Nemesis_IO_Helper::write_sidesets(), and write_var_names_impl().
std::vector<Real> libMesh::ExodusII_IO_Helper::w |
Definition at line 780 of file exodusII_io_helper.h.
Referenced by read_nodes().
std::vector<Real> libMesh::ExodusII_IO_Helper::x |
Definition at line 771 of file exodusII_io_helper.h.
Referenced by print_nodes(), read_nodes(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), and write_nodal_coordinates().
std::vector<Real> libMesh::ExodusII_IO_Helper::y |
Definition at line 774 of file exodusII_io_helper.h.
Referenced by print_nodes(), read_nodes(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), and write_nodal_coordinates().
std::vector<Real> libMesh::ExodusII_IO_Helper::z |
Definition at line 777 of file exodusII_io_helper.h.
Referenced by print_nodes(), read_nodes(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), and write_nodal_coordinates().