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 } |
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 | |
ExodusII_IO_Helper & | operator= (const ExodusII_IO_Helper &)=default |
ExodusII_IO_Helper & | operator= (ExodusII_IO_Helper &&)=default |
virtual | ~ExodusII_IO_Helper () |
const char * | get_elem_type () const |
void | open (const char *filename, bool read_only) |
Opens an ExodusII mesh file named filename . More... | |
void | read_header () |
Reads an ExodusII mesh file header. 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 | print_nodes (std::ostream &out=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_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_nodeset (int id) |
Reads information about nodeset id and inserts it into the global nodeset array at the position offset . More... | |
void | read_all_nodesets () |
New API that reads all nodesets simultaneously. More... | |
void | close () |
Closes the ExodusII mesh file. More... | |
int | inquire (int req_info, std::string error_msg="") |
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_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 | 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 | 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 | 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) const |
std::vector< std::set< subdomain_id_type > > | get_complex_vars_active_subdomains (const std::vector< std::set< subdomain_id_type >> &vars_active_subdomains) const |
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) 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 (const std::string &msg) |
Prints the message defined in msg . More... | |
void | message (const std::string &msg, int i) |
Prints the message defined in msg , and appends the number i to the end of the message. More... | |
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 |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
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... | |
Protected Attributes | |
bool | _run_only_on_proc0 |
bool | _elem_vars_initialized |
bool | _global_vars_initialized |
bool | _nodal_vars_initialized |
bool | _use_mesh_dimension_instead_of_spatial_dimension |
unsigned | _write_as_dimension |
Point | _coordinate_offset |
bool | _single_precision |
const Parallel::Communicator & | _communicator |
Private Member Functions | |
void | read_var_names_impl (const char *var_type, int &count, std::vector< std::string > &result) |
read_var_names() dispatches to this function. More... | |
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 | |
std::map< std::string, ElemType > | element_equivalence_map |
Defines equivalence classes of Exodus element types that map to libmesh ElemTypes. More... | |
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 80 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, or global variable names are read and which class members are filled in. NODAL: num_nodal_vars nodal_var_names ELEMENTAL: num_elem_vars elem_var_names GLOBAL: num_global_vars global_var_names SIDESET: num_sideset_vars sideset_var_names
Enumerator | |
---|---|
NODAL | |
ELEMENTAL | |
GLOBAL | |
SIDESET |
Definition at line 692 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 98 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 and assignable, but I don't know if any existing code actually uses these operations.
|
default |
|
virtualdefault |
|
protected |
When appending: during initialization, check that variable names in the file match those you attempt to initialize with.
Definition at line 2522 of file exodusII_io_helper.C.
References equal(), 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().
void libMesh::ExodusII_IO_Helper::close | ( | ) |
Closes the ExodusII
mesh file.
Definition at line 1228 of file exodusII_io_helper.C.
References _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 94 of file parallel_object.h.
References libMesh::ParallelObject::_communicator.
Referenced by libMesh::__libmesh_petsc_diff_solver_jacobian(), libMesh::__libmesh_petsc_diff_solver_monitor(), libMesh::__libmesh_petsc_diff_solver_residual(), libMesh::__libmesh_tao_equality_constraints(), libMesh::__libmesh_tao_equality_constraints_jacobian(), libMesh::__libmesh_tao_gradient(), libMesh::__libmesh_tao_hessian(), libMesh::__libmesh_tao_inequality_constraints(), libMesh::__libmesh_tao_inequality_constraints_jacobian(), libMesh::__libmesh_tao_objective(), libMesh::MeshRefinement::_coarsen_elements(), libMesh::ExactSolution::_compute_error(), libMesh::UniformRefinementEstimator::_estimate_error(), libMesh::BoundaryInfo::_find_id_maps(), libMesh::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::EquationSystems::_read_impl(), 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::ImplicitSystem::add_matrix(), libMesh::RBConstruction::add_scaled_matrix_and_vector(), libMesh::DynaIO::add_spline_constraints(), libMesh::System::add_vector(), libMesh::UnstructuredMesh::all_second_order(), 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::FEMSystem::assemble_qoi(), libMesh::MeshCommunication::assign_global_indices(), libMesh::DofMap::attach_matrix(), libMesh::MeshTools::Generation::build_extrusion(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::PetscDMWrapper::build_section(), libMesh::PetscDMWrapper::build_sf(), libMesh::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::Problem_Interface::computeF(), libMesh::Problem_Interface::computeJacobian(), libMesh::Problem_Interface::computePreconditioner(), libMesh::ExodusII_IO::copy_elemental_solution(), libMesh::ExodusII_IO::copy_scalar_solution(), 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::MeshCommunication::delete_remote_elements(), libMesh::DofMap::distribute_dofs(), DMlibMeshFunction(), DMlibMeshJacobian(), DMlibMeshSetSystem_libMesh(), DMVariableBounds_libMesh(), libMesh::DTKSolutionTransfer::DTKSolutionTransfer(), libMesh::MeshRefinement::eliminate_unrefined_patches(), libMesh::RBEIMConstruction::enrich_RB_space(), libMesh::TransientRBConstruction::enrich_RB_space(), libMesh::RBConstruction::enrich_RB_space(), libMesh::EpetraVector< T >::EpetraVector(), AssembleOptimization::equality_constraints(), libMesh::WeightedPatchRecoveryErrorEstimator::estimate_error(), libMesh::PatchRecoveryErrorEstimator::estimate_error(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::AdjointRefinementEstimator::estimate_error(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::RBEIMConstruction::evaluate_mesh_function(), 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::DofMap::gather_constraints(), libMesh::MeshfreeInterpolation::gather_remote_data(), libMesh::CondensedEigenSystem::get_eigenpair(), libMesh::DofMap::get_info(), libMesh::ImplicitSystem::get_linear_solver(), AssembleOptimization::inequality_constraints(), AssembleOptimization::inequality_constraints_jacobian(), libMesh::LocationMap< T >::init(), libMesh::TimeSolver::init(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), libMesh::EigenSystem::init_matrices(), libMesh::OptimizationSystem::initialize_equality_constraints_storage(), libMesh::OptimizationSystem::initialize_inequality_constraints_storage(), libMesh::RBEIMConstruction::initialize_rb_construction(), 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_parallel_consistent_new_node_procids(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Elem >(), libMesh::MeshTools::libmesh_assert_parallel_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_topology_consistent_procids< Node >(), libMesh::MeshTools::libmesh_assert_valid_boundary_ids(), libMesh::MeshTools::libmesh_assert_valid_dof_ids(), libMesh::MeshTools::libmesh_assert_valid_neighbors(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_flags(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_object_ids(), libMesh::DistributedMesh::libmesh_assert_valid_parallel_p_levels(), libMesh::MeshTools::libmesh_assert_valid_refinement_flags(), libMesh::MeshTools::libmesh_assert_valid_unique_ids(), libMesh::libmesh_petsc_preconditioner_apply(), libMesh::libmesh_petsc_snes_fd_residual(), libMesh::libmesh_petsc_snes_jacobian(), libMesh::libmesh_petsc_snes_mffd_residual(), libMesh::libmesh_petsc_snes_postcheck(), libMesh::libmesh_petsc_snes_residual(), libMesh::libmesh_petsc_snes_residual_helper(), libMesh::MeshRefinement::limit_level_mismatch_at_edge(), libMesh::MeshRefinement::limit_level_mismatch_at_node(), libMesh::MeshRefinement::limit_overrefined_boundary(), libMesh::MeshRefinement::limit_underrefined_boundary(), 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_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(), LinearElasticityWithContact::move_mesh(), libMesh::DistributedMesh::n_active_elem(), libMesh::MeshTools::n_active_levels(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::DofMap::n_constrained_dofs(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::CondensedEigenSystem::n_global_non_condensed_dofs(), libMesh::MeshTools::n_levels(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::MeshTools::n_p_levels(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::DistributedMesh::parallel_max_elem_id(), libMesh::DistributedMesh::parallel_max_node_id(), libMesh::ReplicatedMesh::parallel_max_unique_id(), libMesh::DistributedMesh::parallel_max_unique_id(), libMesh::DistributedMesh::parallel_n_elem(), libMesh::DistributedMesh::parallel_n_nodes(), libMesh::SparsityPattern::Build::parallel_sync(), libMesh::MeshTools::paranoid_n_levels(), libMesh::petsc_auto_fieldsplit(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::DofMap::print_dof_constraints(), FEMParameters::read(), libMesh::Nemesis_IO::read(), libMesh::XdrIO::read(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), 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::MeshRefinement::refine_and_coarsen_elements(), libMesh::DistributedMesh::renumber_dof_objects(), LinearElasticityWithContact::residual_and_jacobian(), OverlappingAlgebraicGhostingTest::run_ghosting_test(), OverlappingCouplingGhostingTest::run_sparsity_pattern_test(), libMesh::DofMap::scatter_constraints(), libMesh::CheckpointIO::select_split_config(), libMesh::TransientRBConstruction::set_error_temporal_data(), libMesh::RBEIMConstruction::set_explicit_sys_subvector(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::PetscDiffSolver::setup_petsc_data(), libMesh::LaplaceMeshSmoother::smooth(), libMesh::split_mesh(), libMesh::BoundaryInfo::sync(), libMesh::MeshRefinement::test_level_one(), MeshfunctionDFEM::test_mesh_function_dfem(), MeshfunctionDFEM::test_mesh_function_dfem_grad(), MeshFunctionTest::test_p_level(), libMesh::MeshRefinement::test_unflagged(), SystemsTest::testBlockRestrictedVarNDofs(), PointLocatorTest::testLocator(), BoundaryInfoTest::testMesh(), SystemsTest::testProjectCubeWithMeshFunction(), CheckpointIOTest::testSplitter(), libMesh::MeshTools::total_weight(), libMesh::MeshFunctionSolutionTransfer::transfer(), libMesh::MeshfreeSolutionTransfer::transfer(), libMesh::TransientRBConstruction::truth_assembly(), libMesh::RBConstruction::truth_assembly(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::TransientRBConstruction::update_RB_initial_condition_all_N(), libMesh::RBEIMConstruction::update_RB_system_matrices(), libMesh::TransientRBConstruction::update_RB_system_matrices(), libMesh::RBConstruction::update_RB_system_matrices(), libMesh::TransientRBConstruction::update_residual_terms(), libMesh::RBConstruction::update_residual_terms(), libMesh::NameBasedIO::write(), libMesh::XdrIO::write(), libMesh::VTKIO::write_nodal_data(), 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.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 1558 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, current_filename, ex_id, opened_for_writing, libMesh::out, libMesh::ParallelObject::processor_id(), libMesh::Real, and verbose.
Get the block number for the given block index.
Definition at line 742 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 751 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 | ) | const |
Definition at line 3188 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 | ) | 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 3227 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 | ) | const |
returns a "tripled" copy of vars_active_subdomains
, which is necessary in the complex-valued case.
Definition at line 3206 of file exodusII_io_helper.C.
const ExodusII_IO_Helper::Conversion & libMesh::ExodusII_IO_Helper::get_conversion | ( | const ElemType | type | ) | const |
Definition at line 383 of file exodusII_io_helper.C.
References conversion_map.
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(), read_edge_blocks(), 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 389 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 396 of file exodusII_io_helper.C.
References elem_type.
Get the node set id for the given node set index.
Definition at line 778 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 787 of file exodusII_io_helper.C.
References id_to_ns_names, and nodeset_ids.
Get the side set id for the given side set index.
Definition at line 760 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 769 of file exodusII_io_helper.C.
References id_to_ss_names, and ss_ids.
|
private |
Definition at line 146 of file exodusII_io_helper.C.
References conversion_map, libMesh::EDGE2, libMesh::EDGE3, libMesh::HEX20, libMesh::HEX27, libMesh::HEX8, libMesh::NODEELEM, libMesh::PRISM15, libMesh::PRISM18, libMesh::PRISM6, libMesh::PYRAMID13, libMesh::PYRAMID14, libMesh::PYRAMID5, libMesh::QUAD4, libMesh::QUAD8, libMesh::QUAD9, libMesh::QUADSHELL4, libMesh::QUADSHELL8, libMesh::TET10, libMesh::TET4, libMesh::TRI3, libMesh::TRI3SUBDIVISION, libMesh::TRI6, and libMesh::TRISHELL3.
Referenced by ExodusII_IO_Helper().
|
private |
Definition at line 293 of file exodusII_io_helper.C.
References libMesh::EDGE2, libMesh::EDGE3, element_equivalence_map, libMesh::HEX20, libMesh::HEX27, libMesh::HEX8, libMesh::NODEELEM, libMesh::PRISM15, libMesh::PRISM18, libMesh::PRISM6, libMesh::PYRAMID13, libMesh::PYRAMID14, libMesh::PYRAMID5, libMesh::QUAD4, libMesh::QUAD8, libMesh::QUAD9, libMesh::QUADSHELL4, libMesh::QUADSHELL8, libMesh::TET10, libMesh::TET4, libMesh::TRI3, libMesh::TRI6, and libMesh::TRISHELL3.
Referenced by ExodusII_IO_Helper().
|
virtual |
Initializes the Exodus file.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 1611 of file exodusII_io_helper.C.
References _run_only_on_proc0, _use_mesh_dimension_instead_of_spatial_dimension, _write_as_dimension, libMesh::BoundaryInfo::build_node_boundary_ids(), libMesh::BoundaryInfo::build_shellface_boundary_ids(), libMesh::BoundaryInfo::build_side_boundary_ids(), distance(), libMesh::err, ex_err, ex_id, libMesh::BoundaryInfo::get_edge_boundary_ids(), mesh, libMesh::MeshBase::mesh_dimension(), libMesh::BoundaryInfo::n_edge_conds(), num_dim, num_edge, num_edge_blk, num_elem, num_elem_blk, num_node_sets, num_nodes, num_side_sets, and libMesh::ParallelObject::processor_id().
|
virtual |
Sets up the nodal variables.
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 2403 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 2496 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 2468 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().
Definition at line 1247 of file exodusII_io_helper.C.
Referenced by read_all_nodesets(), read_num_time_steps(), read_qa_records(), read_sideset_info(), and write_information_records().
void libMesh::ExodusII_IO_Helper::message | ( | const std::string & | msg | ) |
Prints the message defined in msg
.
Can be turned off if verbosity is set to 0.
Definition at line 403 of file exodusII_io_helper.C.
References libMesh::out, and verbose.
Referenced by close(), read_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_header(), read_node_num_map(), read_nodes(), read_nodeset(), read_nodeset_info(), read_sideset(), and read_sideset_info().
void libMesh::ExodusII_IO_Helper::message | ( | const std::string & | 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 410 of file exodusII_io_helper.C.
References libMesh::out, and verbose.
|
inlineinherited |
Definition at line 100 of file parallel_object.h.
References libMesh::ParallelObject::_communicator.
Referenced by 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::LaplaceMeshSmoother::allgather_graph(), libMesh::DofMap::allgather_recursive_constraints(), libMesh::FEMSystem::assembly(), libMesh::AztecLinearSolver< T >::AztecLinearSolver(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::DistributedMesh::clear(), libMesh::Nemesis_IO_Helper::compute_border_node_ids(), libMesh::Nemesis_IO_Helper::construct_nemesis_filename(), libMesh::ExodusII_IO::copy_scalar_solution(), libMesh::UnstructuredMesh::create_pid_mesh(), libMesh::MeshTools::create_processor_bounding_box(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::EnsightIO::EnsightIO(), libMesh::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), libMesh::Nemesis_IO_Helper::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::partition(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::DofMap::prepare_send_list(), 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(), OverlappingFunctorTest::run_partitioner_test(), libMesh::DofMap::scatter_constraints(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), CheckpointIOTest::testSplitter(), WriteVecAndScalar::testWrite(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::GMVIO::write_binary(), libMesh::GMVIO::write_discontinuous_gmv(), libMesh::VTKIO::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().
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 492 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.
|
default |
|
default |
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 625 of file exodusII_io_helper.C.
References num_dim, num_elem, num_elem_blk, num_node_sets, num_nodes, num_side_sets, libMesh::out, title, and verbose.
void libMesh::ExodusII_IO_Helper::print_nodes | ( | std::ostream & | out = libMesh::out | ) |
|
inlineinherited |
Definition at line 106 of file parallel_object.h.
References libMesh::ParallelObject::_communicator.
Referenced by libMesh::BoundaryInfo::_find_id_maps(), libMesh::EquationSystems::_read_impl(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::DistributedMesh::add_elem(), libMesh::BoundaryInfo::add_elements(), libMesh::DofMap::add_neighbors_to_send_list(), libMesh::DistributedMesh::add_node(), libMesh::UnstructuredMesh::all_second_order(), libMesh::MeshTools::Modification::all_tri(), libMesh::DofMap::allgather_recursive_constraints(), libMesh::FEMSystem::assembly(), libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), libMesh::InfElemBuilder::build_inf_elem(), libMesh::BoundaryInfo::build_node_list_from_side_list(), libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::DistributedMesh::clear(), 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_scalar_solution(), libMesh::MeshTools::correct_node_proc_ids(), create(), libMesh::DistributedMesh::delete_elem(), libMesh::DistributedMesh::delete_node(), libMesh::MeshCommunication::delete_remote_elements(), libMesh::DofMap::distribute_dofs(), libMesh::DofMap::distribute_local_dofs_node_major(), libMesh::DofMap::distribute_local_dofs_var_major(), libMesh::DistributedMesh::DistributedMesh(), libMesh::DofMap::end_dof(), libMesh::DofMap::end_old_dof(), libMesh::EnsightIO::EnsightIO(), libMesh::RBEIMConstruction::evaluate_mesh_function(), libMesh::MeshFunction::find_element(), libMesh::MeshFunction::find_elements(), libMesh::UnstructuredMesh::find_neighbors(), libMesh::DofMap::first_dof(), libMesh::DofMap::first_old_dof(), 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::DofMap::get_info(), libMesh::Nemesis_IO_Helper::get_init_global(), libMesh::Nemesis_IO_Helper::get_init_info(), libMesh::Nemesis_IO_Helper::get_loadbal_param(), libMesh::DofMap::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::SystemSubsetBySubdomain::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), 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::DofMap::last_dof(), libMesh::TransientRBEvaluation::legacy_write_offline_data_to_files(), libMesh::RBEIMEvaluation::legacy_write_offline_data_to_files(), libMesh::RBEvaluation::legacy_write_offline_data_to_files(), libMesh::RBSCMEvaluation::legacy_write_offline_data_to_files(), libMesh::RBEIMEvaluation::legacy_write_out_interpolation_points_elem(), 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::MeshBase::n_active_local_elem(), libMesh::BoundaryInfo::n_boundary_conds(), libMesh::BoundaryInfo::n_edge_conds(), libMesh::DofMap::n_local_dofs(), libMesh::System::n_local_dofs(), libMesh::MeshBase::n_local_elem(), libMesh::MeshBase::n_local_nodes(), libMesh::BoundaryInfo::n_nodeset_conds(), libMesh::BoundaryInfo::n_shellface_conds(), libMesh::SparsityPattern::Build::operator()(), libMesh::DistributedMesh::own_node(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::System::point_value(), libMesh::DofMap::print_dof_constraints(), 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(), read_elem_num_map(), read_global_values(), libMesh::CheckpointIO::read_header(), libMesh::XdrIO::read_header(), libMesh::System::read_header(), libMesh::RBEvaluation::read_in_vectors_from_multiple_files(), libMesh::System::read_legacy_data(), 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::DistributedMesh::renumber_dof_objects(), libMesh::DofMap::scatter_constraints(), libMesh::CheckpointIO::select_split_config(), libMesh::DofMap::set_nonlocal_dof_objects(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::LaplaceMeshSmoother::smooth(), DefaultCouplingTest::testCoupling(), PointNeighborCouplingTest::testCoupling(), MeshInputTest::testDynaReadElem(), MeshInputTest::testDynaReadPatch(), MeshInputTest::testExodusCopyElementSolution(), MeshInputTest::testExodusWriteElementDataFromDiscontinuousNodalData(), SystemsTest::testProjectMatrix1D(), SystemsTest::testProjectMatrix2D(), SystemsTest::testProjectMatrix3D(), BoundaryInfoTest::testShellFaceConstraints(), CheckpointIOTest::testSplitter(), WriteVecAndScalar::testWrite(), libMesh::MeshTools::total_weight(), libMesh::MeshRefinement::uniformly_coarsen(), libMesh::Parallel::Packing< Node * >::unpack(), libMesh::Parallel::Packing< Elem * >::unpack(), libMesh::DistributedMesh::update_parallel_id_counts(), libMesh::DTKAdapter::update_variable_values(), 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(), 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::VTKIO::write_nodal_data(), libMesh::UCDIO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data(), libMesh::ExodusII_IO::write_nodal_data_discontinuous(), write_nodal_values(), libMesh::Nemesis_IO_Helper::write_nodesets(), write_nodesets(), libMesh::RBEvaluation::write_out_vectors(), 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 1164 of file exodusII_io_helper.C.
References _single_precision, libMesh::ExodusII_IO_Helper::MappedInputVector::data(), ex_err, ex_id, id_to_ns_names, inquire(), 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.
void libMesh::ExodusII_IO_Helper::read_block_info | ( | ) |
Reads information for all of the blocks in the ExodusII
mesh file.
Definition at line 692 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 852 of file exodusII_io_helper.C.
References libMesh::BoundaryInfo::add_edge(), libMesh::Elem::build(), connect, edge_block_ids, libMesh::BoundaryInfo::edgeset_name(), elem_type, ex_err, ex_id, get_conversion(), id_to_edge_block_names, mesh, message(), node_num_map, 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 797 of file exodusII_io_helper.C.
References block_ids, connect, elem_type, ex_err, ex_id, 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 996 of file exodusII_io_helper.C.
References 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 1476 of file exodusII_io_helper.C.
References _single_precision, block_ids, data, 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 the vector of global variables.
Definition at line 3151 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, ex_err, ex_id, num_global_vars, and libMesh::ParallelObject::processor_id().
void libMesh::ExodusII_IO_Helper::read_header | ( | ) |
Reads an ExodusII
mesh file header.
Definition at line 532 of file exodusII_io_helper.C.
References ex_err, ex_id, message(), num_dim, num_edge, num_edge_blk, num_elem, num_elem_blk, num_elem_vars, num_global_vars, num_nodal_vars, num_node_sets, num_nodes, num_side_sets, num_sideset_vars, read_num_time_steps(), and title.
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 1291 of file exodusII_io_helper.C.
References _single_precision, data, 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 660 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 | ( | ) |
void libMesh::ExodusII_IO_Helper::read_nodeset | ( | int | id | ) |
Reads information about nodeset id
and inserts it into the global nodeset array at the position offset
.
Definition at line 1131 of file exodusII_io_helper.C.
References ex_err, ex_id, message(), node_list, nodeset_ids, num_node_df_per_set, and num_nodes_per_set.
void libMesh::ExodusII_IO_Helper::read_nodeset_info | ( | ) |
Reads information about all of the nodesets in the ExodusII
mesh file.
Definition at line 1057 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 1283 of file exodusII_io_helper.C.
References inquire(), and num_time_steps.
Referenced by read_header(), 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 575 of file exodusII_io_helper.C.
References ex_err, ex_id, inquire(), libMesh::out, and verbose.
Reads information about sideset id
and inserts it into the global sideset array at the position offset
.
Definition at line 1086 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 2736 of file exodusII_io_helper.C.
References _single_precision, data, elem_list, 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, and ss_ids.
void libMesh::ExodusII_IO_Helper::read_sideset_info | ( | ) |
Reads information about all of the sidesets in the ExodusII
mesh file.
Definition at line 1022 of file exodusII_io_helper.C.
References elem_list, ex_err, ex_id, id_list, id_to_ss_names, inquire(), 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 1266 of file exodusII_io_helper.C.
References _single_precision, data, 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 1344 of file exodusII_io_helper.C.
References elem_var_names, ELEMENTAL, GLOBAL, global_var_names, NODAL, nodal_var_names, num_elem_vars, num_global_vars, num_nodal_vars, num_sideset_vars, read_var_names_impl(), SIDESET, and sideset_var_names.
Referenced by check_existing_vars(), read_elemental_var_values(), read_nodal_var_values(), and read_sideset_data().
|
private |
read_var_names() dispatches to this function.
Definition at line 1367 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().
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 3181 of file exodusII_io_helper.C.
References _coordinate_offset.
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 3167 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 3174 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 2854 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, ex_err, ex_id, get_block_id(), mesh, libMesh::MeshTools::n_elem(), num_elem_vars, and libMesh::ParallelObject::processor_id().
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 2937 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, libMesh::ExodusII_IO_Helper::MappedOutputVector::data(), distance(), ex_err, ex_id, get_block_id(), mesh, num_elem_vars, and libMesh::ParallelObject::processor_id().
|
virtual |
Writes the elements contained in "mesh".
FIXME: This only works for Meshes having a single type of element!
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 1827 of file exodusII_io_helper.C.
References _run_only_on_proc0, block_ids, libMesh::BoundaryInfo::build_edge_list(), connect, elem_num_map, libMesh::Utility::enum_to_string(), ex_err, ex_id, libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), get_conversion(), libMesh::BoundaryInfo::get_edgeset_name(), libMesh::DofObject::id(), libMesh::index_range(), libMesh::libmesh_assert(), libmesh_elem_num_to_exodus, libmesh_node_num_to_exodus, mesh, libMesh::Elem::node_id(), libMesh::Elem::node_index_range(), libMesh::Elem::node_ptr(), num_edge_blk, num_elem_blk, num_nodes_per_elem, libMesh::ParallelObject::processor_id(), libMesh::ExodusII_IO_Helper::NamesData::push_back_entry(), and libMesh::Elem::type().
void libMesh::ExodusII_IO_Helper::write_global_values | ( | const std::vector< Real > & | values, |
int | timestep | ||
) |
Writes the vector of global variables.
Definition at line 3131 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, ex_err, ex_id, num_global_vars, and libMesh::ParallelObject::processor_id().
void libMesh::ExodusII_IO_Helper::write_information_records | ( | const std::vector< std::string > & | records | ) |
Writes the vector of information records.
Definition at line 3092 of file exodusII_io_helper.C.
References _run_only_on_proc0, libMesh::err, ex_err, ex_id, libMesh::ExodusII_IO_Helper::NamesData::get_char_star_star(), inquire(), libMesh::ParallelObject::processor_id(), and libMesh::ExodusII_IO_Helper::NamesData::push_back_entry().
|
virtual |
Writes the nodal coordinates contained in "mesh".
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 1726 of file exodusII_io_helper.C.
References _coordinate_offset, _run_only_on_proc0, _single_precision, libMesh::ExodusII_IO_Helper::MappedOutputVector::data(), ex_err, ex_id, libMesh::DofObject::id(), libmesh_node_num_to_exodus, mesh, node_num_map, num_nodes, libMesh::ParallelObject::processor_id(), 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 3070 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, ex_err, ex_id, num_nodes, and libMesh::ParallelObject::processor_id().
Referenced by libMesh::Nemesis_IO_Helper::write_nodal_solution().
|
virtual |
Writes the nodesets contained in "mesh".
Reimplemented in libMesh::Nemesis_IO_Helper.
Definition at line 2317 of file exodusII_io_helper.C.
References _run_only_on_proc0, ex_err, ex_id, 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 2587 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, data, elem_list, 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_list, SIDESET, ss_ids, 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 2212 of file exodusII_io_helper.C.
References _run_only_on_proc0, ex_err, ex_id, get_conversion(), libMesh::index_range(), 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 2562 of file exodusII_io_helper.C.
References _run_only_on_proc0, _single_precision, ex_err, ex_id, and libMesh::ParallelObject::processor_id().
|
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 1408 of file exodusII_io_helper.C.
References ELEMENTAL, GLOBAL, NODAL, num_elem_vars, num_global_vars, num_nodal_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(), and write_sideset_data().
|
private |
write_var_names() dispatches to this function.
Definition at line 1438 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, libMesh::ExodusII_IO_Helper::NamesData::push_back_entry(), and verbose.
Referenced by write_var_names().
|
protectedinherited |
Definition at line 112 of file parallel_object.h.
Referenced by libMesh::EquationSystems::build_parallel_elemental_solution_vector(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::ParallelObject::comm(), libMesh::ParallelObject::n_processors(), libMesh::ParallelObject::operator=(), and libMesh::ParallelObject::processor_id().
|
protected |
Definition at line 737 of file exodusII_io_helper.h.
Referenced by set_coordinate_offset(), and write_nodal_coordinates().
|
protected |
Definition at line 719 of file exodusII_io_helper.h.
Referenced by initialize_element_variables(), and libMesh::Nemesis_IO_Helper::initialize_element_variables().
|
protected |
Definition at line 722 of file exodusII_io_helper.h.
Referenced by initialize_global_variables().
|
protected |
Definition at line 725 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables().
|
protected |
Definition at line 716 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_global_values(), write_information_records(), write_nodal_coordinates(), write_nodal_values(), write_nodesets(), write_sideset_data(), write_sidesets(), and write_timestep().
|
protected |
Definition at line 740 of file exodusII_io_helper.h.
Referenced by create(), libMesh::Nemesis_IO_Helper::create(), open(), read_all_nodesets(), read_elemental_var_values(), read_global_values(), read_nodal_var_values(), read_nodes(), read_sideset_data(), read_time_steps(), write_element_values(), write_element_values_element_major(), write_global_values(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), write_nodal_coordinates(), write_nodal_values(), write_sideset_data(), and write_timestep().
|
protected |
Definition at line 730 of file exodusII_io_helper.h.
Referenced by initialize(), and use_mesh_dimension_instead_of_spatial_dimension().
|
protected |
Definition at line 734 of file exodusII_io_helper.h.
Referenced by initialize(), and write_as_dimension().
std::vector<int> libMesh::ExodusII_IO_Helper::block_ids |
Definition at line 541 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 547 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.
Definition at line 823 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 681 of file exodusII_io_helper.h.
std::vector<int> libMesh::ExodusII_IO_Helper::edge_block_ids |
Definition at line 544 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 584 of file exodusII_io_helper.h.
Referenced by 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 599 of file exodusII_io_helper.h.
Referenced by read_elem_num_map(), read_elemental_var_values(), and write_elements().
std::vector<char> libMesh::ExodusII_IO_Helper::elem_type |
Definition at line 614 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 645 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 648 of file exodusII_io_helper.h.
|
private |
Defines equivalence classes of Exodus element types that map to libmesh ElemTypes.
Definition at line 816 of file exodusII_io_helper.h.
Referenced by get_conversion(), and init_element_equivalence_map().
int libMesh::ExodusII_IO_Helper::ex_err |
Definition at line 495 of file exodusII_io_helper.h.
Referenced by close(), initialize(), initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), inquire(), read_all_nodesets(), read_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_elemental_var_values(), read_global_values(), read_header(), read_nodal_var_values(), read_node_num_map(), read_nodes(), read_nodeset(), read_nodeset_info(), read_qa_records(), read_sideset(), read_sideset_data(), read_sideset_info(), read_time_steps(), read_var_names_impl(), libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), libMesh::Nemesis_IO_Helper::write_elements(), write_elements(), 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(), 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 492 of file exodusII_io_helper.h.
Referenced by close(), create(), libMesh::Nemesis_IO_Helper::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(), inquire(), 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_n_coord(), 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_block_info(), read_edge_blocks(), read_elem_in_block(), read_elem_num_map(), read_elemental_var_values(), read_global_values(), read_header(), read_nodal_var_values(), read_node_num_map(), read_nodes(), read_nodeset(), read_nodeset_info(), read_qa_records(), read_sideset(), read_sideset_data(), read_sideset_info(), read_time_steps(), read_var_names_impl(), libMesh::Nemesis_IO_Helper::write_element_values(), write_element_values(), write_element_values_element_major(), libMesh::Nemesis_IO_Helper::write_elements(), write_elements(), 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(), 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 619 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 624 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 651 of file exodusII_io_helper.h.
Referenced by initialize_global_variables(), and read_var_names().
std::vector<int> libMesh::ExodusII_IO_Helper::id_list |
Definition at line 593 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 657 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 658 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_ns_names |
Definition at line 660 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 659 of file exodusII_io_helper.h.
Referenced by get_side_set_name(), and read_sideset_info().
Definition at line 618 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_sideset_data(), libMesh::Nemesis_IO_Helper::write_sidesets(), and write_sidesets().
Definition at line 623 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(), and libMesh::Nemesis_IO_Helper::write_nodesets().
std::vector<std::string> libMesh::ExodusII_IO_Helper::nodal_var_names |
Definition at line 636 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables(), read_nodal_var_values(), and read_var_names().
std::vector<Real> libMesh::ExodusII_IO_Helper::nodal_var_values |
Definition at line 639 of file exodusII_io_helper.h.
Referenced by read_nodal_var_values().
std::vector<int> libMesh::ExodusII_IO_Helper::node_list |
Definition at line 590 of file exodusII_io_helper.h.
Referenced by read_nodeset().
std::vector<int> libMesh::ExodusII_IO_Helper::node_num_map |
Definition at line 596 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 581 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 573 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 569 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), and write_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::node_sets_node_list |
Definition at line 577 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), and write_nodesets().
std::vector<int> libMesh::ExodusII_IO_Helper::nodeset_ids |
Definition at line 553 of file exodusII_io_helper.h.
Referenced by get_node_set_id(), get_node_set_name(), read_all_nodesets(), read_nodeset(), read_nodeset_info(), and write_nodesets().
int libMesh::ExodusII_IO_Helper::num_attr |
Definition at line 535 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 562 of file exodusII_io_helper.h.
Referenced by read_sideset(), and read_sideset_info().
int libMesh::ExodusII_IO_Helper::num_dim |
Definition at line 498 of file exodusII_io_helper.h.
Referenced by initialize(), print_header(), read_header(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int libMesh::ExodusII_IO_Helper::num_edge |
Definition at line 516 of file exodusII_io_helper.h.
Referenced by initialize(), and read_header().
int libMesh::ExodusII_IO_Helper::num_edge_blk |
Definition at line 520 of file exodusII_io_helper.h.
Referenced by initialize(), read_block_info(), read_edge_blocks(), read_header(), and write_elements().
int libMesh::ExodusII_IO_Helper::num_elem |
Definition at line 510 of file exodusII_io_helper.h.
Referenced by initialize(), print_header(), read_elem_num_map(), read_header(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int libMesh::ExodusII_IO_Helper::num_elem_all_sidesets |
Definition at line 538 of file exodusII_io_helper.h.
Referenced by read_sideset_info().
int libMesh::ExodusII_IO_Helper::num_elem_blk |
Definition at line 513 of file exodusII_io_helper.h.
Referenced by initialize(), initialize_element_variables(), print_header(), read_block_info(), read_elemental_var_values(), read_header(), write_elements(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int libMesh::ExodusII_IO_Helper::num_elem_this_blk |
Definition at line 529 of file exodusII_io_helper.h.
Referenced by read_elem_in_block(), and read_elemental_var_values().
int libMesh::ExodusII_IO_Helper::num_elem_vars |
Definition at line 642 of file exodusII_io_helper.h.
Referenced by initialize_element_variables(), libMesh::Nemesis_IO_Helper::initialize_element_variables(), read_header(), read_var_names(), write_element_values(), write_element_values_element_major(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_global_vars |
Definition at line 501 of file exodusII_io_helper.h.
Referenced by initialize_global_variables(), read_global_values(), read_header(), read_var_names(), write_global_values(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_nodal_vars |
Definition at line 633 of file exodusII_io_helper.h.
Referenced by initialize_nodal_variables(), read_header(), read_var_names(), and write_var_names().
std::vector<int> libMesh::ExodusII_IO_Helper::num_node_df_per_set |
Definition at line 565 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), read_nodeset(), read_nodeset_info(), and write_nodesets().
int libMesh::ExodusII_IO_Helper::num_node_sets |
Definition at line 523 of file exodusII_io_helper.h.
Referenced by initialize(), print_header(), read_all_nodesets(), read_header(), read_nodeset_info(), and libMesh::Nemesis_IO_Helper::write_exodus_initialization_info().
int libMesh::ExodusII_IO_Helper::num_nodes |
Definition at line 507 of file exodusII_io_helper.h.
Referenced by libMesh::Nemesis_IO_Helper::build_element_and_node_maps(), initialize(), print_header(), print_nodes(), read_header(), 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(), and write_nodal_values().
int libMesh::ExodusII_IO_Helper::num_nodes_per_elem |
Definition at line 532 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 559 of file exodusII_io_helper.h.
Referenced by read_all_nodesets(), read_nodeset(), read_nodeset_info(), and write_nodesets().
int libMesh::ExodusII_IO_Helper::num_side_sets |
Definition at line 526 of file exodusII_io_helper.h.
Referenced by initialize(), print_header(), read_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 556 of file exodusII_io_helper.h.
Referenced by read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
int libMesh::ExodusII_IO_Helper::num_sideset_vars |
Definition at line 504 of file exodusII_io_helper.h.
Referenced by read_header(), read_sideset_data(), read_var_names(), and write_var_names().
int libMesh::ExodusII_IO_Helper::num_time_steps |
Definition at line 627 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 671 of file exodusII_io_helper.h.
bool libMesh::ExodusII_IO_Helper::opened_for_writing |
Definition at line 667 of file exodusII_io_helper.h.
Referenced by close(), create(), libMesh::Nemesis_IO_Helper::create(), open(), and libMesh::Nemesis_IO_Helper::~Nemesis_IO_Helper().
std::vector<int> libMesh::ExodusII_IO_Helper::side_list |
Definition at line 587 of file exodusII_io_helper.h.
Referenced by 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 654 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 550 of file exodusII_io_helper.h.
Referenced by get_side_set_id(), get_side_set_name(), read_sideset(), read_sideset_data(), read_sideset_info(), and write_sideset_data().
std::vector<Real> libMesh::ExodusII_IO_Helper::time_steps |
Definition at line 630 of file exodusII_io_helper.h.
Referenced by read_time_steps().
std::vector<char> libMesh::ExodusII_IO_Helper::title |
Definition at line 611 of file exodusII_io_helper.h.
Referenced by ExodusII_IO_Helper(), print_header(), and read_header().
bool libMesh::ExodusII_IO_Helper::verbose |
Definition at line 663 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::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::x |
Definition at line 602 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 605 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 608 of file exodusII_io_helper.h.
Referenced by print_nodes(), read_nodes(), libMesh::Nemesis_IO_Helper::write_nodal_coordinates(), and write_nodal_coordinates().