*/
/**
- * Boundary indicator of this object.
+ * Return the boundary indicator of this object.
*
* If the return value is the special value
* numbers::internal_face_boundary_id, then this object is in the interior
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- types::boundary_id boundary_indicator () const;
+ types::boundary_id boundary_id () const;
/**
- * Set the boundary indicator. The same applies as for the
- * <tt>boundary_indicator()</tt> function.
+ * Return the boundary indicator of this object.
*
- * Note that it only sets the boundary object of the current object itself,
+ * @deprecated This spelling of the function name is deprecated. Use
+ * boundary_id() instead.
+ */
+ types::boundary_id boundary_indicator () const DEAL_II_DEPRECATED;
+
+ /**
+ * Set the boundary indicator of the current object. The same applies as for the
+ * boundary_id() function.
+ *
+ * This function only sets the boundary object of the current object itself,
* not the indicators of the ones that bound it. For example, in 3d, if this
* function is called on a face, then the boundary indicator of the 4 edges
* that bound the face remain unchanged. If you want to set the boundary
* indicators of face and edges at the same time, use the
- * set_all_boundary_indicators() function. You can see the result of not
+ * set_all_boundary_ids() function. You can see the result of not
* using the correct function in the results section of step-49.
*
* @warning You should never set the boundary indicator of an interior face
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- void set_boundary_indicator (const types::boundary_id) const;
+ void set_boundary_id (const types::boundary_id) const;
/**
- * Do as set_boundary_indicator() but also set the boundary indicators of
+ * Set the boundary indicator of this object.
+ *
+ * @deprecated This spelling of the function name is deprecated. Use
+ * set_boundary_id() instead.
+ */
+ void set_boundary_indicator (const types::boundary_id) const DEAL_II_DEPRECATED;
+
+ /**
+ * Do as set_boundary_id() but also set the boundary indicators of
* the objects that bound the current object. For example, in 3d, if
- * set_boundary_indicator() is called on a face, then the boundary indicator
+ * set_boundary_id() is called on a face, then the boundary indicator
* of the 4 edges that bound the face remain unchanged. In contrast, if you
* call the current function, the boundary indicators of face and edges are
* all set to the given value.
*
* This function is useful if you set boundary indicators of faces in 3d (in
- * 2d, the function does the same as set_boundary_indicator()) and you do so
+ * 2d, the function does the same as set_boundary_id()) and you do so
* because you want a curved boundary object to represent the part of the
* boundary that corresponds to the current face. In that case, the
* Triangulation class needs to figure out where to put new vertices upon
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- void set_all_boundary_indicators (const types::boundary_id) const;
+ void set_all_boundary_ids (const types::boundary_id) const;
+
+ /**
+ * Set the boundary indicator of this object and all that bound it.
+ *
+ * @deprecated This spelling of the function name is deprecated. Use
+ * set_all_boundary_ids() instead.
+ */
+ void set_all_boundary_indicators (const types::boundary_id) const DEAL_II_DEPRECATED;
/**
* Return whether this object is at the boundary. Obviously, the use of this
* @see
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
- types::boundary_id boundary_indicator () const;
+ types::boundary_id boundary_id () const;
+
+ /**
+ * Return the boundary indicator of this object.
+ *
+ * @deprecated This spelling of the function name is deprecated. Use
+ * boundary_id() instead.
+ */
+ types::boundary_id boundary_indicator () const DEAL_II_DEPRECATED;
/**
* Return the manifold indicator of this object.
/**
* Set the boundary indicator. The same applies as for the
- * <tt>boundary_indicator()</tt> function.
+ * <tt>boundary_id()</tt> function.
*
* @warning You should never set the boundary indicator of an interior face
* (a face not at the boundary of the domain), or set set the boundary
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
void
- set_boundary_indicator (const types::boundary_id);
+ set_boundary_id (const types::boundary_id);
+
+ /**
+ * Set the boundary indicator of this object.
+ *
+ * @deprecated This spelling of the function name is deprecated. Use
+ * set_boundary_id() instead.
+ */
+ void set_boundary_indicator (const types::boundary_id) DEAL_II_DEPRECATED;
/**
* Set the manifold indicator of this vertex. This does nothing so far since
* Set the boundary indicator of this object and all of its lower-
* dimensional sub-objects. Since this object only represents a single
* vertex, there are no lower-dimensional obejct and this function is
- * equivalent to calling set_boundary_indicator with the same argument.
+ * equivalent to calling set_boundary_id() with the same argument.
*
* @ingroup boundary
*
* @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
*/
void
- set_all_boundary_indicators (const types::boundary_id);
+ set_all_boundary_ids (const types::boundary_id);
+
+ /**
+ * Set the boundary indicator of this object and all that bound it.
+ *
+ * @deprecated This spelling of the function name is deprecated. Use
+ * set_all_boundary_ids() instead.
+ */
+ void set_all_boundary_indicators (const types::boundary_id) DEAL_II_DEPRECATED;
/**
* Set the manifold indicator of this object and all of its lower-
* dimensional sub-objects. Since this object only represents a single
* vertex, there are no lower-dimensional obejct and this function is
- * equivalent to calling set_manifold_indicator with the same argument.
+ * equivalent to calling set_manifold_id() with the same argument.
*
* @ingroup manifold
*
* @see
* @ref GlossManifoldIndicator "Glossary entry on manifold indicators"
*/
-
void
set_all_manifold_ids (const types::manifold_id);
/**
template <int structdim, int dim, int spacedim>
types::boundary_id
-TriaAccessor<structdim, dim, spacedim>::boundary_indicator () const
+TriaAccessor<structdim, dim, spacedim>::boundary_id () const
{
Assert (structdim<dim, ExcImpossibleInDim(dim));
Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
+template <int structdim, int dim, int spacedim>
+types::boundary_id
+TriaAccessor<structdim, dim, spacedim>::boundary_indicator () const
+{
+ return boundary_id();
+}
+
+
+
+
template <int structdim, int dim, int spacedim>
void
TriaAccessor<structdim, dim, spacedim>::
-set_boundary_indicator (const types::boundary_id boundary_ind) const
+set_boundary_id (const types::boundary_id boundary_ind) const
{
Assert (structdim<dim, ExcImpossibleInDim(dim));
Assert (this->used(), TriaAccessorExceptions::ExcCellNotUsed());
template <int structdim, int dim, int spacedim>
void
TriaAccessor<structdim, dim, spacedim>::
-set_all_boundary_indicators (const types::boundary_id boundary_ind) const
+set_boundary_indicator (const types::boundary_id boundary_ind) const
{
- set_boundary_indicator (boundary_ind);
+ set_boundary_id (boundary_ind);
+}
+
+
+
+template <int structdim, int dim, int spacedim>
+void
+TriaAccessor<structdim, dim, spacedim>::
+set_all_boundary_ids (const types::boundary_id boundary_ind) const
+{
+ set_boundary_id (boundary_ind);
switch (structdim)
{
// for boundary quads also set
// boundary_id of bounding lines
for (unsigned int i=0; i<4; ++i)
- this->line(i)->set_boundary_indicator (boundary_ind);
+ this->line(i)->set_boundary_id (boundary_ind);
break;
default:
+template <int structdim, int dim, int spacedim>
+void
+TriaAccessor<structdim, dim, spacedim>::
+set_all_boundary_indicators (const types::boundary_id boundary_ind) const
+{
+ set_all_boundary_ids (boundary_ind);
+}
+
+
+
template <int structdim, int dim, int spacedim>
bool
TriaAccessor<structdim, dim, spacedim>::at_boundary () const
{
// error checking is done
- // in boundary_indicator()
- return (boundary_indicator() != numbers::internal_face_boundary_id);
+ // in boundary_id()
+ return (boundary_id() != numbers::internal_face_boundary_id);
}
template <int spacedim>
inline
types::boundary_id
-TriaAccessor<0, 1, spacedim>::boundary_indicator () const
+TriaAccessor<0, 1, spacedim>::boundary_id () const
{
switch (vertex_kind)
{
default:
return numbers::internal_face_boundary_id;
}
+}
+
+
+template <int spacedim>
+inline
+types::boundary_id
+TriaAccessor<0, 1, spacedim>::boundary_indicator () const
+{
+ return boundary_id();
}
+
+
template <int spacedim>
inline
types::manifold_id
}
+
template <int spacedim>
inline
void
-TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id b)
+TriaAccessor<0, 1, spacedim>::set_boundary_id (const types::boundary_id b)
{
Assert (tria->vertex_to_boundary_id_map_1d->find (this->vertex_index())
!= tria->vertex_to_boundary_id_map_1d->end(),
}
+
+template <int spacedim>
+inline
+void
+TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id b)
+{
+ set_boundary_id (b);
+}
+
+
+
+
template <int spacedim>
inline
void
+template <int spacedim>
+inline
+void TriaAccessor<0, 1, spacedim>::set_all_boundary_ids (const types::boundary_id b)
+{
+ set_boundary_id (b);
+}
+
+
+
template <int spacedim>
inline
void TriaAccessor<0, 1, spacedim>::set_all_boundary_indicators (const types::boundary_id b)
{
- set_boundary_indicator (b);
+ set_all_boundary_ids (b);
}
// boundary indicator zero by
// default
if (n_adj_cells == 1)
- line->set_boundary_indicator (0);
+ line->set_boundary_id (0);
else
// interior line -> numbers::internal_face_boundary_id
- line->set_boundary_indicator (numbers::internal_face_boundary_id);
+ line->set_boundary_id (numbers::internal_face_boundary_id);
line->set_manifold_id(numbers::flat_manifold_id);
}
// assert that we only set
// boundary info once
- AssertThrow (! (line->boundary_indicator() != 0 &&
- line->boundary_indicator() != numbers::internal_face_boundary_id),
+ AssertThrow (! (line->boundary_id() != 0 &&
+ line->boundary_id() != numbers::internal_face_boundary_id),
ExcMultiplySetLineInfoOfLine(line_vertices.first,
line_vertices.second));
// Assert that only exterior lines
// are given a boundary indicator
- AssertThrow (! (line->boundary_indicator() == numbers::internal_face_boundary_id),
+ AssertThrow (! (line->boundary_id() == numbers::internal_face_boundary_id),
ExcInteriorLineCantBeBoundary(line->vertex_index(0),
line->vertex_index(1),
boundary_line->boundary_id));
- line->set_boundary_indicator (boundary_line->boundary_id);
+ line->set_boundary_id (boundary_line->boundary_id);
line->set_manifold_id (boundary_line->manifold_id);
}
// boundary indicator zero by
// default
if (n_adj_cells == 1)
- quad->set_boundary_indicator (0);
+ quad->set_boundary_id (0);
else
// interior quad -> numbers::internal_face_boundary_id
- quad->set_boundary_indicator (numbers::internal_face_boundary_id);
+ quad->set_boundary_id (numbers::internal_face_boundary_id);
// Manifold ids are set
// independently of where
// they are
for (typename Triangulation<dim,spacedim>::line_iterator
line=triangulation.begin_line(); line!=triangulation.end_line(); ++line)
{
- line->set_boundary_indicator (numbers::internal_face_boundary_id);
+ line->set_boundary_id (numbers::internal_face_boundary_id);
line->set_manifold_id(numbers::flat_manifold_id);
}
quad=triangulation.begin_quad(); quad!=triangulation.end_quad(); ++quad)
if (quad->at_boundary())
for (unsigned int l=0; l<4; ++l)
- quad->line(l)->set_boundary_indicator (0);
+ quad->line(l)->set_boundary_id (0);
///////////////////////////////////////
// now set boundary indicators
// boundary indicator to a
// different than the
// previously set value
- if (line->boundary_indicator() != 0)
- AssertThrow (line->boundary_indicator() == boundary_line->boundary_id,
+ if (line->boundary_id() != 0)
+ AssertThrow (line->boundary_id() == boundary_line->boundary_id,
ExcMessage ("Duplicate boundary lines are only allowed "
"if they carry the same boundary indicator."));
- line->set_boundary_indicator (boundary_line->boundary_id);
+ line->set_boundary_id (boundary_line->boundary_id);
// Set manifold id if given
line->set_manifold_id(boundary_line->manifold_id);
}
// boundary indicator to a
// different than the
// previously set value
- if (quad->boundary_indicator() != 0)
- AssertThrow (quad->boundary_indicator() == boundary_quad->boundary_id,
+ if (quad->boundary_id() != 0)
+ AssertThrow (quad->boundary_id() == boundary_quad->boundary_id,
ExcMessage ("Duplicate boundary quads are only allowed "
"if they carry the same boundary indicator."));
- quad->set_boundary_indicator (boundary_quad->boundary_id);
+ quad->set_boundary_id (boundary_quad->boundary_id);
quad->set_manifold_id (boundary_quad->manifold_id);
}
switch_1->line_orientation(2),
switch_1->line_orientation(3)
};
- const types::boundary_id switch_1_boundary_indicator=switch_1->boundary_indicator();
+ const types::boundary_id switch_1_boundary_id=switch_1->boundary_id();
const unsigned int switch_1_user_index=switch_1->user_index();
const bool switch_1_user_flag=switch_1->user_flag_set();
switch_1->set_line_orientation(1, switch_2->line_orientation(1));
switch_1->set_line_orientation(2, switch_2->line_orientation(2));
switch_1->set_line_orientation(3, switch_2->line_orientation(3));
- switch_1->set_boundary_indicator(switch_2->boundary_indicator());
+ switch_1->set_boundary_id(switch_2->boundary_id());
switch_1->set_manifold_id(switch_2->manifold_id());
switch_1->set_user_index(switch_2->user_index());
if (switch_2->user_flag_set())
switch_2->set_line_orientation(1, switch_1_line_orientations[1]);
switch_2->set_line_orientation(2, switch_1_line_orientations[2]);
switch_2->set_line_orientation(3, switch_1_line_orientations[3]);
- switch_2->set_boundary_indicator(switch_1_boundary_indicator);
+ switch_2->set_boundary_id(switch_1_boundary_id);
switch_2->set_manifold_id(switch_1->manifold_id());
switch_2->set_user_index(switch_1_user_index);
if (switch_1_user_flag)
new_lines[l]->clear_user_data();
new_lines[l]->clear_children();
// interior line
- new_lines[l]->set_boundary_indicator(numbers::internal_face_boundary_id);
+ new_lines[l]->set_boundary_id(numbers::internal_face_boundary_id);
new_lines[l]->set_manifold_id(cell->manifold_id());
}
line->set_user_flag ();
//TODO[WB]: we overwrite the user_index here because we later on need
// to find out which boundary object we have to ask to refine this
-// line. we can't use the boundary_indicator field because that can
+// line. we can't use the boundary_id field because that can
// only be used for lines at the boundary of the domain, but we also
// need a domain description for interior lines in the codim-1 case
if (spacedim > dim)
if (line->at_boundary())
// if possible honor boundary
// indicator
- line->set_user_index(line->boundary_indicator());
+ line->set_user_index(line->boundary_id());
else
// otherwise take manifold
// description from the adjacent
children[0]->clear_user_flag();
children[1]->clear_user_flag();
- children[0]->set_boundary_indicator (line->boundary_indicator());
- children[1]->set_boundary_indicator (line->boundary_indicator());
+ children[0]->set_boundary_id (line->boundary_id());
+ children[1]->set_boundary_id (line->boundary_id());
children[0]->set_manifold_id (line->manifold_id());
children[1]->set_manifold_id (line->manifold_id());
children[0]->clear_user_flag();
children[1]->clear_user_flag();
- children[0]->set_boundary_indicator (line->boundary_indicator());
- children[1]->set_boundary_indicator (line->boundary_indicator());
+ children[0]->set_boundary_id (line->boundary_id());
+ children[1]->set_boundary_id (line->boundary_id());
children[0]->set_manifold_id (line->manifold_id());
children[1]->set_manifold_id (line->manifold_id());
new_line->clear_user_flag();
new_line->clear_user_data();
new_line->clear_children();
- new_line->set_boundary_indicator(quad->boundary_indicator());
+ new_line->set_boundary_id(quad->boundary_id());
new_line->set_manifold_id(quad->manifold_id());
// child 0 and 1 of a line are switched if the
new_quads[i]->clear_user_flag();
new_quads[i]->clear_user_data();
new_quads[i]->clear_children();
- new_quads[i]->set_boundary_indicator (quad->boundary_indicator());
+ new_quads[i]->set_boundary_id (quad->boundary_id());
new_quads[i]->set_manifold_id (quad->manifold_id());
// set all line orientations to true, change
// this after the loop, as we have to consider
new_child[i]->set(internal::Triangulation::TriaObject<1>(old_child[i]->vertex_index(0),
old_child[i]->vertex_index(1)));
- new_child[i]->set_boundary_indicator(old_child[i]->boundary_indicator());
+ new_child[i]->set_boundary_id(old_child[i]->boundary_id());
new_child[i]->set_manifold_id(old_child[i]->manifold_id());
new_child[i]->set_user_index(old_child[i]->user_index());
if (old_child[i]->user_flag_set())
switch_1->line_orientation(2),
switch_1->line_orientation(3)
};
- const types::boundary_id switch_1_boundary_indicator=switch_1->boundary_indicator();
+ const types::boundary_id switch_1_boundary_id=switch_1->boundary_id();
const unsigned int switch_1_user_index=switch_1->user_index();
const bool switch_1_user_flag=switch_1->user_flag_set();
const RefinementCase<dim-1> switch_1_refinement_case=switch_1->refinement_case();
switch_1->set_line_orientation(1, switch_2->line_orientation(1));
switch_1->set_line_orientation(2, switch_2->line_orientation(2));
switch_1->set_line_orientation(3, switch_2->line_orientation(3));
- switch_1->set_boundary_indicator(switch_2->boundary_indicator());
+ switch_1->set_boundary_id(switch_2->boundary_id());
switch_1->set_manifold_id(switch_2->manifold_id());
switch_1->set_user_index(switch_2->user_index());
if (switch_2->user_flag_set())
switch_2->set_line_orientation(1, switch_1_line_orientations[1]);
switch_2->set_line_orientation(2, switch_1_line_orientations[2]);
switch_2->set_line_orientation(3, switch_1_line_orientations[3]);
- switch_2->set_boundary_indicator(switch_1_boundary_indicator);
+ switch_2->set_boundary_id(switch_1_boundary_id);
switch_2->set_manifold_id(switch_1->manifold_id());
switch_2->set_user_index(switch_1_user_index);
if (switch_1_user_flag)
children[0]->clear_user_flag();
children[1]->clear_user_flag();
- children[0]->set_boundary_indicator (middle_line->boundary_indicator());
- children[1]->set_boundary_indicator (middle_line->boundary_indicator());
+ children[0]->set_boundary_id (middle_line->boundary_id());
+ children[1]->set_boundary_id (middle_line->boundary_id());
children[0]->set_manifold_id (middle_line->manifold_id());
children[1]->set_manifold_id (middle_line->manifold_id());
new_lines[i]->clear_user_flag();
new_lines[i]->clear_user_data();
new_lines[i]->clear_children();
- new_lines[i]->set_boundary_indicator(quad->boundary_indicator());
+ new_lines[i]->set_boundary_id(quad->boundary_id());
new_lines[i]->set_manifold_id(quad->manifold_id());
}
new_quads[i]->clear_user_flag();
new_quads[i]->clear_user_data();
new_quads[i]->clear_children();
- new_quads[i]->set_boundary_indicator (quad->boundary_indicator());
+ new_quads[i]->set_boundary_id (quad->boundary_id());
new_quads[i]->set_manifold_id (quad->manifold_id());
// set all line orientations to true, change
// this after the loop, as we have to consider
new_lines[i]->clear_user_data();
new_lines[i]->clear_children();
// interior line
- new_lines[i]->set_boundary_indicator(numbers::internal_face_boundary_id);
+ new_lines[i]->set_boundary_id(numbers::internal_face_boundary_id);
// they inherit geometry description of the hex they belong to
new_lines[i]->set_manifold_id(hex->manifold_id());
}
new_quads[i]->clear_user_data();
new_quads[i]->clear_children();
// interior quad
- new_quads[i]->set_boundary_indicator (numbers::internal_face_boundary_id);
+ new_quads[i]->set_boundary_id (numbers::internal_face_boundary_id);
// they inherit geometry description of the hex they belong to
new_quads[i]->set_manifold_id (hex->manifold_id());
// set all line orientation flags to true by
template <int dim, int spacedim>
std::vector<types::boundary_id>
-Triangulation<dim, spacedim>::get_boundary_indicators () const
+Triangulation<dim, spacedim>::get_boundary_ids () const
{
// in 1d, we store a map of all used boundary indicators. use it for
// our purposes
if (dim == 1)
{
- std::vector<types::boundary_id> boundary_indicators;
+ std::vector<types::boundary_id> boundary_ids;
for (std::map<unsigned int, types::boundary_id>::const_iterator
p = vertex_to_boundary_id_map_1d->begin();
p != vertex_to_boundary_id_map_1d->end();
++p)
- boundary_indicators.push_back (p->second);
+ boundary_ids.push_back (p->second);
- return boundary_indicators;
+ return boundary_ids;
}
else
{
for (; cell!=end(); ++cell)
for (unsigned int face=0; face<GeometryInfo<dim>::faces_per_cell; ++face)
if (cell->at_boundary(face))
- b_ids.insert(cell->face(face)->boundary_indicator());
- std::vector<types::boundary_id> boundary_indicators(b_ids.begin(), b_ids.end());
- return boundary_indicators;
+ b_ids.insert(cell->face(face)->boundary_id());
+ std::vector<types::boundary_id> boundary_ids(b_ids.begin(), b_ids.end());
+ return boundary_ids;
}
}
+
+
+template <int dim, int spacedim>
+std::vector<types::boundary_id>
+Triangulation<dim, spacedim>::get_boundary_indicators () const
+{
+ return get_boundary_ids();
+}
+
+
+
template <int dim, int spacedim>
std::vector<types::manifold_id>
Triangulation<dim, spacedim>::get_manifold_ids () const