Panzer Version of the Day
|
#include <Panzer_STK_QuadraticToLinearMeshFactory.hpp>
Public Member Functions | |
QuadraticToLinearMeshFactory (const std::string &quadMeshFileName, stk::ParallelMachine mpi_comm=MPI_COMM_WORLD, const bool print_debug=false) | |
QuadraticToLinearMeshFactory (const Teuchos::RCP< panzer_stk::STK_Interface > &quadMesh, const bool print_debug=false) | |
Teuchos::RCP< STK_Interface > | buildMesh (stk::ParallelMachine parallelMach) const |
Build the mesh object. | |
virtual Teuchos::RCP< STK_Interface > | buildUncommitedMesh (stk::ParallelMachine parallelMach) const |
virtual void | completeMeshConstruction (STK_Interface &mesh, stk::ParallelMachine parallelMach) const |
void | setParameterList (const Teuchos::RCP< Teuchos::ParameterList > ¶mList) |
Derived from ParameterListAcceptor. | |
Teuchos::RCP< const Teuchos::ParameterList > | getValidParameters () const |
Derived from ParameterListAcceptor. | |
![]() | |
STK_MeshFactory () | |
virtual Teuchos::RCP< STK_Interface > | buildMesh (stk::ParallelMachine parallelMach) const =0 |
virtual Teuchos::RCP< STK_Interface > | buildUncommitedMesh (stk::ParallelMachine parallelMach) const =0 |
virtual void | completeMeshConstruction (STK_Interface &mesh, stk::ParallelMachine parallelMach) const =0 |
void | enableRebalance (bool enable, const Teuchos::RCP< const Teuchos::ParameterList > &rebalanceList=Teuchos::null) |
void | rebalance (STK_Interface &mesh) const |
double | getMeshCoord (const int nx, const double deltaX, const double x0) const |
Protected Member Functions | |
void | buildMetaData (stk::ParallelMachine parallelMach, STK_Interface &mesh) const |
void | buildElements (stk::ParallelMachine parallelMach, STK_Interface &mesh) const |
void | addSideSets (STK_Interface &mesh) const |
void | addNodeSets (STK_Interface &mesh) const |
void | addEdgeBlocks (STK_Interface &mesh) const |
void | copyCellFieldData (STK_Interface &mesh) const |
void | getOutputTopology () |
Protected Attributes | |
Teuchos::RCP< panzer_stk::STK_Interface > | quadMesh_ |
unsigned int | machRank_ |
Second order mesh. | |
unsigned int | machSize_ |
bool | createEdgeBlocks_ |
bool | offsetGIDs_ |
If true, offset mesh GIDs to exercise 32-bit limits. | |
stk::mesh::EntityId | offset_ |
bool | print_debug_ |
std::string | edgeBlockName_ |
const CellTopologyData * | outputTopoData_ |
unsigned int | nDim_ |
Output mesh topology data. | |
unsigned int | nNodes_ |
Dimension of the mesh. | |
std::vector< shards::CellTopology > | supportedInputTopos_ |
Nodes in one element of the linear basis. | |
std::map< const std::string, const CellTopologyData * > | outputTopoMap_ |
![]() | |
std::vector< Teuchos::RCP< const PeriodicBC_MatcherBase > > | periodicBCVec_ |
bool | useBBoxSearch_ |
bool | enableRebalance_ |
Teuchos::RCP< const Teuchos::ParameterList > | rebalanceList_ |
Additional Inherited Members | |
![]() | |
static void | parsePeriodicBCList (const Teuchos::RCP< Teuchos::ParameterList > &pl, std::vector< Teuchos::RCP< const PeriodicBC_MatcherBase > > &periodicBC, bool &useBBoxSearch) |
This class reads in a second-order (quadratic) mesh and converts it to a first-order (linear) mesh. It will create the cells/nodes/edges, copy the sideset and nodeset data, and copy a list of user provided cell (not nodal) field data into the mesh.
Definition at line 59 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
panzer_stk::QuadraticToLinearMeshFactory::QuadraticToLinearMeshFactory | ( | const std::string & | quadMeshFileName, |
stk::ParallelMachine | mpi_comm = MPI_COMM_WORLD , |
||
const bool | print_debug = false |
||
) |
Definition at line 56 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
panzer_stk::QuadraticToLinearMeshFactory::QuadraticToLinearMeshFactory | ( | const Teuchos::RCP< panzer_stk::STK_Interface > & | quadMesh, |
const bool | print_debug = false |
||
) |
Definition at line 77 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
virtual |
Build the mesh object.
Implements panzer_stk::STK_MeshFactory.
Definition at line 93 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
virtual |
This builds all the meta data of the mesh. Does not call metaData->commit. Allows user to add solution fields and other pieces. The mesh can be "completed" by calling completeMeshConstruction
.
Implements panzer_stk::STK_MeshFactory.
Definition at line 148 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
virtual |
Finishes building a mesh object started by buildUncommitedMesh
.
Implements panzer_stk::STK_MeshFactory.
Definition at line 166 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
void panzer_stk::QuadraticToLinearMeshFactory::setParameterList | ( | const Teuchos::RCP< Teuchos::ParameterList > & | paramList | ) |
Derived from ParameterListAcceptor.
From ParameterListAcceptor.
Definition at line 206 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
Teuchos::RCP< const Teuchos::ParameterList > panzer_stk::QuadraticToLinearMeshFactory::getValidParameters | ( | ) | const |
Derived from ParameterListAcceptor.
From ParameterListAcceptor.
Definition at line 221 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 246 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 332 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 403 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 432 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 435 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 453 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Infer the output topology from the given input mesh. Also, ensure the input mesh topology matches the parameter list. Currently, each element block must have the same topology.
Definition at line 116 of file Panzer_STK_QuadraticToLinearMeshFactory.cpp.
|
protected |
Definition at line 96 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
mutableprotected |
Second order mesh.
Definition at line 98 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Definition at line 98 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Definition at line 100 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
If true, offset mesh GIDs to exercise 32-bit limits.
Definition at line 103 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
mutableprotected |
Definition at line 104 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Definition at line 106 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Definition at line 108 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Definition at line 110 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Output mesh topology data.
Definition at line 112 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Dimension of the mesh.
Definition at line 113 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Nodes in one element of the linear basis.
List of currently supported input topologies.
Definition at line 116 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.
|
protected |
Map from input topology to the output shards topology data. The list here is currently supported. Right now, this is one-to-one and may need to be expanded.
Definition at line 125 of file Panzer_STK_QuadraticToLinearMeshFactory.hpp.