/******************************************************************** * 网格处理 * ********************************************************************/ void MeshOpt::setNodeInfo(hier::Patch<NDIM>& patch) { const hier::Index<NDIM> ifirst=patch.getBox().lower(); const hier::Index<NDIM> ilast =patch.getBox().upper(); int cols = ilast(0) - ifirst(0)+2; int rows = ilast(1) - ifirst(1)+2; int num_of_nodes = cols*rows; tbox::Array<bool> d_fixed_info(num_of_nodes,true); for(int row = 0; row < rows; row++) { for(int col = 0; col < cols; col++) { if(row == 0 || row == rows-1 || col == 0 || col == cols-1) { d_fixed_info[row*cols+col] = true; } else d_fixed_info[row*cols+col] = false; } } tbox::Pointer< pdat::NodeData<NDIM,bool> > fixed_info = patch.getPatchData(d_fixed_info_id); int count=-1; for(pdat::NodeIterator<NDIM> ic((*fixed_info).getBox()); ic; ic++) { (*fixed_info)(ic(),0) = d_fixed_info[++count]; } }
void PatchMultiblockTestStrategy::tagCellsInInputBoxes( hier::Patch& patch, int level_number, int tag_index) { if (level_number < static_cast<int>(d_refine_level_boxes.size())) { std::shared_ptr<pdat::CellData<int> > tags( SAMRAI_SHARED_PTR_CAST<pdat::CellData<int>, hier::PatchData>( patch.getPatchData(tag_index))); TBOX_ASSERT(tags); tags->fillAll(0); const hier::Box pbox = patch.getBox(); for (hier::BoxContainer::iterator k = d_refine_level_boxes[level_number].begin(); k != d_refine_level_boxes[level_number].end(); ++k) { tags->fill(1, *k * pbox, 0); } } }
void EdgeMultiblockTest::postprocessRefine( hier::Patch& fine, const hier::Patch& coarse, const std::shared_ptr<hier::VariableContext>& context, const hier::Box& fine_box, const hier::IntVector& ratio) const { pdat::EdgeDoubleConstantRefine ref_op; hier::BoxContainer fine_box_list(fine_box); hier::BoxContainer empty_box_list; xfer::BoxGeometryVariableFillPattern fill_pattern; for (int i = 0; i < static_cast<int>(d_variables.size()); ++i) { int id = hier::VariableDatabase::getDatabase()-> mapVariableAndContextToIndex(d_variables[i], context); std::shared_ptr<hier::PatchDataFactory> fine_pdf( fine.getPatchDescriptor()->getPatchDataFactory(id)); std::shared_ptr<hier::BoxOverlap> fine_overlap( fill_pattern.computeFillBoxesOverlap( fine_box_list, empty_box_list, fine.getBox(), fine.getPatchData(id)->getGhostBox(), *fine_pdf)); ref_op.refine(fine, coarse, id, id, *fine_overlap, ratio); } }
void PoissonGaussianSolution::setGridData( hier::Patch& patch, pdat::CellData<double>& exact_data, pdat::CellData<double>& source_data) { boost::shared_ptr<geom::CartesianPatchGeometry> patch_geom( BOOST_CAST<geom::CartesianPatchGeometry, hier::PatchGeometry>( patch.getPatchGeometry())); TBOX_ASSERT(patch_geom); const double* h = patch_geom->getDx(); const double* xl = patch_geom->getXLower(); const int* il = &patch.getBox().lower()[0]; { /* Set cell-centered data. */ double sl[SAMRAI::MAX_DIM_VAL]; // Like XLower, except for cell. int j; for (j = 0; j < d_dim.getValue(); ++j) { sl[j] = xl[j] + 0.5 * h[j]; } pdat::CellData<double>::iterator iter(pdat::CellGeometry::begin(patch.getBox())); pdat::CellData<double>::iterator iterend(pdat::CellGeometry::end(patch.getBox())); if (d_dim == tbox::Dimension(2)) { double x, y; for ( ; iter != iterend; ++iter) { const pdat::CellIndex& index = *iter; x = sl[0] + (index[0] - il[0]) * h[0]; y = sl[1] + (index[1] - il[1]) * h[1]; exact_data(index) = exactFcn(x, y); source_data(index) = sourceFcn(x, y); } } else if (d_dim == tbox::Dimension(3)) { double x, y, z; for ( ; iter != iterend; ++iter) { const pdat::CellIndex& index = *iter; x = sl[0] + (index[0] - il[0]) * h[0]; y = sl[1] + (index[1] - il[1]) * h[1]; z = sl[2] + (index[2] - il[2]) * h[2]; exact_data(index) = exactFcn(x, y, z); source_data(index) = sourceFcn(x, y, z); } } } } // End patch loop.
void CommTester::putCoordinatesToDatabase( std::shared_ptr<tbox::Database>& coords_db, const hier::Patch& patch) { std::shared_ptr<geom::CartesianPatchGeometry> pgeom( SAMRAI_SHARED_PTR_CAST<geom::CartesianPatchGeometry, hier::PatchGeometry>( patch.getPatchGeometry())); /* if (pgeom) { pgeom->putBlueprintCoords(coords_db, patch.getBox()); } */ const tbox::Dimension& dim(patch.getDim()); pdat::NodeData<double> coords(patch.getBox(), dim.getValue(), hier::IntVector::getZero(dim)); const hier::Index& box_lo = patch.getBox().lower(); const double* x_lo = pgeom->getXLower(); const double* dx = pgeom->getDx(); pdat::NodeIterator nend = pdat::NodeGeometry::end(patch.getBox()); for (pdat::NodeIterator itr(pdat::NodeGeometry::begin(patch.getBox())); itr != nend; ++itr) { const pdat::NodeIndex& ni = *itr; for (int d = 0; d < dim.getValue(); ++d) { coords(ni, d) = x_lo[d] + (ni(d)-box_lo(d))*dx[d]; } } coords_db->putString("type", "explicit"); std::shared_ptr<tbox::Database> values_db = coords_db->putDatabase("values"); int data_size = coords.getArrayData().getBox().size(); values_db->putDoubleArray("x", coords.getPointer(0), data_size); if (dim.getValue() > 1) { values_db->putDoubleArray("y", coords.getPointer(1), data_size); } if (dim.getValue() > 2) { values_db->putDoubleArray("z", coords.getPointer(2), data_size); } }
void MblkGeometry::buildCartesianGridOnPatch( const hier::Patch& patch, const int xyz_id, const int level_number, const int block_number) { boost::shared_ptr<pdat::NodeData<double> > xyz( BOOST_CAST<pdat::NodeData<double>, hier::PatchData>( patch.getPatchData(xyz_id))); TBOX_ASSERT(xyz); pdat::NodeIterator niend(pdat::NodeGeometry::end(patch.getBox())); for (pdat::NodeIterator ni(pdat::NodeGeometry::begin(patch.getBox())); ni != niend; ++ni) { pdat::NodeIndex node = *ni; if (d_block_rotation[block_number] == 0) { (*xyz)(node, 0) = d_cart_xlo[block_number][0] + node(0) * d_dx[level_number][block_number][0]; (*xyz)(node, 1) = d_cart_xlo[block_number][1] + node(1) * d_dx[level_number][block_number][1]; if (d_dim == tbox::Dimension(3)) { (*xyz)(node, 2) = d_cart_xlo[block_number][2] + node(2) * d_dx[level_number][block_number][2]; } } if (d_block_rotation[block_number] == 1) { // I sideways, J down (*xyz)(node, 0) = d_cart_xlo[block_number][0] - node(0) * d_dx[level_number][block_number][0]; (*xyz)(node, 1) = d_cart_xlo[block_number][1] + node(1) * d_dx[level_number][block_number][1]; if (d_dim == tbox::Dimension(3)) { (*xyz)(node, 2) = d_cart_xlo[block_number][2] + node(2) * d_dx[level_number][block_number][2]; } } } }
boost::shared_ptr<hier::PatchData> CellDataFactory<TYPE>::allocate( const hier::Patch& patch) const { TBOX_ASSERT_OBJDIM_EQUALITY2(*this, patch); return boost::make_shared<CellData<TYPE> >( patch.getBox(), d_depth, d_ghosts); }
/* ************************************************************************* * * Tag cells for spherical octant problem * ************************************************************************* */ void MblkGeometry::tagOctantCells( hier::Patch& patch, const int xyz_id, boost::shared_ptr<pdat::CellData<int> >& temp_tags, const double regrid_time, const int refine_tag_val) { TBOX_ASSERT(d_geom_problem == "SPHERICAL_SHELL" && d_sshell_type == "OCTANT"); TBOX_ASSERT(temp_tags); boost::shared_ptr<pdat::NodeData<double> > xyz( BOOST_CAST<pdat::NodeData<double>, hier::PatchData>( patch.getPatchData(xyz_id))); TBOX_ASSERT(xyz); if (d_dim == tbox::Dimension(3)) { /* * Tag in X direction only */ double xtag_loc_lo = d_sshell_rmin + (regrid_time * d_tag_velocity) - (0.5 * d_tag_width); double xtag_loc_hi = d_sshell_rmin + (regrid_time * d_tag_velocity) + (0.5 * d_tag_width); hier::Box pbox = patch.getBox(); for (int k = pbox.lower(2); k <= pbox.upper(2) + 1; ++k) { for (int j = pbox.lower(1); j <= pbox.upper(1) + 1; ++j) { for (int i = pbox.lower(0); i <= pbox.upper(0) + 1; ++i) { hier::Index ic(i, j, k); pdat::NodeIndex node(ic, pdat::NodeIndex::LLL); hier::Index icm1(i - 1, j - 1, k - 1); pdat::CellIndex cell(icm1); double node_x_loc = (*xyz)(node, 0); if ((node_x_loc > xtag_loc_lo) && (node_x_loc < xtag_loc_hi)) { (*temp_tags)(cell) = refine_tag_val; } } } } } }
/* ************************************************************************* * * Verify results of communication operations. This test must be * consistent with data initialization and boundary operations above. * ************************************************************************* */ bool EdgeMultiblockTest::verifyResults( const hier::Patch& patch, const std::shared_ptr<hier::PatchHierarchy> hierarchy, const int level_number, const hier::BlockId& block_id) { tbox::plog << "\nEntering EdgeMultiblockTest::verifyResults..." << endl; tbox::plog << "level_number = " << level_number << endl; tbox::plog << "Patch box = " << patch.getBox() << endl; hier::IntVector tgcw(d_dim, 0); for (int i = 0; i < static_cast<int>(d_variables.size()); ++i) { tgcw.max(patch.getPatchData(d_variables[i], getDataContext())-> getGhostCellWidth()); } hier::Box pbox = patch.getBox(); std::shared_ptr<pdat::EdgeData<double> > solution( new pdat::EdgeData<double>(pbox, 1, tgcw)); hier::Box tbox(pbox); tbox.grow(tgcw); std::shared_ptr<hier::BaseGridGeometry> grid_geom( hierarchy->getGridGeometry()); hier::BoxContainer singularity( grid_geom->getSingularityBoxContainer(block_id)); hier::IntVector ratio = hierarchy->getPatchLevel(level_number)->getRatioToLevelZero(); singularity.refine(ratio); bool test_failed = false; for (int i = 0; i < static_cast<int>(d_variables.size()); ++i) { double correct = (double)block_id.getBlockValue(); std::shared_ptr<pdat::EdgeData<double> > edge_data( SAMRAI_SHARED_PTR_CAST<pdat::EdgeData<double>, hier::PatchData>( patch.getPatchData(d_variables[i], getDataContext()))); TBOX_ASSERT(edge_data); int depth = edge_data->getDepth(); hier::Box interior_box(pbox); interior_box.grow(hier::IntVector(d_dim, -1)); for (int axis = 0; axis < d_dim.getValue(); ++axis) { pdat::EdgeIterator ciend(pdat::EdgeGeometry::end(interior_box, axis)); for (pdat::EdgeIterator ci(pdat::EdgeGeometry::begin(interior_box, axis)); ci != ciend; ++ci) { for (int d = 0; d < depth; ++d) { double result = (*edge_data)(*ci, d); if (!tbox::MathUtilities<double>::equalEps(correct, result)) { tbox::perr << "Test FAILED: ...." << " : edge index = " << *ci << endl; tbox::perr << " Variable = " << d_variable_src_name[i] << " : depth index = " << d << endl; tbox::perr << " result = " << result << " : correct = " << correct << endl; test_failed = true; } } } } hier::Box gbox = edge_data->getGhostBox(); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box patch_edge_box = pdat::EdgeGeometry::toEdgeBox(pbox, axis); hier::BoxContainer tested_neighbors; hier::BoxContainer sing_edge_boxlist; for (hier::BoxContainer::iterator si = singularity.begin(); si != singularity.end(); ++si) { sing_edge_boxlist.pushFront( pdat::EdgeGeometry::toEdgeBox(*si, axis)); } for (hier::BaseGridGeometry::ConstNeighborIterator ne( grid_geom->begin(block_id)); ne != grid_geom->end(block_id); ++ne) { const hier::BaseGridGeometry::Neighbor& nbr = *ne; if (nbr.isSingularity()) { continue; } correct = nbr.getBlockId().getBlockValue(); hier::BoxContainer neighbor_ghost(nbr.getTransformedDomain()); hier::BoxContainer neighbor_edge_ghost; for (hier::BoxContainer::iterator nn = neighbor_ghost.begin(); nn != neighbor_ghost.end(); ++nn) { hier::Box neighbor_ghost_interior( pdat::EdgeGeometry::toEdgeBox(*nn, axis)); neighbor_ghost_interior.grow(-hier::IntVector::getOne(d_dim)); neighbor_edge_ghost.pushFront(neighbor_ghost_interior); } neighbor_edge_ghost.refine(ratio); neighbor_edge_ghost.intersectBoxes( pdat::EdgeGeometry::toEdgeBox(gbox, axis)); neighbor_edge_ghost.removeIntersections(sing_edge_boxlist); neighbor_edge_ghost.removeIntersections(tested_neighbors); for (hier::BoxContainer::iterator ng = neighbor_edge_ghost.begin(); ng != neighbor_edge_ghost.end(); ++ng) { hier::Box::iterator ciend(ng->end()); for (hier::Box::iterator ci(ng->begin()); ci != ciend; ++ci) { pdat::EdgeIndex ei(*ci, 0, 0); ei.setAxis(axis); if (!patch_edge_box.contains(ei)) { for (int d = 0; d < depth; ++d) { double result = (*edge_data)(ei, d); if (!tbox::MathUtilities<double>::equalEps(correct, result)) { tbox::perr << "Test FAILED: ...." << " : edge index = " << ei << endl; tbox::perr << " Variable = " << d_variable_src_name[i] << " : depth index = " << d << endl; tbox::perr << " result = " << result << " : correct = " << correct << endl; test_failed = true; } } } } } tested_neighbors.spliceBack(neighbor_edge_ghost); } } std::shared_ptr<hier::PatchGeometry> pgeom(patch.getPatchGeometry()); for (int b = 0; b < d_dim.getValue(); ++b) { const std::vector<hier::BoundaryBox>& bdry = pgeom->getCodimensionBoundaries(b + 1); for (int k = 0; k < static_cast<int>(bdry.size()); ++k) { hier::Box fill_box = pgeom->getBoundaryFillBox(bdry[k], patch.getBox(), tgcw); fill_box = fill_box * gbox; if (bdry[k].getIsMultiblockSingularity()) { correct = 0.0; int num_sing_neighbors = 0; for (hier::BaseGridGeometry::ConstNeighborIterator ns( grid_geom->begin(block_id)); ns != grid_geom->end(block_id); ++ns) { const hier::BaseGridGeometry::Neighbor& nbr = *ns; if (nbr.isSingularity()) { hier::BoxContainer neighbor_ghost( nbr.getTransformedDomain()); neighbor_ghost.refine(ratio); neighbor_ghost.intersectBoxes(fill_box); if (neighbor_ghost.size()) { ++num_sing_neighbors; correct += nbr.getBlockId().getBlockValue(); } } } if (num_sing_neighbors == 0) { correct = (double)bdry[k].getLocationIndex() + 200.0; } else { correct /= (double)num_sing_neighbors; } } else { correct = (double)(bdry[k].getLocationIndex() + 100); } for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box patch_edge_box = pdat::EdgeGeometry::toEdgeBox(pbox, axis); pdat::EdgeIterator ciend(pdat::EdgeGeometry::end(fill_box, axis)); for (pdat::EdgeIterator ci(pdat::EdgeGeometry::begin(fill_box, axis)); ci != ciend; ++ci) { if (!patch_edge_box.contains(*ci)) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && bdry[k].getBox().numberCells(n) == 1) { if ((*ci)(n) == patch_edge_box.lower() (n) || (*ci)(n) == patch_edge_box.upper() (n)) { use_index = false; break; } } } if (use_index) { for (int d = 0; d < depth; ++d) { double result = (*edge_data)(*ci, d); if (!tbox::MathUtilities<double>::equalEps(correct, result)) { tbox::perr << "Test FAILED: ...." << " : edge index = " << *ci << endl; tbox::perr << " Variable = " << d_variable_src_name[i] << " : depth index = " << d << endl; tbox::perr << " result = " << result << " : correct = " << correct << endl; test_failed = true; } } } } } } } } } if (!test_failed) { tbox::plog << "EdgeMultiblockTest Successful!" << endl; } else { tbox::perr << "Multiblock EdgeMultiblockTest FAILED: \n" << endl; } solution.reset(); // just to be anal... tbox::plog << "\nExiting EdgeMultiblockTest::verifyResults..." << endl; tbox::plog << "level_number = " << level_number << endl; tbox::plog << "Patch box = " << patch.getBox() << endl << endl; return !test_failed; }
void MblkGeometry::buildSShellGridOnPatch( const hier::Patch& patch, const hier::Box& domain, const int xyz_id, const int level_number, const int block_number) { bool xyz_allocated = patch.checkAllocated(xyz_id); if (!xyz_allocated) { TBOX_ERROR("xyz data not allocated" << std::endl); //patch.allocatePatchData(xyz_id); } boost::shared_ptr<pdat::NodeData<double> > xyz( BOOST_CAST<pdat::NodeData<double>, hier::PatchData>( patch.getPatchData(xyz_id))); TBOX_ASSERT(xyz); if (d_dim == tbox::Dimension(3)) { const hier::Index ifirst = patch.getBox().lower(); const hier::Index ilast = patch.getBox().upper(); hier::IntVector nghost_cells = xyz->getGhostCellWidth(); //int imin = ifirst(0); //int imax = ilast(0) + 1; //int jmin = ifirst(1); //int jmax = ilast(1) + 1; //int kmin = ifirst(2); //int kmax = ilast(2) + 1; //int nx = imax - imin + 1; //int ny = jmax - jmin + 1; //int nxny = nx*ny; int nd_imin = ifirst(0) - nghost_cells(0); int nd_imax = ilast(0) + 1 + nghost_cells(0); int nd_jmin = ifirst(1) - nghost_cells(1); int nd_jmax = ilast(1) + 1 + nghost_cells(1); int nd_kmin = ifirst(2) - nghost_cells(2); int nd_kmax = ilast(2) + 1 + nghost_cells(2); int nd_nx = nd_imax - nd_imin + 1; int nd_ny = nd_jmax - nd_jmin + 1; int nd_nxny = nd_nx * nd_ny; double* x = xyz->getPointer(0); double* y = xyz->getPointer(1); double* z = xyz->getPointer(2); bool found = false; int nrad = (domain.upper(0) - domain.lower(0) + 1); int nth = (domain.upper(1) - domain.lower(1) + 1); int nphi = (domain.upper(2) - domain.lower(2) + 1); /* * If its a solid shell, its a single block and dx = dr, dth, dphi */ if (d_sshell_type == "SOLID") { d_dx[level_number][block_number][0] = (d_sshell_rmax - d_sshell_rmin) / (double)nrad; d_dx[level_number][block_number][1] = 2.0 * tbox::MathUtilities<double>::Abs(d_sangle_thmin) / (double)nth; d_dx[level_number][block_number][2] = 2.0 * tbox::MathUtilities<double>::Abs(d_sangle_thmin) / (double)nphi; // // step in a radial direction in x and set y and z appropriately // for a solid angle we go -th to th and -phi to phi // for (int k = nd_kmin; k <= nd_kmax; ++k) { for (int j = nd_jmin; j <= nd_jmax; ++j) { double theta = d_sangle_thmin + j * d_dx[level_number][block_number][1]; // dx used for dth double phi = d_sangle_thmin + k * d_dx[level_number][block_number][2]; double xface = cos(theta) * cos(phi); double yface = sin(theta) * cos(phi); double zface = sin(phi); for (int i = nd_imin; i <= nd_imax; ++i) { int ind = POLY3(i, j, k, nd_imin, nd_jmin, nd_kmin, nd_nx, nd_nxny); double r = d_sshell_rmin + d_dx[level_number][block_number][0] * (i); double xx = r * xface; double yy = r * yface; double zz = r * zface; x[ind] = xx; y[ind] = yy; z[ind] = zz; } } } found = true; } /* * If its an octant problem, then its got multiple (three) blocks */ if (d_sshell_type == "OCTANT") { double drad = (d_sshell_rmax - d_sshell_rmin) / nrad; // // as in the solid angle we go along a radial direction in // x setting y and z appropriately, but here we have logic for // the block we are in. This is contained in the dispOctant.m // matlab code. // for (int k = nd_kmin; k <= nd_kmax; ++k) { for (int j = nd_jmin; j <= nd_jmax; ++j) { // // compute the position on the unit sphere for our radial line // double xface, yface, zface; computeUnitSphereOctant(block_number, nth, j, k, &xface, &yface, &zface); for (int i = nd_imin; i <= nd_imax; ++i) { int ind = POLY3(i, j, k, nd_imin, nd_jmin, nd_kmin, nd_nx, nd_nxny); double r = d_sshell_rmin + drad * (i); double xx = r * xface; double yy = r * yface; double zz = r * zface; x[ind] = xx; y[ind] = yy; z[ind] = zz; } } } found = true; } if (!found) { TBOX_ERROR( d_object_name << ": " << "spherical shell nodal positions for " << d_sshell_type << " not found" << std::endl); } } }
void MblkGeometry::buildWedgeGridOnPatch( const hier::Patch& patch, const int xyz_id, const int level_number, const int block_number) { boost::shared_ptr<pdat::NodeData<double> > xyz( BOOST_CAST<pdat::NodeData<double>, hier::PatchData>( patch.getPatchData(xyz_id))); TBOX_ASSERT(xyz); const hier::Index ifirst = patch.getBox().lower(); const hier::Index ilast = patch.getBox().upper(); hier::IntVector nghost_cells = xyz->getGhostCellWidth(); int nd_imin = ifirst(0) - nghost_cells(0); int nd_imax = ilast(0) + 1 + nghost_cells(0); int nd_jmin = ifirst(1) - nghost_cells(1); int nd_jmax = ilast(1) + 1 + nghost_cells(1); int nd_nx = nd_imax - nd_imin + 1; int nd_ny = nd_jmax - nd_jmin + 1; //int nd_nz = nd_kmax - nd_kmin + 1; int nd_nxny = nd_nx * nd_ny; //int nd_nel = nd_nx*nd_ny*nd_nz; double dx[SAMRAI::MAX_DIM_VAL]; dx[0] = d_dx[level_number][block_number][0]; dx[1] = d_dx[level_number][block_number][1]; double* x = xyz->getPointer(0); double* y = xyz->getPointer(1); int nd_kmin; int nd_kmax; dx[2] = d_dx[level_number][block_number][2]; double* z = 0; if (d_dim == tbox::Dimension(3)) { nd_kmin = ifirst(2) - nghost_cells(2); nd_kmax = ilast(2) + 1 + nghost_cells(2); dx[2] = d_dx[level_number][block_number][2]; z = xyz->getPointer(2); } else { nd_kmin = 0; nd_kmax = 0; } // // ----------- set the wedge nodal positions // for (int k = nd_kmin; k <= nd_kmax; ++k) { for (int j = nd_jmin; j <= nd_jmax; ++j) { for (int i = nd_imin; i <= nd_imax; ++i) { int ind = POLY3(i, j, k, nd_imin, nd_jmin, nd_kmin, nd_nx, nd_nxny); double r = d_wedge_rmin[block_number] + dx[0] * (i); double th = d_wedge_thmin + dx[1] * (j); double xx = r * cos(th); double yy = r * sin(th); x[ind] = xx; y[ind] = yy; if (d_dim == tbox::Dimension(3)) { double zz = d_wedge_zmin + dx[2] * (k); z[ind] = zz; } } } } }
void PoissonGaussianSolution::setBcCoefs( const boost::shared_ptr<pdat::ArrayData<double> >& acoef_data, const boost::shared_ptr<pdat::ArrayData<double> >& bcoef_data, const boost::shared_ptr<pdat::ArrayData<double> >& gcoef_data, const boost::shared_ptr<hier::Variable>& variable, const hier::Patch& patch, const hier::BoundaryBox& bdry_box, const double fill_time) const { NULL_USE(variable); NULL_USE(fill_time); boost::shared_ptr<geom::CartesianPatchGeometry> patch_geom( BOOST_CAST<geom::CartesianPatchGeometry, hier::PatchGeometry>( patch.getPatchGeometry())); TBOX_ASSERT(patch_geom); /* * Set to an inhomogeneous Dirichlet boundary condition. */ hier::Box patch_box(patch.getBox()); const double* xlo = patch_geom->getXLower(); const double* xup = patch_geom->getXUpper(); const double* dx = patch_geom->getDx(); if (bdry_box.getBoundaryType() != 1) { // Must be a face boundary. TBOX_ERROR("Bad boundary type in\n" << "PoissonGaussianSolution::setBcCoefs \n"); } const hier::Box& box = bdry_box.getBox(); hier::Index lower = box.lower(); hier::Index upper = box.upper(); if (d_dim == tbox::Dimension(2)) { double* a_array = acoef_data ? acoef_data->getPointer() : 0; double* b_array = bcoef_data ? bcoef_data->getPointer() : 0; double* g_array = gcoef_data ? gcoef_data->getPointer() : 0; int i, j, ibeg, iend, jbeg, jend; double x, y; switch (bdry_box.getLocationIndex()) { case 0: // min i edge jbeg = box.lower()[1]; jend = box.upper()[1]; x = xlo[0]; for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); if (a_array) a_array[j - jbeg] = 1.0; if (b_array) b_array[j - jbeg] = 0.0; if (g_array) g_array[j - jbeg] = exactFcn(x, y); } break; case 1: // max i edge jbeg = box.lower()[1]; jend = box.upper()[1]; x = xup[0]; for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); if (a_array) a_array[j - jbeg] = 1.0; if (b_array) b_array[j - jbeg] = 0.0; if (g_array) g_array[j - jbeg] = exactFcn(x, y); } break; case 2: // min j edge ibeg = box.lower()[0]; iend = box.upper()[0]; y = xlo[1]; for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array[i - ibeg] = 1.0; if (b_array) b_array[i - ibeg] = 0.0; if (g_array) g_array[i - ibeg] = exactFcn(x, y); } break; case 3: // max j edge ibeg = box.lower()[0]; iend = box.upper()[0]; y = xup[1]; for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array[i - ibeg] = 1.0; if (b_array) b_array[i - ibeg] = 0.0; if (g_array) g_array[i - ibeg] = exactFcn(x, y); } break; default: TBOX_ERROR("Invalid location index in\n" << "PoissonGaussianSolution::setBcCoefs"); } } if (d_dim == tbox::Dimension(3)) { MDA_Access<double, 3, MDA_OrderColMajor<3> > a_array, b_array, g_array; if (acoef_data) a_array = pdat::ArrayDataAccess::access<3, double>( *acoef_data); if (bcoef_data) b_array = pdat::ArrayDataAccess::access<3, double>( *bcoef_data); if (gcoef_data) g_array = pdat::ArrayDataAccess::access<3, double>( *gcoef_data); int i, j, k, ibeg, iend, jbeg, jend, kbeg, kend; double x, y, z; switch (bdry_box.getLocationIndex()) { case 0: // min i side jbeg = box.lower()[1]; jend = box.upper()[1]; kbeg = box.lower()[2]; kend = box.upper()[2]; i = box.lower()[0] + 1; x = xlo[0]; for (k = kbeg; k <= kend; ++k) { z = xlo[2] + dx[2] * (k - patch_box.lower()[2] + 0.5); for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; case 1: // max i side jbeg = box.lower()[1]; jend = box.upper()[1]; kbeg = box.lower()[2]; kend = box.upper()[2]; i = box.upper()[0]; x = xup[0]; for (k = kbeg; k <= kend; ++k) { z = xlo[2] + dx[2] * (k - patch_box.lower()[2] + 0.5); for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; case 2: // min j side ibeg = box.lower()[0]; iend = box.upper()[0]; kbeg = box.lower()[2]; kend = box.upper()[2]; j = box.lower()[1] + 1; y = xlo[1]; for (k = kbeg; k <= kend; ++k) { z = xlo[2] + dx[2] * (k - patch_box.lower()[2] + 0.5); for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; case 3: // max j side ibeg = box.lower()[0]; iend = box.upper()[0]; kbeg = box.lower()[2]; kend = box.upper()[2]; j = box.upper()[1]; y = xup[1]; for (k = kbeg; k <= kend; ++k) { z = xlo[2] + dx[2] * (k - patch_box.lower()[2] + 0.5); for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; case 4: // min k side ibeg = box.lower()[0]; iend = box.upper()[0]; jbeg = box.lower()[1]; jend = box.upper()[1]; k = box.lower()[2] + 1; z = xlo[2]; for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; case 5: // max k side ibeg = box.lower()[0]; iend = box.upper()[0]; jbeg = box.lower()[1]; jend = box.upper()[1]; k = box.upper()[2]; z = xup[2]; for (j = jbeg; j <= jend; ++j) { y = xlo[1] + dx[1] * (j - patch_box.lower()[1] + 0.5); for (i = ibeg; i <= iend; ++i) { x = xlo[0] + dx[0] * (i - patch_box.lower()[0] + 0.5); if (a_array) a_array(i, j, k) = 1.0; if (b_array) b_array(i, j, k) = 0.0; if (g_array) g_array(i, j, k) = exactFcn(x, y, z); } } break; default: TBOX_ERROR("Invalid location index in\n" << "PoissonGaussianSolution::setBcCoefs"); } } }
void EdgeMultiblockTest::fillSingularityBoundaryConditions( hier::Patch& patch, const hier::PatchLevel& encon_level, std::shared_ptr<const hier::Connector> dst_to_encon, const hier::Box& fill_box, const hier::BoundaryBox& bbox, const std::shared_ptr<hier::BaseGridGeometry>& grid_geometry) { const tbox::Dimension& dim = fill_box.getDim(); const hier::BoxId& dst_mb_id = patch.getBox().getBoxId(); const hier::BlockId& patch_blk_id = patch.getBox().getBlockId(); for (int i = 0; i < static_cast<int>(d_variables.size()); ++i) { std::shared_ptr<pdat::EdgeData<double> > edge_data( SAMRAI_SHARED_PTR_CAST<pdat::EdgeData<double>, hier::PatchData>( patch.getPatchData(d_variables[i], getDataContext()))); TBOX_ASSERT(edge_data); hier::Box sing_fill_box(edge_data->getGhostBox() * fill_box); int depth = edge_data->getDepth(); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box pbox = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); hier::Index plower(pbox.lower()); hier::Index pupper(pbox.upper()); pdat::EdgeIterator niend(pdat::EdgeGeometry::end(sing_fill_box, axis)); for (pdat::EdgeIterator ni(pdat::EdgeGeometry::begin(sing_fill_box, axis)); ni != niend; ++ni) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && bbox.getBox().numberCells(n) == 1) { if ((*ni)(n) == plower(n) || (*ni)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { for (int d = 0; d < depth; ++d) { (*edge_data)(*ni, d) = 0.0; } } } } int num_encon_used = 0; if (grid_geometry->hasEnhancedConnectivity()) { hier::Connector::ConstNeighborhoodIterator ni = dst_to_encon->findLocal(dst_mb_id); if (ni != dst_to_encon->end()) { for (hier::Connector::ConstNeighborIterator ei = dst_to_encon->begin(ni); ei != dst_to_encon->end(ni); ++ei) { const hier::BlockId& encon_blk_id = ei->getBlockId(); std::shared_ptr<hier::Patch> encon_patch( encon_level.getPatch(ei->getBoxId())); hier::Transformation::RotationIdentifier rotation = hier::Transformation::NO_ROTATE; hier::IntVector offset(dim); hier::BaseGridGeometry::ConstNeighborIterator itr = grid_geometry->find(patch_blk_id, encon_blk_id); if (itr != grid_geometry->end(patch_blk_id)) { rotation = (*itr).getRotationIdentifier(); offset = (*itr).getShift(encon_level.getLevelNumber()); } hier::Transformation transformation(rotation, offset, encon_blk_id, patch_blk_id); hier::Box encon_patch_box(encon_patch->getBox()); transformation.transform(encon_patch_box); hier::Box encon_fill_box(encon_patch_box * sing_fill_box); if (!encon_fill_box.empty()) { const hier::Transformation::RotationIdentifier back_rotate = hier::Transformation::getReverseRotationIdentifier( rotation, dim); hier::IntVector back_shift(dim); hier::Transformation::calculateReverseShift( back_shift, offset, rotation); hier::Transformation back_trans(back_rotate, back_shift, patch_blk_id, encon_blk_id); std::shared_ptr<pdat::EdgeData<double> > sing_data( SAMRAI_SHARED_PTR_CAST<pdat::EdgeData<double>, hier::PatchData>( encon_patch->getPatchData( d_variables[i], getDataContext()))); TBOX_ASSERT(sing_data); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box pbox( pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis)); hier::Index plower(pbox.lower()); hier::Index pupper(pbox.upper()); pdat::EdgeIterator ciend(pdat::EdgeGeometry::end(sing_fill_box, axis)); for (pdat::EdgeIterator ci(pdat::EdgeGeometry::begin(sing_fill_box, axis)); ci != ciend; ++ci) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && bbox.getBox().numberCells(n) == 1) { if ((*ci)(n) == plower(n) || (*ci)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { pdat::EdgeIndex src_index(*ci); pdat::EdgeGeometry::transform(src_index, back_trans); for (int d = 0; d < depth; ++d) { (*edge_data)(*ci, d) += (*sing_data)(src_index, d); } } } } ++num_encon_used; } } } } if (num_encon_used) { for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box pbox = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); hier::Index plower(pbox.lower()); hier::Index pupper(pbox.upper()); pdat::EdgeIterator ciend(pdat::EdgeGeometry::end(sing_fill_box, axis)); for (pdat::EdgeIterator ci(pdat::EdgeGeometry::begin(sing_fill_box, axis)); ci != ciend; ++ci) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && bbox.getBox().numberCells(n) == 1) { if ((*ci)(n) == plower(n) || (*ci)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { for (int d = 0; d < depth; ++d) { (*edge_data)(*ci, d) /= num_encon_used; } } } } } else { /* * In cases of reduced connectivity, there are no other blocks * from which to acquire data. */ for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box pbox = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); hier::Index plower(pbox.lower()); hier::Index pupper(pbox.upper()); pdat::EdgeIterator ciend(pdat::EdgeGeometry::end(sing_fill_box, axis)); for (pdat::EdgeIterator ci(pdat::EdgeGeometry::begin(sing_fill_box, axis)); ci != ciend; ++ci) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && bbox.getBox().numberCells(n) == 1) { if ((*ci)(n) == plower(n) || (*ci)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { for (int d = 0; d < depth; ++d) { (*edge_data)(*ci, d) = (double)bbox.getLocationIndex() + 200.0; } } } } } } }
void EdgeMultiblockTest::setPhysicalBoundaryConditions( hier::Patch& patch, const double time, const hier::IntVector& gcw_to_fill) const { NULL_USE(time); std::shared_ptr<hier::PatchGeometry> pgeom(patch.getPatchGeometry()); const std::vector<hier::BoundaryBox>& node_bdry = pgeom->getCodimensionBoundaries(d_dim.getValue()); const int num_node_bdry_boxes = static_cast<int>(node_bdry.size()); std::vector<hier::BoundaryBox> empty_vector(0, hier::BoundaryBox(d_dim)); const std::vector<hier::BoundaryBox>& edge_bdry = d_dim > tbox::Dimension(1) ? pgeom->getCodimensionBoundaries(d_dim.getValue() - 1) : empty_vector; const int num_edge_bdry_boxes = static_cast<int>(edge_bdry.size()); const std::vector<hier::BoundaryBox>& face_bdry = d_dim == tbox::Dimension(3) ? pgeom->getCodimensionBoundaries(d_dim.getValue() - 2) : empty_vector; const int num_face_bdry_boxes = static_cast<int>(face_bdry.size()); for (int i = 0; i < static_cast<int>(d_variables.size()); ++i) { std::shared_ptr<pdat::EdgeData<double> > edge_data( SAMRAI_SHARED_PTR_CAST<pdat::EdgeData<double>, hier::PatchData>( patch.getPatchData(d_variables[i], getDataContext()))); TBOX_ASSERT(edge_data); /* * Set node boundary data. */ for (int nb = 0; nb < num_node_bdry_boxes; ++nb) { hier::Box fill_box = pgeom->getBoundaryFillBox(node_bdry[nb], patch.getBox(), gcw_to_fill); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box patch_edge_box = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); if (!node_bdry[nb].getIsMultiblockSingularity()) { pdat::EdgeIterator niend(pdat::EdgeGeometry::end(fill_box, axis)); for (pdat::EdgeIterator ni(pdat::EdgeGeometry::begin(fill_box, axis)); ni != niend; ++ni) { if (!patch_edge_box.contains(*ni)) { for (int d = 0; d < edge_data->getDepth(); ++d) { (*edge_data)(*ni, d) = (double)(node_bdry[nb].getLocationIndex() + 100); } } } } } } if (d_dim > tbox::Dimension(1)) { /* * Set edge boundary data. */ for (int eb = 0; eb < num_edge_bdry_boxes; ++eb) { hier::Box fill_box = pgeom->getBoundaryFillBox(edge_bdry[eb], patch.getBox(), gcw_to_fill); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box patch_edge_box = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); hier::Index plower(patch_edge_box.lower()); hier::Index pupper(patch_edge_box.upper()); if (!edge_bdry[eb].getIsMultiblockSingularity()) { pdat::EdgeIterator niend(pdat::EdgeGeometry::end(fill_box, axis)); for (pdat::EdgeIterator ni(pdat::EdgeGeometry::begin(fill_box, axis)); ni != niend; ++ni) { if (!patch_edge_box.contains(*ni)) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && edge_bdry[eb].getBox().numberCells(n) == 1) { if ((*ni)(n) == plower(n) || (*ni)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { for (int d = 0; d < edge_data->getDepth(); ++d) { (*edge_data)(*ni, d) = (double)(edge_bdry[eb].getLocationIndex() + 100); } } } } } } } } if (d_dim == tbox::Dimension(3)) { /* * Set face boundary data. */ for (int fb = 0; fb < num_face_bdry_boxes; ++fb) { hier::Box fill_box = pgeom->getBoundaryFillBox(face_bdry[fb], patch.getBox(), gcw_to_fill); for (int axis = 0; axis < d_dim.getValue(); ++axis) { hier::Box patch_edge_box = pdat::EdgeGeometry::toEdgeBox(patch.getBox(), axis); hier::Index plower(patch_edge_box.lower()); hier::Index pupper(patch_edge_box.upper()); if (!face_bdry[fb].getIsMultiblockSingularity()) { pdat::EdgeIterator niend(pdat::EdgeGeometry::end(fill_box, axis)); for (pdat::EdgeIterator ni(pdat::EdgeGeometry::begin(fill_box, axis)); ni != niend; ++ni) { if (!patch_edge_box.contains(*ni)) { bool use_index = true; for (tbox::Dimension::dir_t n = 0; n < d_dim.getValue(); ++n) { if (axis != n && face_bdry[fb].getBox().numberCells(n) == 1) { if ((*ni)(n) == plower(n) || (*ni)(n) == pupper(n)) { use_index = false; break; } } } if (use_index) { (*edge_data)(*ni) = (double)(face_bdry[fb].getLocationIndex() + 100); } } } } } } } } }
void BoundaryDataTester::setPhysicalBoundaryConditions( hier::Patch& patch, const double fill_time, const hier::IntVector& ghost_width_to_fill) { NULL_USE(fill_time); tbox::plog << "\n\nFilling boundary data on patch = " << patch.getBox() << endl; tbox::plog << "ghost_width_to_fill = " << ghost_width_to_fill << endl; for (int iv = 0; iv < static_cast<int>(d_variables.size()); ++iv) { std::shared_ptr<pdat::CellData<double> > cvdata( SAMRAI_SHARED_PTR_CAST<pdat::CellData<double>, hier::PatchData>( patch.getPatchData(d_variables[iv], d_variable_context))); TBOX_ASSERT(cvdata); tbox::plog << "\n iv = " << iv << " : " << d_variable_name[iv] << endl; tbox::plog << " depth = " << cvdata->getDepth() << endl; hier::IntVector fill_gcw(hier::IntVector::min(cvdata->getGhostCellWidth(), ghost_width_to_fill)); if (d_dim == tbox::Dimension(3)) { appu::CartesianBoundaryUtilities3:: fillFaceBoundaryData(d_variable_name[iv], cvdata, patch, fill_gcw, ((cvdata->getDepth() > 1) ? d_vector_bdry_face_conds : d_scalar_bdry_face_conds), d_variable_bc_values[iv]); appu::CartesianBoundaryUtilities3:: fillEdgeBoundaryData(d_variable_name[iv], cvdata, patch, fill_gcw, ((cvdata->getDepth() > 1) ? d_vector_bdry_edge_conds : d_scalar_bdry_edge_conds), d_variable_bc_values[iv]); appu::CartesianBoundaryUtilities3:: fillNodeBoundaryData(d_variable_name[iv], cvdata, patch, fill_gcw, ((cvdata->getDepth() > 1) ? d_vector_bdry_node_conds : d_scalar_bdry_node_conds), d_variable_bc_values[iv]); } if (d_dim == tbox::Dimension(2)) { appu::CartesianBoundaryUtilities2:: fillEdgeBoundaryData(d_variable_name[iv], cvdata, patch, fill_gcw, ((cvdata->getDepth() > 1) ? d_vector_bdry_edge_conds : d_scalar_bdry_edge_conds), d_variable_bc_values[iv]); appu::CartesianBoundaryUtilities2:: fillNodeBoundaryData(d_variable_name[iv], cvdata, patch, fill_gcw, ((cvdata->getDepth() > 1) ? d_vector_bdry_node_conds : d_scalar_bdry_node_conds), d_variable_bc_values[iv]); } } if (d_dim == tbox::Dimension(2)) { checkBoundaryData(Bdry::EDGE2D, patch, ghost_width_to_fill); checkBoundaryData(Bdry::NODE2D, patch, ghost_width_to_fill); } if (d_dim == tbox::Dimension(3)) { checkBoundaryData(Bdry::FACE3D, patch, ghost_width_to_fill); checkBoundaryData(Bdry::EDGE3D, patch, ghost_width_to_fill); checkBoundaryData(Bdry::NODE3D, patch, ghost_width_to_fill); } }
int SkeletonBoundaryUtilities2::checkBdryData( const string& varname, const hier::Patch& patch, int data_id, int depth, const hier::IntVector& gcw_to_check, const hier::BoundaryBox& bbox, int bcase, double bstate) { TBOX_ASSERT(!varname.empty()); TBOX_ASSERT(data_id >= 0); TBOX_ASSERT(depth >= 0); int num_bad_values = 0; int btype = bbox.getBoundaryType(); int bloc = bbox.getLocationIndex(); std::shared_ptr<hier::PatchGeometry> pgeom(patch.getPatchGeometry()); std::shared_ptr<pdat::CellData<double> > vardata( SAMRAI_SHARED_PTR_CAST<pdat::CellData<double>, hier::PatchData>( patch.getPatchData(data_id))); TBOX_ASSERT(vardata); string bdry_type_str; if (btype == Bdry::EDGE2D) { bdry_type_str = "EDGE"; } else if (btype == Bdry::NODE2D) { bdry_type_str = "NODE"; } else { TBOX_ERROR( "Unknown btype " << btype << " passed to SkeletonBoundaryUtilities2::checkBdryData()! " << endl); } tbox::plog << "\n\nCHECKING 2D " << bdry_type_str << " BDRY DATA..." << endl; tbox::plog << "varname = " << varname << " : depth = " << depth << endl; tbox::plog << "bbox = " << bbox.getBox() << endl; tbox::plog << "btype, bloc, bcase = " << btype << ", = " << bloc << ", = " << bcase << endl; tbox::Dimension::dir_t idir; double valfact = 0.0, constval = 0.0, dxfact = 0.0; int offsign; get2dBdryDirectionCheckValues(idir, offsign, btype, bloc, bcase); if (btype == Bdry::EDGE2D) { if (bcase == BdryCond::FLOW) { valfact = 1.0; constval = 0.0; dxfact = 0.0; } else if (bcase == BdryCond::REFLECT) { valfact = -1.0; constval = 0.0; dxfact = 0.0; } else if (bcase == BdryCond::DIRICHLET) { valfact = 0.0; constval = bstate; dxfact = 0.0; } else { TBOX_ERROR( "Unknown bcase " << bcase << " passed to SkeletonBoundaryUtilities2::checkBdryData()" << "\n for " << bdry_type_str << " at location " << bloc << endl); } } else if (btype == Bdry::NODE2D) { if (bcase == BdryCond::XFLOW || bcase == BdryCond::YFLOW) { valfact = 1.0; constval = 0.0; dxfact = 0.0; } else if (bcase == BdryCond::XREFLECT || bcase == BdryCond::YREFLECT) { valfact = -1.0; constval = 0.0; dxfact = 0.0; } else if (bcase == BdryCond::XDIRICHLET || bcase == BdryCond::YDIRICHLET) { valfact = 0.0; constval = bstate; dxfact = 0.0; } else { TBOX_ERROR( "Unknown bcase " << bcase << " passed to SkeletonBoundaryUtilities2::checkBdryData()" << "\n for " << bdry_type_str << " at location " << bloc << endl); } } hier::Box gbox_to_check( vardata->getGhostBox() * pgeom->getBoundaryFillBox(bbox, patch.getBox(), gcw_to_check)); hier::Box cbox(gbox_to_check); hier::Box dbox(gbox_to_check); hier::Index ifirst(vardata->getBox().lower()); hier::Index ilast(vardata->getBox().upper()); if (offsign == -1) { cbox.setLower(idir, ifirst(idir) - 1); cbox.setUpper(idir, ifirst(idir) - 1); dbox.setLower(idir, ifirst(idir)); dbox.setUpper(idir, ifirst(idir)); } else { cbox.setLower(idir, ilast(idir) + 1); cbox.setUpper(idir, ilast(idir) + 1); dbox.setLower(idir, ilast(idir)); dbox.setUpper(idir, ilast(idir)); } pdat::CellIterator id(pdat::CellGeometry::begin(dbox)); pdat::CellIterator icend(pdat::CellGeometry::end(cbox)); for (pdat::CellIterator ic(pdat::CellGeometry::begin(cbox)); ic != icend; ++ic) { double checkval = valfact * (*vardata)(*id, depth) + constval; pdat::CellIndex check = *ic; for (int p = 0; p < gbox_to_check.numberCells(idir); ++p) { double offcheckval = checkval + dxfact * (p + 1); if ((*vardata)(check, depth) != offcheckval) { ++num_bad_values; TBOX_WARNING("Bad " << bdry_type_str << " boundary value for " << varname << " found in cell " << check << "\n found = " << (*vardata)(check, depth) << " : correct = " << offcheckval << endl); } check(idir) += offsign; } ++id; } return num_bad_values; }
void SkeletonBoundaryUtilities2::fillNodeBoundaryData( const string& varname, std::shared_ptr<pdat::CellData<double> >& vardata, const hier::Patch& patch, const hier::IntVector& ghost_fill_width, const std::vector<int>& bdry_node_conds, const std::vector<double>& bdry_edge_values) { NULL_USE(varname); TBOX_ASSERT(vardata); TBOX_ASSERT(static_cast<int>(bdry_node_conds.size()) == NUM_2D_NODES); TBOX_ASSERT(static_cast<int>(bdry_edge_values.size()) == NUM_2D_EDGES * (vardata->getDepth())); if (!s_fortran_constants_stuffed) { stuff2dBdryFortConst(); } const std::shared_ptr<hier::PatchGeometry> pgeom( patch.getPatchGeometry()); const hier::Box& interior(patch.getBox()); const hier::Index& ifirst(interior.lower()); const hier::Index& ilast(interior.upper()); const hier::IntVector& ghost_cells = vardata->getGhostCellWidth(); hier::IntVector gcw_to_fill = hier::IntVector::min(ghost_cells, ghost_fill_width); const std::vector<hier::BoundaryBox>& node_bdry = pgeom->getCodimensionBoundaries(Bdry::NODE2D); for (int i = 0; i < static_cast<int>(node_bdry.size()); ++i) { TBOX_ASSERT(node_bdry[i].getBoundaryType() == Bdry::NODE2D); int bnode_loc = node_bdry[i].getLocationIndex(); hier::Box fill_box(pgeom->getBoundaryFillBox(node_bdry[i], interior, gcw_to_fill)); if (!fill_box.empty()) { const hier::Index& ibeg(fill_box.lower()); const hier::Index& iend(fill_box.upper()); SAMRAI_F77_FUNC(getskelnodebdry2d, GETSKELNODEBDRY2D) ( ifirst(0), ilast(0), ifirst(1), ilast(1), ibeg(0), iend(0), ibeg(1), iend(1), ghost_cells(0), ghost_cells(1), bnode_loc, bdry_node_conds[bnode_loc], &bdry_edge_values[0], vardata->getPointer(), vardata->getDepth()); } } }
void OuternodeDoubleInjection::coarsen( hier::Patch& coarse, const hier::Patch& fine, const int dst_component, const int src_component, const hier::Box& coarse_box, const hier::IntVector& ratio) const { const tbox::Dimension& dim(fine.getDim()); boost::shared_ptr<OuternodeData<double> > fdata( BOOST_CAST<OuternodeData<double>, hier::PatchData>( fine.getPatchData(src_component))); boost::shared_ptr<OuternodeData<double> > cdata( BOOST_CAST<OuternodeData<double>, hier::PatchData>( coarse.getPatchData(dst_component))); TBOX_ASSERT(fdata); TBOX_ASSERT(cdata); TBOX_ASSERT(cdata->getDepth() == fdata->getDepth()); TBOX_ASSERT_OBJDIM_EQUALITY4(coarse, fine, coarse_box, ratio); const hier::Index filo = fine.getBox().lower(); const hier::Index fihi = fine.getBox().upper(); const hier::Index cilo = coarse.getBox().lower(); const hier::Index cihi = coarse.getBox().upper(); const hier::Index ifirstc = coarse_box.lower(); const hier::Index ilastc = coarse_box.upper(); for (int i = 0; i < 2; ++i) { for (int axis = 0; axis < dim.getValue(); ++axis) { if (cdata->dataExists(axis)) { for (int d = 0; d < cdata->getDepth(); ++d) { if (dim == tbox::Dimension(1)) { SAMRAI_F77_FUNC(conavgouternodedoub1d, CONAVGOUTERNODEDOUB1D) (ifirstc(0), ilastc(0), filo(0), fihi(0), cilo(0), cihi(0), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } else if (dim == tbox::Dimension(2)) { if (axis == 0) { SAMRAI_F77_FUNC(conavgouternodedoub2d0, CONAVGOUTERNODEDOUB2D0) (ifirstc(0), ifirstc(1), ilastc(0), ilastc(1), filo(0), filo(1), fihi(0), fihi(1), cilo(0), cilo(1), cihi(0), cihi(1), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } if (axis == 1) { SAMRAI_F77_FUNC(conavgouternodedoub2d1, CONAVGOUTERNODEDOUB2D1) (ifirstc(0), ifirstc(1), ilastc(0), ilastc(1), filo(0), filo(1), fihi(0), fihi(1), cilo(0), cilo(1), cihi(0), cihi(1), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } } else if (dim == tbox::Dimension(3)) { if (axis == 0) { SAMRAI_F77_FUNC(conavgouternodedoub3d0, CONAVGOUTERNODEDOUB3D0) (ifirstc(0), ifirstc(1), ifirstc(2), ilastc(0), ilastc(1), ilastc(2), filo(0), filo(1), filo(2), fihi(0), fihi(1), fihi(2), cilo(0), cilo(1), cilo(2), cihi(0), cihi(1), cihi(2), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } if (axis == 1) { SAMRAI_F77_FUNC(conavgouternodedoub3d1, CONAVGOUTERNODEDOUB3D1) (ifirstc(0), ifirstc(1), ifirstc(2), ilastc(0), ilastc(1), ilastc(2), filo(0), filo(1), filo(2), fihi(0), fihi(1), fihi(2), cilo(0), cilo(1), cilo(2), cihi(0), cihi(1), cihi(2), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } if (axis == 2) { SAMRAI_F77_FUNC(conavgouternodedoub3d2, CONAVGOUTERNODEDOUB3D2) (ifirstc(0), ifirstc(1), ifirstc(2), ilastc(0), ilastc(1), ilastc(2), filo(0), filo(1), filo(2), fihi(0), fihi(1), fihi(2), cilo(0), cilo(1), cilo(2), cihi(0), cihi(1), cihi(2), &ratio[0], fdata->getPointer(axis, i, d), cdata->getPointer(axis, i, d)); } } } } } } }