They had previously already been replaced by functions with name 'boundary_id', to
be consistent with the spelling for other attributes such as subdomain_id,
material_id, etc.
</p>
<ol>
+ <li> Removed: Functions with names containing <code>boundary_indicator</code>
+ have been removed. They had previously already been deprecated, and replaced
+ by functions containing the string <code>boundary_id</code> instead, to keep
+ with the style used for <code>material_id</code>, <code>subdomain_id</code>,
+ etc.
+ <br>
+ (Wolfgang Bangerth, 2016/02/28)
+ </li>
+
<li> Changed: Many functions in VectorTools and MatrixTools now require
matching data types between vectors, matrices, and Function arguments.
<br>
*/
std::vector<types::boundary_id> get_boundary_ids() const;
- /**
- * Deprecated spelling of get_boundary_ids().
- *
- * @deprecated Use get_boundary_ids() instead.
- */
- std::vector<types::boundary_id> get_boundary_indicators() const DEAL_II_DEPRECATED;
-
/**
* Returns a vector containing all manifold indicators assigned to the
* objects of this Triangulation. Note, that each manifold indicator is
*/
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;
-
/**
* Set the boundary indicator of the current object. The same applies as for
* the boundary_id() function.
*/
void set_boundary_id (const types::boundary_id) const;
- /**
- * 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
*/
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
* function is only possible for <tt>dim@>structdim</tt>; however, for
*/
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.
*
void
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
* manifolds are only used to refine and map objects, but vertices are not
void
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
-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>::
-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 (boundary_ind);
-}
-
-
-
template <int structdim, int dim, int spacedim>
void
TriaAccessor<structdim, dim, spacedim>::
-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
-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)
-{
- set_boundary_id (b);
-}
-
-
-
-
template <int spacedim>
inline
void
-template <int spacedim>
-inline
-void TriaAccessor<0, 1, spacedim>::set_all_boundary_indicators (const types::boundary_id b)
-{
- set_all_boundary_ids (b);
-}
-
-
-
template <int spacedim>
inline
void TriaAccessor<0, 1, spacedim>::set_all_manifold_ids (const types::manifold_id b)
for (unsigned int f=0; f<4; ++f)
if (cell->at_boundary(f)
&&
- (cell->face(f)->boundary_indicator() != 0))
+ (cell->face(f)->boundary_id() != 0))
{
quad.boundary_id = cell->face(f)->boundary_id();
max_boundary_id = std::max(max_boundary_id, quad.boundary_id);
-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
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
// set the boundary indicator for
// one face of the single cell
triangulation.set_boundary (1, boundary);
- triangulation.begin_active()->face(0)->set_boundary_indicator (1);
+ triangulation.begin_active()->face(0)->set_boundary_id (1);
const unsigned int n_points = 5;
{
if (cell->at_boundary(face))
deallog << "vertex " << cell->face_index(face)
- << " has boundary indicator " << (int)cell->face(face)->boundary_indicator()
+ << " has boundary indicator " << (int)cell->face(face)->boundary_id()
<< std::endl;
}
}
{
if (cell->at_boundary(face))
deallog << "vertex " << cell->face_index(face)
- << " has boundary indicator " << (int)cell->face(face)->boundary_indicator()
+ << " has boundary indicator " << (int)cell->face(face)->boundary_id()
<< std::endl;
}
}