Panzer  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Panzer_STK_QuadraticToLinearMeshFactory.cpp
Go to the documentation of this file.
1 // @HEADER
2 // ***********************************************************************
3 //
4 // Panzer: A partial differential equation assembly
5 // engine for strongly coupled complex multiphysics systems
6 // Copyright (2011) Sandia Corporation
7 //
8 // Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation,
9 // the U.S. Government retains certain rights in this software.
10 //
11 // Redistribution and use in source and binary forms, with or without
12 // modification, are permitted provided that the following conditions are
13 // met:
14 //
15 // 1. Redistributions of source code must retain the above copyright
16 // notice, this list of conditions and the following disclaimer.
17 //
18 // 2. Redistributions in binary form must reproduce the above copyright
19 // notice, this list of conditions and the following disclaimer in the
20 // documentation and/or other materials provided with the distribution.
21 //
22 // 3. Neither the name of the Corporation nor the names of the
23 // contributors may be used to endorse or promote products derived from
24 // this software without specific prior written permission.
25 //
26 // THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
27 // EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
28 // IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
29 // PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
30 // CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
31 // EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
32 // PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
33 // PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
34 // LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
35 // NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
36 // SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
37 //
38 // Questions? Contact Roger P. Pawlowski (rppawlo@sandia.gov) and
39 // Eric C. Cyr (eccyr@sandia.gov)
40 // ***********************************************************************
41 // @HEADER
42 
43 #include "PanzerAdaptersSTK_config.hpp"
46 #include "Panzer_STK_Interface.hpp"
47 #include "Teuchos_TimeMonitor.hpp"
48 #include "Teuchos_StandardParameterEntryValidators.hpp" // for plist validation
49 #include <stk_mesh/base/FieldBase.hpp>
50 #include <stk_mesh/base/DumpMeshInfo.hpp>
51 
52 using Teuchos::RCP;
53 using Teuchos::rcp;
54 
55 namespace panzer_stk {
56 
58  stk::ParallelMachine mpi_comm,
59  const bool print_debug)
60  : createEdgeBlocks_(false),
61  print_debug_(print_debug)
62 {
63  panzer_stk::STK_ExodusReaderFactory factory;
65  pl->set("File Name",quadMeshFileName);
66  factory.setParameterList(pl);
67  quadMesh_ = factory.buildMesh(mpi_comm);
68 
69  // TODO for currently supported input topologies, this should always be true
70  // but may need to be generalized in the future
72 
73  // check the conversion is supported
74  // and get output topology
75  this->getOutputTopology();
76 }
77 
79  const bool print_debug)
80  : quadMesh_(quadMesh),
81  createEdgeBlocks_(false),
82  print_debug_(print_debug)
83 {
84  // TODO for currently supported input topologies, this should always be true
85  // but may need to be generalized in the future
87 
88  // check the conversion is supported
89  // and get output topology
90  this->getOutputTopology();
91 }
92 
95 {
96  PANZER_FUNC_TIME_MONITOR("panzer::QuadraticToLinearMeshFactory::buildMesh()");
97 
98  // Make sure the Comms match between the meshes
99  {
100  int result = MPI_UNEQUAL;
101  MPI_Comm_compare(parallelMach, quadMesh_->getBulkData()->parallel(), &result);
102  TEUCHOS_ASSERT(result != MPI_UNEQUAL);
103  }
104 
105  // build all meta data
106  RCP<STK_Interface> mesh = this->buildUncommitedMesh(parallelMach);
107 
108  // commit meta data
109  mesh->initialize(parallelMach);
110 
111  // build bulk data
112  this->completeMeshConstruction(*mesh,parallelMach);
113 
114  return mesh;
115 }
116 
118 {
119  bool errFlag = false;
120 
121  std::vector<std::string> eblock_names;
122  quadMesh_->getElementBlockNames(eblock_names);
123 
124  // check that we have a supported topology
125  auto inputTopo = quadMesh_->getCellTopology(eblock_names[0]);
126  if (std::find(supportedInputTopos_.begin(),
127  supportedInputTopos_.end(),*inputTopo) == supportedInputTopos_.end()) errFlag = true;
128  TEUCHOS_TEST_FOR_EXCEPTION(errFlag,std::logic_error,
129  "ERROR :: Input topology " << inputTopo->getName() << " currently unsupported by QuadraticToLinearMeshFactory!");
130 
131  // check that the topology is the same over blocks
132  // not sure this is 100% foolproof
133  for (auto & eblock : eblock_names) {
134  auto cellTopo = quadMesh_->getCellTopology(eblock);
135  if (*cellTopo != *inputTopo) errFlag = true;
136  }
137 
138  TEUCHOS_TEST_FOR_EXCEPTION(errFlag, std::logic_error,
139  "ERROR :: The mesh has different topologies on different blocks!");
140 
141  outputTopoData_ = outputTopoMap_[inputTopo->getName()];
142 
143  nDim_ = outputTopoData_->dimension;
144  nNodes_ = outputTopoData_->node_count;
145 
146  return;
147 }
148 
150 {
151  PANZER_FUNC_TIME_MONITOR("panzer::QuadraticToLinearMeshFactory::buildUncomittedMesh()");
152 
154 
155  machRank_ = stk::parallel_machine_rank(parallelMach);
156  machSize_ = stk::parallel_machine_size(parallelMach);
157 
158  // build meta information: blocks and side set setups
159  this->buildMetaData(parallelMach,*mesh);
160 
161  mesh->addPeriodicBCs(periodicBCVec_);
162  mesh->setBoundingBoxSearchFlag(useBBoxSearch_);
163 
164  return mesh;
165 }
166 
167 void QuadraticToLinearMeshFactory::completeMeshConstruction(STK_Interface & mesh,stk::ParallelMachine parallelMach) const
168 {
169  PANZER_FUNC_TIME_MONITOR("panzer::QuadraticToLinearMeshFactory::completeMeshConstruction()");
170 
171  if(not mesh.isInitialized())
172  mesh.initialize(parallelMach);
173 
174  // add node and element information
175  this->buildElements(parallelMach,mesh);
176 
177  // finish up the edges
178 #ifndef ENABLE_UNIFORM
179  mesh.buildSubcells();
180 #endif
181  mesh.buildLocalElementIDs();
182  if(createEdgeBlocks_) {
183  mesh.buildLocalEdgeIDs();
184  }
185 
186  // now that edges are built, sidesets can be added
187 #ifndef ENABLE_UNIFORM
188  this->addSideSets(mesh);
189 #endif
190 
191  // add nodesets
192  this->addNodeSets(mesh);
193 
194  // TODO this functionality may be untested
195  if(createEdgeBlocks_) {
196  this->addEdgeBlocks(mesh);
197  }
198 
199  // Copy field data
200  this->copyCellFieldData(mesh);
201 
202  // calls Stk_MeshFactory::rebalance
203  // this->rebalance(mesh);
204 }
205 
208 {
210 
211  setMyParamList(paramList);
212 
213  // offsetGIDs_ = (paramList->get<std::string>("Offset mesh GIDs above 32-bit int limit") == "ON") ? true : false;
214 
215  createEdgeBlocks_ = paramList->get<bool>("Create Edge Blocks");
216 
217  // read in periodic boundary conditions
218  parsePeriodicBCList(Teuchos::rcpFromRef(paramList->sublist("Periodic BCs")),periodicBCVec_,useBBoxSearch_);
219 }
220 
223 {
224  static RCP<Teuchos::ParameterList> defaultParams;
225 
226  // fill with default values
227  if(defaultParams == Teuchos::null) {
228  defaultParams = rcp(new Teuchos::ParameterList);
229 
230  defaultParams->set<std::string>("Offset mesh GIDs above 32-bit int limit", "OFF",
231  "If 64-bit GIDs are supported, the mesh element and node global indices will start at a value greater than 32-bit limit.",
232  rcp(new Teuchos::StringValidator(Teuchos::tuple<std::string>("OFF", "ON"))));
233 
234  // default to false for backward compatibility
235  defaultParams->set<bool>("Create Edge Blocks",false,"Create edge blocks in the mesh");
236 
237  Teuchos::ParameterList & bcs = defaultParams->sublist("Periodic BCs");
238  bcs.set<int>("Count",0); // no default periodic boundary conditions
239  }
240 
241  return defaultParams;
242 }
243 
244 void QuadraticToLinearMeshFactory::buildMetaData(stk::ParallelMachine /* parallelMach */, STK_Interface & mesh) const
245 {
246  if (print_debug_) {
247  std::cout << "\n\n**** DEBUG: begin printing source quad mesh exodus file metadata ****\n";
248  stk::mesh::impl::dump_all_meta_info(*(quadMesh_->getMetaData()), std::cout);
249  std::cout << "\n\n**** DEBUG: end printing source quad mesh exodus file metadata ****\n";
250  }
251 
252  // Required topologies
253  auto ctd = outputTopoData_;
254  // will only work for 2D and 3D meshes
255  const CellTopologyData * side_ctd = shards::CellTopology(ctd).getBaseCellTopologyData(nDim_-1,0);
256 
257  // Add in element blocks
258  std::vector<std::string> element_block_names;
259  quadMesh_->getElementBlockNames(element_block_names);
260  {
261  for (const auto& n : element_block_names)
262  mesh.addElementBlock(n,ctd);
263  }
264 
265  // Add in sidesets
266  {
267  std::vector<std::string> sideset_names;
268  quadMesh_->getSidesetNames(sideset_names);
269  for (const auto& n : sideset_names)
270  mesh.addSideset(n,side_ctd);
271  }
272 
273  // Add in nodesets
274  {
275  std::vector<std::string> nodeset_names;
276  quadMesh_->getNodesetNames(nodeset_names);
277  for (const auto& n : nodeset_names)
278  mesh.addNodeset(n);
279  }
280 
281  if(createEdgeBlocks_) {
282  const CellTopologyData * edge_ctd = shards::CellTopology(ctd).getBaseCellTopologyData(1,0);
283  std::vector<std::string> element_block_names;
284  quadMesh_->getElementBlockNames(element_block_names);
285  for (const auto& block_name : element_block_names)
286  mesh.addEdgeBlock(block_name,edgeBlockName_,edge_ctd);
287  }
288 
289  // Add in nodal fields
290  {
291  const auto& fields = quadMesh_->getMetaData()->get_fields(mesh.getNodeRank());
292  for (const auto& f : fields) {
293  if (print_debug_)
294  std::cout << "Field=" << f->name() << ", rank=" << f->entity_rank() << std::endl;
295 
296  // Cull out the coordinate fields. That is a default field in
297  // stk that is automatically created by stk.
298  if (f->name() != "coordinates") {
299  for (const auto& n : element_block_names)
300  mesh.addSolutionField(f->name(),n);
301  }
302  }
303  }
304 
305  // Add in element fields
306  {
307  const auto& fields = quadMesh_->getMetaData()->get_fields(mesh.getElementRank());
308  for (const auto& f : fields) {
309  if (print_debug_)
310  std::cout << "Add Cell Field=" << f->name() << ", rank=" << f->entity_rank() << std::endl;
311 
312  for (const auto& n : element_block_names)
313  mesh.addCellField(f->name(),n);
314  }
315  }
316 
317  // NOTE: skipping edge and face fields for now. Can't error out since sidesets count as edge fields.
318  // TEUCHOS_TEST_FOR_EXCEPTION(quadMesh_->getMetaData()->get_fields(mesh.getEdgeRank()).size() != 0,std::runtime_error,
319  // "ERROR: the Quad8 mesh contains edge fields\""
320  // << quadMesh_->getMetaData()->get_fields(mesh.getEdgeRank())[0]->name()
321  // << "\". Edge fields are not supported in Quad8ToQuad4!");
322 
323  if (print_debug_) {
324  std::cout << "\n\n**** DEBUG: begin printing source linear mesh exodus file metadata ****\n";
325  stk::mesh::impl::dump_all_meta_info(*(mesh.getMetaData()), std::cout);
326  std::cout << "\n\n**** DEBUG: end printing source linear mesh exodus file metadata ****\n";
327  }
328 }
329 
330 void QuadraticToLinearMeshFactory::buildElements(stk::ParallelMachine parallelMach,STK_Interface & mesh) const
331 {
332  mesh.beginModification();
333 
334  auto metadata = mesh.getMetaData();
335  auto bulkdata = mesh.getBulkData();
336 
337  // Loop over element blocks
338  std::vector<std::string> block_names;
339  quadMesh_->getElementBlockNames(block_names);
340  for (const auto& block_name : block_names) {
341 
342  // Get the elements on this process
343  std::vector<stk::mesh::Entity> elements;
344  quadMesh_->getMyElements(block_name,elements);
345 
346  if (print_debug_) {
347  std::cout << "*************************************************" << std::endl;
348  std::cout << "block_name=" << block_name << ", num_my_elements=" << elements.size() << std::endl;
349  std::cout << "*************************************************" << std::endl;
350  }
351 
352  for (const auto& element : elements) {
353 
354  const auto element_gid = quadMesh_->getBulkData()->identifier(element);
355 
356  if (print_debug_) {
357  std::cout << "rank=" << machRank_
358  << ", block=" << block_name
359  << ", element entity_id=" << element
360  << ", gid=" << element_gid << std::endl;
361  }
362 
363  // Register nodes with the mesh
364  std::vector<stk::mesh::EntityId> nodes(nNodes_);
365  for (size_t i=0; i < nNodes_; ++i) {
366  // NOTE: this assumes that the linear topology is nested in
367  // the quadratic topology as an extended topology - i.e. the first n
368  // nodes of the quadratic topology are the corresponding linear
369  // nodes. Shards topologies enforce this through the concept
370  // of extended topologies.
371  stk::mesh::Entity node_entity = quadMesh_->findConnectivityById(element,mesh.getNodeRank(),i);
372  TEUCHOS_ASSERT(node_entity.is_local_offset_valid());
373  const auto node_gid = quadMesh_->getBulkData()->identifier(node_entity);
374  const double* node_coords = quadMesh_->getNodeCoordinates(node_entity);
375  std::vector<double> coords_vec(nDim_);
376  for (size_t j=0; j < nDim_; ++j) coords_vec[j] = node_coords[j];
377  mesh.addNode(node_gid,coords_vec);
378  nodes[i]=node_gid;
379  if (print_debug_) {
380  if (nDim_==2) {
381  std::cout << "elem gid=" << quadMesh_->getBulkData()->identifier(element)
382  << ", node_gid=" << node_gid << ", ("
383  << coords_vec[0] << "," << coords_vec[1] << ")\n";
384  } else {
385  std::cout << "elem gid=" << quadMesh_->getBulkData()->identifier(element)
386  << ", node_gid=" << node_gid << ", ("
387  << coords_vec[0] << "," << coords_vec[1] << "," << coords_vec[2] << ")\n";
388  }
389  }
390  }
391 
392  // Register element with the element block
393  auto element_descriptor = panzer_stk::buildElementDescriptor(element_gid,nodes);
394  auto element_block_part = mesh.getMetaData()->get_part(block_name);
395  mesh.addElement(element_descriptor,element_block_part);
396  }
397  }
398  mesh.endModification();
399 }
400 
402 {
403  mesh.beginModification();
404 
405  // Loop over sidesets
406  std::vector<std::string> sideset_names;
407  quadMesh_->getSidesetNames(sideset_names);
408  for (const auto& sideset_name : sideset_names) {
409 
410  stk::mesh::Part* sideset_part = mesh.getSideset(sideset_name);
411 
412  std::vector<stk::mesh::Entity> q_sides;
413  quadMesh_->getMySides(sideset_name,q_sides);
414 
415  // Loop over edges
416  for (const auto q_ent : q_sides) {
417  // The edge numbering scheme uses the element/node gids, so it
418  // should be consistent between the quadratic and linear meshes
419  // since we used the same gids. We use this fact to populate
420  // the quadratic sidesets.
421  stk::mesh::EntityId ent_gid = quadMesh_->getBulkData()->identifier(q_ent);
422  stk::mesh::Entity lin_ent = mesh.getBulkData()->get_entity(mesh.getSideRank(),ent_gid);
423  mesh.addEntityToSideset(lin_ent,sideset_part);
424  }
425  }
426 
427  mesh.endModification();
428 }
429 
431 {}
432 
434 {
435  mesh.beginModification();
436 
439 
440  stk::mesh::Part * edge_block = mesh.getEdgeBlock(edgeBlockName_);
441 
442  stk::mesh::Selector owned_block = metaData->locally_owned_part();
443 
444  std::vector<stk::mesh::Entity> edges;
445  bulkData->get_entities(mesh.getEdgeRank(), owned_block, edges);
446  mesh.addEntitiesToEdgeBlock(edges, edge_block);
447 
448  mesh.endModification();
449 }
450 
452 {
453  // Vector of pointers to field data
454  const auto& fields = lin_mesh.getMetaData()->get_fields(lin_mesh.getElementRank());
455 
456  // loop over fields and add the data to the new mesh.
457  for (const auto& field : fields) {
458 
459  if (print_debug_)
460  std::cout << "Adding field values for \"" << *field << "\" to the linear mesh!\n";
461 
462  auto field_name = field->name();
463 
464  // Divide into scalar and vector fields, ignoring any other types
465  // for now.
466  if (field->type_is<double>() &&
467  field_name != "coordinates" &&
468  field_name != "PROC_ID" &&
469  field_name != "LOAD_BAL") {
470 
471  // Loop over element blocks
472  std::vector<std::string> block_names;
473  quadMesh_->getElementBlockNames(block_names);
474  for (const auto& block : block_names) {
475 
476  auto* lin_field = lin_mesh.getCellField(field_name,block);
477  TEUCHOS_ASSERT(lin_field != nullptr);
478  // The q mesh doesn't have the field names set up, so a query
479  // fails. Go to stk directly in this case.
480  auto* q_field = quadMesh_->getMetaData()->get_field(quadMesh_->getElementRank(),field_name);
481 #ifdef PANZER_DEBUG
482  TEUCHOS_ASSERT(q_field != nullptr);
483 #endif
484 
485  // Get the elements for this block.
486  std::vector<stk::mesh::Entity> lin_elements;
487  lin_mesh.getMyElements(block,lin_elements);
488  std::vector<stk::mesh::Entity> q_elements;
489  quadMesh_->getMyElements(block,q_elements);
490  TEUCHOS_ASSERT(lin_elements.size() == q_elements.size());
491 
492  for (size_t i=0; i < lin_elements.size(); ++i) {
493 #ifdef PANZER_DEBUG
494  TEUCHOS_ASSERT(lin_mesh.getBulkData()->identifier(lin_elements[i]) ==
495  quadMesh_->getBulkData()->identifier(q_elements[i]));
496 #endif
497 
498  double* const lin_val = static_cast<double*>(stk::mesh::field_data(*lin_field,lin_elements[i]));
499  const double* const q_val = static_cast<double*>(stk::mesh::field_data(*q_field,q_elements[i]));
500  *lin_val = *q_val;
501 
502  if (print_debug_) {
503  std::cout << "field=" << field_name << ", block=" << block
504  << ", lin_e(" << lin_mesh.getBulkData()->identifier(lin_elements[i]) << ") = " << *lin_val
505  << ", q_e(" << quadMesh_->getBulkData()->identifier(q_elements[i]) << ") = " << *q_val
506  << std::endl;
507  }
508 
509  }
510  }
511  }
512  }
513 }
514 
515 } // end panzer_stk
QuadraticToLinearMeshFactory(const std::string &quadMeshFileName, stk::ParallelMachine mpi_comm=MPI_COMM_WORLD, const bool print_debug=false)
Teuchos::RCP< ElementDescriptor > buildElementDescriptor(stk::mesh::EntityId elmtId, std::vector< stk::mesh::EntityId > &nodes)
void getSidesetNames(std::vector< std::string > &name) const
void addNodeset(const std::string &name)
static void parsePeriodicBCList(const Teuchos::RCP< Teuchos::ParameterList > &pl, std::vector< Teuchos::RCP< const PeriodicBC_MatcherBase > > &periodicBC, bool &useBBoxSearch)
std::map< const std::string, const CellTopologyData * > outputTopoMap_
void getElementBlockNames(std::vector< std::string > &names) const
T & get(const std::string &name, T def_value)
void buildElements(stk::ParallelMachine parallelMach, STK_Interface &mesh) const
ParameterList & set(std::string const &name, T const &value, std::string const &docString="", RCP< const ParameterEntryValidator > const &validator=null)
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
void addEntityToSideset(stk::mesh::Entity entity, stk::mesh::Part *sideset)
void addSolutionField(const std::string &fieldName, const std::string &blockId)
Teuchos::RCP< STK_Interface > buildMesh(stk::ParallelMachine parallelMach) const
Build the mesh object.
void addEdgeBlock(const std::string &elemBlockName, const std::string &edgeBlockName, const stk::topology &topology)
const double * getNodeCoordinates(stk::mesh::EntityId nodeId) const
stk::mesh::Part * getSideset(const std::string &name) const
void getMySides(const std::string &sideName, std::vector< stk::mesh::Entity > &sides) const
PHX::MDField< ScalarT, panzer::Cell, panzer::IP > result
A field that will be used to build up the result of the integral we&#39;re performing.
void addElement(const Teuchos::RCP< ElementDescriptor > &ed, stk::mesh::Part *block)
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters() const
Derived from ParameterListAcceptor.
stk::mesh::EntityRank getSideRank() const
void initialize(stk::ParallelMachine parallelMach, bool setupIO=true, const bool buildRefinementSupport=false)
Teuchos::RCP< stk::mesh::BulkData > getBulkData() const
void setMyParamList(const RCP< ParameterList > &paramList)
void validateParametersAndSetDefaults(ParameterList const &validParamList, int const depth=1000)
static const std::string edgeBlockString
void buildMetaData(stk::ParallelMachine parallelMach, STK_Interface &mesh) const
void addNode(stk::mesh::EntityId gid, const std::vector< double > &coord)
void addEntitiesToEdgeBlock(std::vector< stk::mesh::Entity > entities, stk::mesh::Part *edgeblock)
void buildSubcells()
force the mesh to build subcells: edges and faces
void setParameterList(const Teuchos::RCP< Teuchos::ParameterList > &paramList)
Derived from ParameterListAcceptor.
Teuchos::RCP< stk::mesh::MetaData > getMetaData() const
bool isInitialized() const
Has initialize been called on this mesh object?
stk::mesh::Entity findConnectivityById(stk::mesh::Entity src, stk::mesh::EntityRank tgt_rank, unsigned rel_id) const
void addSideset(const std::string &name, const CellTopologyData *ctData)
stk::mesh::Part * getEdgeBlock(const std::string &name) const
get the block part
PHX::MDField< ScalarT, panzer::Cell, panzer::BASIS > field
A field to which we&#39;ll contribute, or in which we&#39;ll store, the result of computing this integral...
std::vector< Teuchos::RCP< const PeriodicBC_MatcherBase > > periodicBCVec_
stk::mesh::EntityRank getEdgeRank() const
virtual void completeMeshConstruction(STK_Interface &mesh, stk::ParallelMachine parallelMach) const
ParameterList & sublist(const std::string &name, bool mustAlreadyExist=false, const std::string &docString="")
void getMyElements(std::vector< stk::mesh::Entity > &elements) const
#define TEUCHOS_ASSERT(assertion_test)
stk::mesh::EntityRank getNodeRank() const
void addCellField(const std::string &fieldName, const std::string &blockId)
stk::mesh::EntityRank getElementRank() const
virtual Teuchos::RCP< STK_Interface > buildUncommitedMesh(stk::ParallelMachine parallelMach) const
void addElementBlock(const std::string &name, const CellTopologyData *ctData)
stk::mesh::Field< double > * getCellField(const std::string &fieldName, const std::string &blockId) const
void getNodesetNames(std::vector< std::string > &name) const
Teuchos::RCP< const shards::CellTopology > getCellTopology(const std::string &eBlock) const
std::vector< shards::CellTopology > supportedInputTopos_
Nodes in one element of the linear basis.