From ebcabe424cc24c7eaa20ebc1d6517cd2777cd07b Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 20 Jan 2010 20:10:21 +0000 Subject: [PATCH] Rename bdry->boundary, ngbr->neighbor. git-svn-id: https://svn.dealii.org/trunk@20413 0785d39b-7218-0410-832d-ea1e28bc413d --- .../deal.II/include/numerics/mesh_worker.h | 22 ++++++++-------- .../include/numerics/mesh_worker_info.h | 20 +++++++------- .../include/numerics/mesh_worker_loop.h | 2 +- .../deal.II/source/numerics/mesh_worker.cc | 26 +++++++++---------- 4 files changed, 35 insertions(+), 35 deletions(-) diff --git a/deal.II/deal.II/include/numerics/mesh_worker.h b/deal.II/deal.II/include/numerics/mesh_worker.h index 8b9121cf6f..d7a482ba0a 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker.h +++ b/deal.II/deal.II/include/numerics/mesh_worker.h @@ -109,7 +109,7 @@ namespace MeshWorker /** * Do the work on a boundary face. */ - void bdry(DoFInfo& face); + void boundary(DoFInfo& face); /** * Do the work on an interior face. @@ -138,7 +138,7 @@ namespace MeshWorker * * First, you should consider if you need values from any vectors in a * NamedData object. If so, fill the VectorSelector objects - * #cell_selector, #bdry_selector and #face_selector with their names + * #cell_selector, #boundary_selector and #face_selector with their names * and the data type (value, gradient, Hessian) to be extracted. * * Afterwards, you will need to consider UpdateFlags for FEValues @@ -149,7 +149,7 @@ namespace MeshWorker * Finally, we need to choose quadrature formulas. If you choose to * use Gauss formulas only, use initialize_gauss_quadrature() with * appropriate values. Otherwise, you can fill the variables - * #cell_quadrature, #bdry_quadrature and #face_quadrature directly. + * #cell_quadrature, #boundary_quadrature and #face_quadrature directly. * * In order to save time, you can set the variables #boundary_fluxes * and #interior_fluxes of the base class to false, thus telling the @@ -185,7 +185,7 @@ namespace MeshWorker * Initialize the * VectorSelector objects * #cell_selector, - * #bdry_selector and + * #boundary_selector and * #face_selector in order to * save computational * eeffort. If no selectors @@ -205,8 +205,8 @@ namespace MeshWorker * Add additional values for update. */ void add_update_flags(const UpdateFlags flags, bool cell = true, - bool bdry = true, bool face = true, - bool ngbr = true); + bool boundary = true, bool face = true, + bool neighbor = true); /** Assign n-point Gauss * quadratures to each of the @@ -217,7 +217,7 @@ namespace MeshWorker * performed. */ void initialize_gauss_quadrature(unsigned int n_cell_points, - unsigned int n_bdry_points, + unsigned int n_boundary_points, unsigned int n_face_points); /** @@ -235,7 +235,7 @@ namespace MeshWorker * the quadrature points on * boundary faces. */ - MeshWorker::VectorSelector bdry_selector; + MeshWorker::VectorSelector boundary_selector; /** * Select the vectors from @@ -262,7 +262,7 @@ namespace MeshWorker * #update_JxW_values and * #update_normal_vectors. */ - UpdateFlags bdry_flags; + UpdateFlags boundary_flags; /** * The set of update flags @@ -283,7 +283,7 @@ namespace MeshWorker * quadrature weights are * taken from the other cell. */ - UpdateFlags ngbr_flags; + UpdateFlags neighbor_flags; /** * The quadrature rule used @@ -295,7 +295,7 @@ namespace MeshWorker * The quadrature rule used * on boundary faces. */ - Quadrature bdry_quadrature; + Quadrature boundary_quadrature; /** * The quadrature rule used diff --git a/deal.II/deal.II/include/numerics/mesh_worker_info.h b/deal.II/deal.II/include/numerics/mesh_worker_info.h index e6dc2a3c2c..4a432bf09f 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_info.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_info.h @@ -569,11 +569,11 @@ namespace MeshWorker // private: boost::shared_ptr > cell_data; - boost::shared_ptr > bdry_data; + boost::shared_ptr > boundary_data; boost::shared_ptr > face_data; CellInfo cell_info; - FaceInfo bdry_info; + FaceInfo boundary_info; FaceInfo face_info; FaceInfo subface_info; FaceInfo neighbor_info; @@ -841,7 +841,7 @@ namespace MeshWorker IntegrationInfoBox::IntegrationInfoBox(const T& t) : cell_info(t), - bdry_info(t), + boundary_info(t), face_info(t), subface_info(t), neighbor_info(t) @@ -858,21 +858,21 @@ namespace MeshWorker const Mapping& mapping) { assembler.initialize_info(cell_info, false); - assembler.initialize_info(bdry_info, false); + assembler.initialize_info(boundary_info, false); assembler.initialize_info(face_info, true); assembler.initialize_info(subface_info, true); assembler.initialize_info(neighbor_info, true); cell_info.initialize >(el, mapping, integrator.cell_quadrature, integrator.cell_flags); - bdry_info.initialize >(el, mapping, integrator.bdry_quadrature, - integrator.bdry_flags); + boundary_info.initialize >(el, mapping, integrator.boundary_quadrature, + integrator.boundary_flags); face_info.initialize >(el, mapping, integrator.face_quadrature, integrator.face_flags); subface_info.initialize >(el, mapping, integrator.face_quadrature, integrator.face_flags); neighbor_info.initialize >(el, mapping, integrator.face_quadrature, - integrator.ngbr_flags); + integrator.neighbor_flags); } @@ -893,10 +893,10 @@ namespace MeshWorker cell_data = p; cell_info.initialize_data(p); - p = boost::shared_ptr >(new VectorData (integrator.bdry_selector)); + p = boost::shared_ptr >(new VectorData (integrator.boundary_selector)); p->initialize(data); - bdry_data = p; - bdry_info.initialize_data(p); + boundary_data = p; + boundary_info.initialize_data(p); p = boost::shared_ptr >(new VectorData (integrator.face_selector)); p->initialize(data); diff --git a/deal.II/deal.II/include/numerics/mesh_worker_loop.h b/deal.II/deal.II/include/numerics/mesh_worker_loop.h index fda5bbb7ff..aa5d0ba93c 100644 --- a/deal.II/deal.II/include/numerics/mesh_worker_loop.h +++ b/deal.II/deal.II/include/numerics/mesh_worker_loop.h @@ -206,7 +206,7 @@ namespace MeshWorker { loop (begin, end, - box.cell_info, box.bdry_info, + box.cell_info, box.boundary_info, box.face_info, box.subface_info, box.neighbor_info, cell_worker, diff --git a/deal.II/deal.II/source/numerics/mesh_worker.cc b/deal.II/deal.II/source/numerics/mesh_worker.cc index 1ccad5b062..ca94d3d38a 100644 --- a/deal.II/deal.II/source/numerics/mesh_worker.cc +++ b/deal.II/deal.II/source/numerics/mesh_worker.cc @@ -23,9 +23,9 @@ template IntegrationWorker::IntegrationWorker () { cell_flags = update_JxW_values; - bdry_flags = UpdateFlags(update_JxW_values | update_normal_vectors); - face_flags = bdry_flags; - ngbr_flags = update_default; + boundary_flags = UpdateFlags(update_JxW_values | update_normal_vectors); + face_flags = boundary_flags; + neighbor_flags = update_default; } @@ -37,29 +37,29 @@ IntegrationWorker::initialize_update_flags () if (cell_selector.has_gradients() != 0) cell_flags |= update_gradients; if (cell_selector.has_hessians() != 0) cell_flags |= update_hessians; - if (bdry_selector.has_values() != 0) bdry_flags |= update_values; - if (bdry_selector.has_gradients() != 0) bdry_flags |= update_gradients; - if (bdry_selector.has_hessians() != 0) bdry_flags |= update_hessians; + if (boundary_selector.has_values() != 0) boundary_flags |= update_values; + if (boundary_selector.has_gradients() != 0) boundary_flags |= update_gradients; + if (boundary_selector.has_hessians() != 0) boundary_flags |= update_hessians; if (face_selector.has_values() != 0) face_flags |= update_values; if (face_selector.has_gradients() != 0) face_flags |= update_gradients; if (face_selector.has_hessians() != 0) face_flags |= update_hessians; - if (face_selector.has_values() != 0) ngbr_flags |= update_values; - if (face_selector.has_gradients() != 0) ngbr_flags |= update_gradients; - if (face_selector.has_hessians() != 0) ngbr_flags |= update_hessians; + if (face_selector.has_values() != 0) neighbor_flags |= update_values; + if (face_selector.has_gradients() != 0) neighbor_flags |= update_gradients; + if (face_selector.has_hessians() != 0) neighbor_flags |= update_hessians; } template void IntegrationWorker::add_update_flags( - const UpdateFlags flags, bool cell, bool bdry, bool face, bool ngbr) + const UpdateFlags flags, bool cell, bool boundary, bool face, bool neighbor) { if (cell) cell_flags |= flags; - if (bdry) bdry_flags |= flags; + if (boundary) boundary_flags |= flags; if (face) face_flags |= flags; - if (ngbr) ngbr_flags |= flags; + if (neighbor) neighbor_flags |= flags; } @@ -71,7 +71,7 @@ IntegrationWorker::initialize_gauss_quadrature( unsigned int fp) { cell_quadrature = QGauss(cp); - bdry_quadrature = QGauss(bp); + boundary_quadrature = QGauss(bp); face_quadrature = QGauss(fp); } -- 2.39.5