Mesh Oriented datABase
(version 5.4.1)
Array-based unstructured mesh datastructure
|
Child helper class for Domain grid. More...
#include <NCHelperDomain.hpp>
Public Member Functions | |
NCHelperDomain (ReadNC *readNC, int fileId, const FileOptions &opts, EntityHandle fileSet) | |
ErrorCode | create_mesh (Range &faces) |
Implementation of NCHelper::create_mesh() | |
Static Public Member Functions | |
static bool | can_read_file (ReadNC *readNC, int fileId) |
Private Member Functions | |
virtual ErrorCode | init_mesh_vals () |
Interfaces to be implemented in child classes. | |
virtual std::string | get_mesh_type_name () |
Private Attributes | |
int | nv |
int | nvDim |
Child helper class for Domain grid.
Definition at line 16 of file NCHelperDomain.hpp.
moab::NCHelperDomain::NCHelperDomain | ( | ReadNC * | readNC, |
int | fileId, | ||
const FileOptions & | opts, | ||
EntityHandle | fileSet | ||
) | [inline] |
Definition at line 19 of file NCHelperDomain.hpp.
: ScdNCHelper( readNC, fileId, opts, fileSet ) { }
bool moab::NCHelperDomain::can_read_file | ( | ReadNC * | readNC, |
int | fileId | ||
) | [static] |
Definition at line 15 of file NCHelperDomain.cpp.
References moab::ReadNC::dimNames, moab::ReadNC::globalAtts, and NCFUNC.
Referenced by moab::NCHelper::get_nc_helper().
{ std::vector< std::string >& dimNames = readNC->dimNames; // If dimension names "n" AND "ni" AND "nj" AND "nv" exist then it should be the Domain grid if( ( std::find( dimNames.begin(), dimNames.end(), std::string( "n" ) ) != dimNames.end() ) && ( std::find( dimNames.begin(), dimNames.end(), std::string( "ni" ) ) != dimNames.end() ) && ( std::find( dimNames.begin(), dimNames.end(), std::string( "nj" ) ) != dimNames.end() ) && ( std::find( dimNames.begin(), dimNames.end(), std::string( "nv" ) ) != dimNames.end() ) ) { // Make sure it is CAM grid std::map< std::string, ReadNC::AttData >::iterator attIt = readNC->globalAtts.find( "source" ); if( attIt == readNC->globalAtts.end() ) return false; unsigned int sz = attIt->second.attLen; std::string att_data; att_data.resize( sz + 1 ); att_data[sz] = '\000'; int success = NCFUNC( get_att_text )( fileId, attIt->second.attVarId, attIt->second.attName.c_str(), &att_data[0] ); if( success ) return false; /*if (att_data.find("CAM") == std::string::npos) return false;*/ return true; } return false; }
ErrorCode moab::NCHelperDomain::create_mesh | ( | Range & | faces | ) | [virtual] |
Implementation of NCHelper::create_mesh()
Reimplemented from moab::ScdNCHelper.
Definition at line 237 of file NCHelperDomain.cpp.
References moab::NCHelper::_fileId, moab::NCHelper::_fileSet, moab::NCHelper::_readNC, moab::Core::a_entity_factory(), moab::Interface::add_entities(), moab::ParallelComm::assign_global_ids(), moab::Range::begin(), moab::AEntityFactory::create_vert_elem_adjacencies(), moab::ReadNC::dbgOut, moab::Range::end(), ErrorCode, moab::ScdNCHelper::gDims, moab::Core::get_connectivity(), moab::Interface::get_connectivity(), moab::ReadUtilIface::get_element_connect(), moab::Interface::get_entities_by_dimension(), moab::ReadUtilIface::get_node_coords(), moab::Range::insert(), moab::ScdNCHelper::lCDims, moab::ScdNCHelper::lDims, mb, MB_CHK_ERR, MB_CHK_SET_ERR, MB_SET_ERR, MB_SUCCESS, MB_TAG_CREAT, MB_TAG_DENSE, MB_TYPE_DOUBLE, moab::ReadNC::mbImpl, MBPOLYGON, MBQUAD, MBTRI, MBVERTEX, moab::ParallelMergeMesh::merge(), moab::ReadNC::mGlobalIdTag, NCFUNCAG, moab::AEntityFactory::notify_create_entity(), nv, moab::ReadNC::VarData::readCounts, moab::ReadNC::readMeshIface, moab::ReadNC::VarData::readStarts, moab::IntxUtils::remove_padded_vertices(), moab::Interface::tag_get_handle(), moab::Interface::tag_set_data(), moab::DebugOutput::tprintf(), moab::ReadNC::VarData::varId, moab::ReadNC::varInfo, and moab::AEntityFactory::vert_elem_adjacencies().
{ Interface*& mbImpl = _readNC->mbImpl; // std::string& fileName = _readNC->fileName; Tag& mGlobalIdTag = _readNC->mGlobalIdTag; // const Tag*& mpFileIdTag = _readNC->mpFileIdTag; DebugOutput& dbgOut = _readNC->dbgOut; /*int& gatherSetRank = _readNC->gatherSetRank; int& trivialPartitionShift = _readNC->trivialPartitionShift;*/ /* int rank = 0; int procs = 1; #ifdef MOAB_HAVE_MPI bool& isParallel = _readNC->isParallel; if (isParallel) { ParallelComm*& myPcomm = _readNC->myPcomm; rank = myPcomm->proc_config().proc_rank(); procs = myPcomm->proc_config().proc_size(); } #endif */ ErrorCode rval; int success = 0; /* bool create_gathers = false; if (rank == gatherSetRank) create_gathers = true; // Shift rank to obtain a rotated trivial partition int shifted_rank = rank; if (procs >= 2 && trivialPartitionShift > 0) shifted_rank = (rank + trivialPartitionShift) % procs;*/ // how many will have mask 0 or 1 // how many will have a fraction ? we will not instantiate all elements; only those with mask 1 // ? also, not all vertices, only those that belong to mask 1 elements ? we will not care about // duplicate vertices; maybe another time ? we will start reading masks, vertices int local_elems = ( lDims[4] - lDims[1] ) * ( lDims[3] - lDims[0] ); dbgOut.tprintf( 1, "local cells: %d \n", local_elems ); // count how many will be with mask 1 here // basically, read the mask variable on the local elements; std::string maskstr( "mask" ); ReadNC::VarData& vmask = _readNC->varInfo[maskstr]; // mask is (nj, ni) vmask.readStarts.push_back( lDims[1] ); vmask.readStarts.push_back( lDims[0] ); vmask.readCounts.push_back( lDims[4] - lDims[1] ); vmask.readCounts.push_back( lDims[3] - lDims[0] ); std::vector< int > mask( local_elems ); success = NCFUNCAG( _vara_int )( _fileId, vmask.varId, &vmask.readStarts[0], &vmask.readCounts[0], &mask[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read int data for mask variable " ); int nb_with_mask1 = 0; for( int i = 0; i < local_elems; i++ ) if( 1 == mask[i] ) nb_with_mask1++; dbgOut.tprintf( 1, "local cells with mask 1: %d \n", nb_with_mask1 ); std::vector< NCDF_SIZE > startsv( 3 ); startsv[0] = vmask.readStarts[0]; startsv[1] = vmask.readStarts[1]; startsv[2] = 0; std::vector< NCDF_SIZE > countsv( 3 ); countsv[0] = vmask.readCounts[0]; countsv[1] = vmask.readCounts[1]; countsv[2] = nv; // number of vertices per element // read xv and yv coords for vertices, and create elements; std::string xvstr( "xv" ); ReadNC::VarData& var_xv = _readNC->varInfo[xvstr]; std::vector< double > xv( local_elems * nv ); success = NCFUNCAG( _vara_double )( _fileId, var_xv.varId, &startsv[0], &countsv[0], &xv[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for xv variable " ); std::string yvstr( "yv" ); ReadNC::VarData& var_yv = _readNC->varInfo[yvstr]; std::vector< double > yv( local_elems * nv ); success = NCFUNCAG( _vara_double )( _fileId, var_yv.varId, &startsv[0], &countsv[0], &yv[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for yv variable " ); // read other variables, like xc, yc, frac, area std::string xcstr( "xc" ); ReadNC::VarData& var_xc = _readNC->varInfo[xcstr]; std::vector< double > xc( local_elems ); success = NCFUNCAG( _vara_double )( _fileId, var_xc.varId, &vmask.readStarts[0], &vmask.readCounts[0], &xc[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for xc variable " ); std::string ycstr( "yc" ); ReadNC::VarData& var_yc = _readNC->varInfo[ycstr]; std::vector< double > yc( local_elems ); success = NCFUNCAG( _vara_double )( _fileId, var_yc.varId, &vmask.readStarts[0], &vmask.readCounts[0], &yc[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for yc variable " ); std::string fracstr( "frac" ); ReadNC::VarData& var_frac = _readNC->varInfo[fracstr]; std::vector< double > frac( local_elems ); success = NCFUNCAG( _vara_double )( _fileId, var_frac.varId, &vmask.readStarts[0], &vmask.readCounts[0], &frac[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for frac variable " ); std::string areastr( "area" ); ReadNC::VarData& var_area = _readNC->varInfo[areastr]; std::vector< double > area( local_elems ); success = NCFUNCAG( _vara_double )( _fileId, var_area.varId, &vmask.readStarts[0], &vmask.readCounts[0], &area[0] ); if( success ) MB_SET_ERR( MB_FAILURE, "Failed to read double data for area variable " ); // create tags for them Tag areaTag, fracTag, xcTag, ycTag; rval = mbImpl->tag_get_handle( "area", 1, MB_TYPE_DOUBLE, areaTag, MB_TAG_DENSE | MB_TAG_CREAT );MB_CHK_SET_ERR( rval, "Trouble creating area tag" ); rval = mbImpl->tag_get_handle( "frac", 1, MB_TYPE_DOUBLE, fracTag, MB_TAG_DENSE | MB_TAG_CREAT );MB_CHK_SET_ERR( rval, "Trouble creating frac tag" ); rval = mbImpl->tag_get_handle( "xc", 1, MB_TYPE_DOUBLE, xcTag, MB_TAG_DENSE | MB_TAG_CREAT );MB_CHK_SET_ERR( rval, "Trouble creating xc tag" ); rval = mbImpl->tag_get_handle( "yc", 1, MB_TYPE_DOUBLE, ycTag, MB_TAG_DENSE | MB_TAG_CREAT );MB_CHK_SET_ERR( rval, "Trouble creating yc tag" ); // EntityHandle* conn_arr; EntityHandle vtx_handle; Range tmp_range; // set connectivity into that space EntityHandle start_cell; EntityType mdb_type = MBVERTEX; if( nv == 3 ) mdb_type = MBTRI; else if( nv == 4 ) mdb_type = MBQUAD; else if( nv > 4 ) // (nv > 4) mdb_type = MBPOLYGON; // for nv = 1 , type is vertex if( nv > 1 && nb_with_mask1 > 0 ) { rval = _readNC->readMeshIface->get_element_connect( nb_with_mask1, nv, mdb_type, 0, start_cell, conn_arr );MB_CHK_SET_ERR( rval, "Failed to create local cells" ); tmp_range.insert( start_cell, start_cell + nb_with_mask1 - 1 ); } // Create vertices; first identify different ones, with a tolerance std::map< Node3D, EntityHandle > vertex_map; if (nb_with_mask1 > 0) { // Set vertex coordinates // will read all xv, yv, but use only those with correct mask on int elem_index = 0; // total index in netcdf arrays const double pideg = acos( -1.0 ) / 180.0; for( ; elem_index < local_elems; elem_index++ ) { if( 0 == mask[elem_index] ) continue; // nothing to do, do not advance elem_index in actual moab arrays // set area and fraction on those elements too for( int k = 0; k < nv; k++ ) { int index_v_arr = nv * elem_index + k; double x, y; if( nv > 1 ) { x = xv[index_v_arr]; y = yv[index_v_arr]; double cosphi = cos( pideg * y ); double zmult = sin( pideg * y ); double xmult = cosphi * cos( x * pideg ); double ymult = cosphi * sin( x * pideg ); Node3D pt( xmult, ymult, zmult ); vertex_map[pt] = 0; } else { x = xc[elem_index]; y = yc[elem_index]; Node3D pt( x, y, 0 ); vertex_map[pt] = 0; } } } int nLocalVertices = (int)vertex_map.size(); std::vector< double* > arrays; EntityHandle start_vertex; rval = _readNC->readMeshIface->get_node_coords( 3, nLocalVertices, 0, start_vertex, arrays );MB_CHK_SET_ERR( rval, "Failed to create local vertices" ); vtx_handle = start_vertex; // Copy vertex coordinates into entity sequence coordinate arrays // and copy handle into vertex_map. double *x = arrays[0], *y = arrays[1], *z = arrays[2]; for( auto i = vertex_map.begin(); i != vertex_map.end(); ++i ) { i->second = vtx_handle; ++vtx_handle; *x = i->first.coords[0]; ++x; *y = i->first.coords[1]; ++y; *z = i->first.coords[2]; ++z; } // int nj = gDims[4]-gDims[1]; // is it about 1 in irregular cases int local_row_size = lCDims[3] - lCDims[0]; int global_row_size = gDims[3] - gDims[0]; // this is along elem_index = -1; int index = 0; // consider the mask for advancing in moab arrays; //printf(" map size :%ld \n", vertex_map.size()); // create now vertex arrays, size vertex_map.size() for (int j = lCDims[1]; j<lCDims[4]; j++) for (int i = lCDims[0]; i<lCDims[3]; i++) { elem_index++; if( 0 == mask[elem_index] ) continue; // nothing to do, do not advance elem_index in actual moab arrays // set area and fraction on those elements too for( int k = 0; k < nv; k++ ) { int index_v_arr = nv * elem_index + k; if( nv > 1 ) { double x = xv[index_v_arr]; double y = yv[index_v_arr]; double cosphi = cos( pideg * y ); double zmult = sin( pideg * y ); double xmult = cosphi * cos( x * pideg ); double ymult = cosphi * sin( x * pideg ); Node3D pt( xmult, ymult, zmult ); conn_arr[index * nv + k] = vertex_map[pt]; } } EntityHandle cell = start_vertex + index; if( nv > 1 ) cell = start_cell + index; // set other tags, like xc, yc, frac, area rval = mbImpl->tag_set_data( xcTag, &cell, 1, &xc[elem_index] );MB_CHK_SET_ERR( rval, "Failed to set xc tag" ); rval = mbImpl->tag_set_data( ycTag, &cell, 1, &yc[elem_index] );MB_CHK_SET_ERR( rval, "Failed to set yc tag" ); rval = mbImpl->tag_set_data( areaTag, &cell, 1, &area[elem_index] );MB_CHK_SET_ERR( rval, "Failed to set area tag" ); rval = mbImpl->tag_set_data( fracTag, &cell, 1, &frac[elem_index] );MB_CHK_SET_ERR( rval, "Failed to set frac tag" ); // set the global id too: int globalId = j * global_row_size + i + 1; rval = mbImpl->tag_set_data( mGlobalIdTag, &cell, 1, &globalId );MB_CHK_SET_ERR( rval, "Failed to set global id tag" ); index++; } rval = mbImpl->add_entities( _fileSet, tmp_range );MB_CHK_SET_ERR( rval, "Failed to add new cells to current file set" ); // modify local file set, to merge coincident vertices, and to correct repeated vertices in elements std::vector< Tag > tagList; tagList.push_back( mGlobalIdTag ); tagList.push_back( xcTag ); tagList.push_back( ycTag ); tagList.push_back( areaTag ); tagList.push_back( fracTag ); rval = IntxUtils::remove_padded_vertices( mbImpl, _fileSet, tagList );MB_CHK_SET_ERR( rval, "Failed to remove duplicate vertices" ); rval = mbImpl->get_entities_by_dimension( _fileSet, 2, faces );MB_CHK_ERR( rval ); Range all_verts; rval = mbImpl->get_connectivity( faces, all_verts );MB_CHK_ERR( rval ); //printf(" range vert size :%ld \n", all_verts.size()); rval = mbImpl->add_entities( _fileSet, all_verts );MB_CHK_ERR( rval ); // need to add adjacencies; TODO: fix this for all nc readers // copy this logic from migrate mesh in par comm graph Core* mb = (Core*)mbImpl; AEntityFactory* adj_fact = mb->a_entity_factory(); if( !adj_fact->vert_elem_adjacencies() ) adj_fact->create_vert_elem_adjacencies(); else { for( Range::iterator it = faces.begin(); it != faces.end(); ++it ) { EntityHandle eh = *it; const EntityHandle* conn = NULL; int num_nodes = 0; rval = mb->get_connectivity( eh, conn, num_nodes );MB_CHK_ERR( rval ); adj_fact->notify_create_entity( eh, conn, num_nodes ); } } } #ifdef MOAB_HAVE_MPI ParallelComm*& myPcomm = _readNC->myPcomm; if( myPcomm ) { double tol = 1.e-12; // this is the same as static tolerance in NCHelper ParallelMergeMesh pmm( myPcomm, tol ); rval = pmm.merge( _fileSet, /* do not do local merge*/ false, /* 2d cells*/ 2 );MB_CHK_SET_ERR( rval, "Failed to merge vertices in parallel" ); // assign global ids only for vertices, cells have them fine rval = myPcomm->assign_global_ids( _fileSet, /*dim*/ 0 );MB_CHK_ERR( rval ); } #endif return MB_SUCCESS; }
virtual std::string moab::NCHelperDomain::get_mesh_type_name | ( | ) | [inline, private, virtual] |
ErrorCode moab::NCHelperDomain::init_mesh_vals | ( | ) | [private, virtual] |
Interfaces to be implemented in child classes.
Implements moab::NCHelper.
Definition at line 44 of file NCHelperDomain.cpp.
References moab::NCHelper::_fileSet, moab::NCHelper::_readNC, moab::ScdInterface::compute_partition(), moab::ReadNC::dbgOut, moab::ReadNC::dimLens, moab::ReadNC::dimNames, moab::ReadNC::VarData::entLoc, moab::ReadNC::ENTLOCEWEDGE, moab::ReadNC::ENTLOCFACE, moab::ReadNC::ENTLOCNSEDGE, ErrorCode, moab::ScdParData::gDims, moab::ScdNCHelper::gDims, moab::ScdNCHelper::globallyPeriodic, moab::ScdNCHelper::iCDim, moab::ScdNCHelper::iDim, moab::ScdNCHelper::ilCVals, moab::ScdNCHelper::ilVals, moab::ReadNC::isParallel, moab::ScdNCHelper::jCDim, moab::ScdNCHelper::jDim, moab::ScdNCHelper::jlCVals, moab::ScdNCHelper::jlVals, moab::ScdNCHelper::lCDims, moab::ScdNCHelper::lDims, moab::NCHelper::levDim, moab::ScdNCHelper::locallyPeriodic, MB_CHK_ERR, MB_CHK_SET_ERR, MB_SET_ERR, MB_SUCCESS, MB_TAG_CREAT, MB_TAG_SPARSE, MB_TYPE_INTEGER, moab::ReadNC::mbImpl, moab::NCHelper::nLevels, moab::NCHelper::nTimeSteps, moab::ReadNC::VarData::numLev, nv, nvDim, moab::ReadNC::parData, moab::ScdParData::partMethod, moab::ReadNC::partMethod, moab::ScdParData::pDims, moab::ParallelComm::proc_config(), moab::ProcConfig::proc_rank(), moab::ProcConfig::proc_size(), moab::Interface::tag_get_handle(), moab::Interface::tag_set_data(), moab::NCHelper::tDim, moab::DebugOutput::tprintf(), moab::NCHelper::tVals, moab::ReadNC::VarData::varDims, and moab::ReadNC::varInfo.
{ Interface*& mbImpl = _readNC->mbImpl; std::vector< std::string >& dimNames = _readNC->dimNames; std::vector< int >& dimLens = _readNC->dimLens; std::map< std::string, ReadNC::VarData >& varInfo = _readNC->varInfo; DebugOutput& dbgOut = _readNC->dbgOut; #ifdef MOAB_HAVE_MPI bool& isParallel = _readNC->isParallel; #endif int& partMethod = _readNC->partMethod; ScdParData& parData = _readNC->parData; ErrorCode rval; // Look for names of i/j dimensions // First i std::vector< std::string >::iterator vit; unsigned int idx; if( ( vit = std::find( dimNames.begin(), dimNames.end(), "ni" ) ) != dimNames.end() ) idx = vit - dimNames.begin(); else { MB_SET_ERR( MB_FAILURE, "Couldn't find 'ni' variable" ); } iDim = idx; gDims[0] = 0; gDims[3] = dimLens[idx]; // Then j if( ( vit = std::find( dimNames.begin(), dimNames.end(), "nj" ) ) != dimNames.end() ) idx = vit - dimNames.begin(); else { MB_SET_ERR( MB_FAILURE, "Couldn't find 'nj' variable" ); } jDim = idx; gDims[1] = 0; gDims[4] = dimLens[idx]; // Add 2 for the pole points ? not needed // do not use gcdims ? or use only gcdims? // Try a truly 2D mesh gDims[2] = -1; gDims[5] = -1; // Get number of vertices per cell if( ( vit = std::find( dimNames.begin(), dimNames.end(), "nv" ) ) != dimNames.end() ) idx = vit - dimNames.begin(); else { MB_SET_ERR( MB_FAILURE, "Couldn't find 'nv' dimension" ); } nvDim = idx; nv = dimLens[idx]; // Parse options to get subset int rank = 0, procs = 1; #ifdef MOAB_HAVE_MPI if( isParallel ) { ParallelComm*& myPcomm = _readNC->myPcomm; rank = myPcomm->proc_config().proc_rank(); procs = myPcomm->proc_config().proc_size(); } #endif if( procs > 1 ) { for( int i = 0; i < 6; i++ ) parData.gDims[i] = gDims[i]; parData.partMethod = partMethod; int pdims[3]; locallyPeriodic[0] = locallyPeriodic[1] = locallyPeriodic[2] = 0; rval = ScdInterface::compute_partition( procs, rank, parData, lDims, locallyPeriodic, pdims );MB_CHK_ERR( rval ); for( int i = 0; i < 3; i++ ) parData.pDims[i] = pdims[i]; dbgOut.tprintf( 1, "Partition: %dx%d (out of %dx%d)\n", lDims[3] - lDims[0], lDims[4] - lDims[1], gDims[3] - gDims[0], gDims[4] - gDims[1] ); if( 0 == rank ) dbgOut.tprintf( 1, "Contiguous chunks of size %d bytes.\n", 8 * ( lDims[3] - lDims[0] ) * ( lDims[4] - lDims[1] ) ); } else { for( int i = 0; i < 6; i++ ) lDims[i] = gDims[i]; locallyPeriodic[0] = globallyPeriodic[0]; } // Now get actual coordinate values for vertices and cell centers lCDims[0] = lDims[0]; lCDims[3] = lDims[3]; // For FV models, will always be non-periodic in j lCDims[1] = lDims[1]; lCDims[4] = lDims[4]; #if 0 // Resize vectors to store values later if (-1 != lDims[0]) ilVals.resize(lDims[3] - lDims[0] + 1); if (-1 != lCDims[0]) ilCVals.resize(lCDims[3] - lCDims[0] + 1); if (-1 != lDims[1]) jlVals.resize(lDims[4] - lDims[1] + 1); if (-1 != lCDims[1]) jlCVals.resize(lCDims[4] - lCDims[1] + 1); if (nTimeSteps > 0) tVals.resize(nTimeSteps); #endif dbgOut.tprintf( 1, "I=%d-%d, J=%d-%d\n", lDims[0], lDims[3], lDims[1], lDims[4] ); dbgOut.tprintf( 1, "%d elements, %d vertices\n", ( lDims[3] - lDims[0] ) * ( lDims[4] - lDims[1] ), ( lDims[3] - lDims[0] ) * ( lDims[4] - lDims[1] ) * nv ); // For each variable, determine the entity location type and number of levels std::map< std::string, ReadNC::VarData >::iterator mit; for( mit = varInfo.begin(); mit != varInfo.end(); ++mit ) { ReadNC::VarData& vd = ( *mit ).second; // Default entLoc is ENTLOCSET if( std::find( vd.varDims.begin(), vd.varDims.end(), tDim ) != vd.varDims.end() ) { if( ( std::find( vd.varDims.begin(), vd.varDims.end(), iCDim ) != vd.varDims.end() ) && ( std::find( vd.varDims.begin(), vd.varDims.end(), jCDim ) != vd.varDims.end() ) ) vd.entLoc = ReadNC::ENTLOCFACE; else if( ( std::find( vd.varDims.begin(), vd.varDims.end(), jDim ) != vd.varDims.end() ) && ( std::find( vd.varDims.begin(), vd.varDims.end(), iCDim ) != vd.varDims.end() ) ) vd.entLoc = ReadNC::ENTLOCNSEDGE; else if( ( std::find( vd.varDims.begin(), vd.varDims.end(), jCDim ) != vd.varDims.end() ) && ( std::find( vd.varDims.begin(), vd.varDims.end(), iDim ) != vd.varDims.end() ) ) vd.entLoc = ReadNC::ENTLOCEWEDGE; } // Default numLev is 0 if( std::find( vd.varDims.begin(), vd.varDims.end(), levDim ) != vd.varDims.end() ) vd.numLev = nLevels; } std::vector< std::string > ijdimNames( 2 ); ijdimNames[0] = "__ni"; ijdimNames[1] = "__nj"; std::string tag_name; Tag tagh; // __<dim_name>_LOC_MINMAX (for slon, slat, lon and lat) for( unsigned int i = 0; i != ijdimNames.size(); i++ ) { std::vector< int > val( 2, 0 ); if( ijdimNames[i] == "__ni" ) { val[0] = lDims[0]; val[1] = lDims[3]; } else if( ijdimNames[i] == "__nj" ) { val[0] = lDims[1]; val[1] = lDims[4]; } std::stringstream ss_tag_name; ss_tag_name << ijdimNames[i] << "_LOC_MINMAX"; tag_name = ss_tag_name.str(); rval = mbImpl->tag_get_handle( tag_name.c_str(), 2, MB_TYPE_INTEGER, tagh, MB_TAG_SPARSE | MB_TAG_CREAT );MB_CHK_SET_ERR( rval, "Trouble creating conventional tag " << tag_name ); rval = mbImpl->tag_set_data( tagh, &_fileSet, 1, &val[0] );MB_CHK_SET_ERR( rval, "Trouble setting data to conventional tag " << tag_name ); if( MB_SUCCESS == rval ) dbgOut.tprintf( 2, "Conventional tag %s is created.\n", tag_name.c_str() ); } // __<dim_name>_LOC_VALS (for slon, slat, lon and lat) // Assume all have the same data type as lon (expected type is float or double) switch( varInfo["xc"].varDataType ) { case NC_FLOAT: case NC_DOUBLE: break; default: MB_SET_ERR( MB_FAILURE, "Unexpected variable data type for 'lon'" ); } // do not need conventional tags Tag convTagsCreated = 0; int def_val = 0; rval = mbImpl->tag_get_handle( "__CONV_TAGS_CREATED", 1, MB_TYPE_INTEGER, convTagsCreated, MB_TAG_SPARSE | MB_TAG_CREAT, &def_val );MB_CHK_SET_ERR( rval, "Trouble getting _CONV_TAGS_CREATED tag" ); int create_conv_tags_flag = 1; rval = mbImpl->tag_set_data( convTagsCreated, &_fileSet, 1, &create_conv_tags_flag );MB_CHK_SET_ERR( rval, "Trouble setting _CONV_TAGS_CREATED tag" ); return MB_SUCCESS; }
int moab::NCHelperDomain::nv [private] |
Definition at line 34 of file NCHelperDomain.hpp.
Referenced by create_mesh(), and init_mesh_vals().
int moab::NCHelperDomain::nvDim [private] |
Definition at line 35 of file NCHelperDomain.hpp.
Referenced by init_mesh_vals().