From: Wolfgang Bangerth
Date: Sun, 28 Feb 2016 21:43:08 +0000 (-0600)
Subject: Remove deprecated functions with names like 'boundary_indicator'.
X-Git-Tag: v8.5.0-rc1~1270^2~1
X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=6db8ba519d9aee8d27eafca7c00c56149800d043;p=dealii.git
Remove deprecated functions with names like 'boundary_indicator'.
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.
---
diff --git a/doc/news/changes.h b/doc/news/changes.h
index 3eccabe9b8..8795b50399 100644
--- a/doc/news/changes.h
+++ b/doc/news/changes.h
@@ -38,6 +38,15 @@ inconvenience this causes.
+ - Removed: Functions with names containing
boundary_indicator
+ have been removed. They had previously already been deprecated, and replaced
+ by functions containing the string boundary_id
instead, to keep
+ with the style used for material_id
, subdomain_id
,
+ etc.
+
+ (Wolfgang Bangerth, 2016/02/28)
+
+
- Changed: Many functions in VectorTools and MatrixTools now require
matching data types between vectors, matrices, and Function arguments.
diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h
index cbb1f1d307..e0405a4934 100644
--- a/include/deal.II/grid/tria.h
+++ b/include/deal.II/grid/tria.h
@@ -1696,13 +1696,6 @@ public:
*/
std::vector get_boundary_ids() const;
- /**
- * Deprecated spelling of get_boundary_ids().
- *
- * @deprecated Use get_boundary_ids() instead.
- */
- std::vector 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
diff --git a/include/deal.II/grid/tria_accessor.h b/include/deal.II/grid/tria_accessor.h
index 3800008757..c9b4354833 100644
--- a/include/deal.II/grid/tria_accessor.h
+++ b/include/deal.II/grid/tria_accessor.h
@@ -884,14 +884,6 @@ public:
*/
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.
@@ -923,14 +915,6 @@ public:
*/
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
@@ -963,14 +947,6 @@ public:
*/
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 dim@>structdim; however, for
@@ -2064,14 +2040,6 @@ public:
*/
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.
*
@@ -2207,14 +2175,6 @@ public:
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
@@ -2238,14 +2198,6 @@ public:
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
diff --git a/include/deal.II/grid/tria_accessor.templates.h b/include/deal.II/grid/tria_accessor.templates.h
index 031e86d770..2c3de29894 100644
--- a/include/deal.II/grid/tria_accessor.templates.h
+++ b/include/deal.II/grid/tria_accessor.templates.h
@@ -1854,16 +1854,6 @@ TriaAccessor::boundary_id () const
-template
-types::boundary_id
-TriaAccessor::boundary_indicator () const
-{
- return boundary_id();
-}
-
-
-
-
template
void
TriaAccessor::
@@ -1877,16 +1867,6 @@ set_boundary_id (const types::boundary_id boundary_ind) const
-template
-void
-TriaAccessor::
-set_boundary_indicator (const types::boundary_id boundary_ind) const
-{
- set_boundary_id (boundary_ind);
-}
-
-
-
template
void
TriaAccessor::
@@ -1915,16 +1895,6 @@ set_all_boundary_ids (const types::boundary_id boundary_ind) const
-template
-void
-TriaAccessor::
-set_all_boundary_indicators (const types::boundary_id boundary_ind) const
-{
- set_all_boundary_ids (boundary_ind);
-}
-
-
-
template
bool
TriaAccessor::at_boundary () const
@@ -2772,16 +2742,6 @@ TriaAccessor<0, 1, spacedim>::boundary_id () const
-template
-inline
-types::boundary_id
-TriaAccessor<0, 1, spacedim>::boundary_indicator () const
-{
- return boundary_id();
-}
-
-
-
template
inline
types::manifold_id
@@ -2922,17 +2882,6 @@ TriaAccessor<0, 1, spacedim>::set_boundary_id (const types::boundary_id b)
-template
-inline
-void
-TriaAccessor<0, 1, spacedim>::set_boundary_indicator (const types::boundary_id b)
-{
- set_boundary_id (b);
-}
-
-
-
-
template
inline
void
@@ -2952,15 +2901,6 @@ void TriaAccessor<0, 1, spacedim>::set_all_boundary_ids (const types::boundary_i
-template
-inline
-void TriaAccessor<0, 1, spacedim>::set_all_boundary_indicators (const types::boundary_id b)
-{
- set_all_boundary_ids (b);
-}
-
-
-
template
inline
void TriaAccessor<0, 1, spacedim>::set_all_manifold_ids (const types::manifold_id b)
diff --git a/source/grid/grid_generator.cc b/source/grid/grid_generator.cc
index 92225b8e13..6ad89aa450 100644
--- a/source/grid/grid_generator.cc
+++ b/source/grid/grid_generator.cc
@@ -3781,7 +3781,7 @@ namespace GridGenerator
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);
diff --git a/source/grid/tria.cc b/source/grid/tria.cc
index 3147a4d5c1..5e37a357c4 100644
--- a/source/grid/tria.cc
+++ b/source/grid/tria.cc
@@ -9007,15 +9007,6 @@ Triangulation::get_boundary_ids () const
-template
-std::vector
-Triangulation::get_boundary_indicators () const
-{
- return get_boundary_ids();
-}
-
-
-
template
std::vector
Triangulation::get_manifold_ids () const
diff --git a/tests/fe/mapping_fe_field_real_to_unit_b2_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_b2_curved.cc
index 8b920c584e..0b4d246c2c 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_b2_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_b2_curved.cc
@@ -59,7 +59,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_b2_mask.cc b/tests/fe/mapping_fe_field_real_to_unit_b2_mask.cc
index 4649e4b374..74169e9aa2 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_b2_mask.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_b2_mask.cc
@@ -55,7 +55,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_b3_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_b3_curved.cc
index 6700f4ceee..68a263a4d8 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_b3_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_b3_curved.cc
@@ -59,7 +59,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_b4_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_b4_curved.cc
index f4c6527741..a6bc935770 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_b4_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_b4_curved.cc
@@ -59,7 +59,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_b5_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_b5_curved.cc
index ac329ad1cd..7de7f49b8a 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_b5_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_b5_curved.cc
@@ -59,7 +59,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_q2_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_q2_curved.cc
index a09c2f7451..b5ac41ddbd 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_q2_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_q2_curved.cc
@@ -61,7 +61,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_q3_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_q3_curved.cc
index 569911d472..bae9d4d3eb 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_q3_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_q3_curved.cc
@@ -61,7 +61,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/fe/mapping_fe_field_real_to_unit_q4_curved.cc b/tests/fe/mapping_fe_field_real_to_unit_q4_curved.cc
index 35a69505c9..bb334119cf 100644
--- a/tests/fe/mapping_fe_field_real_to_unit_q4_curved.cc
+++ b/tests/fe/mapping_fe_field_real_to_unit_q4_curved.cc
@@ -58,7 +58,7 @@ void test_real_to_unit_cell()
// 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;
diff --git a/tests/grid/grid_in_msh_02.cc b/tests/grid/grid_in_msh_02.cc
index cb5e575c85..17884b955c 100644
--- a/tests/grid/grid_in_msh_02.cc
+++ b/tests/grid/grid_in_msh_02.cc
@@ -53,7 +53,7 @@ void check_file ()
{
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;
}
}
diff --git a/tests/grid/grid_in_msh_02_13.cc b/tests/grid/grid_in_msh_02_13.cc
index 5669a990e2..5461fe8d8e 100644
--- a/tests/grid/grid_in_msh_02_13.cc
+++ b/tests/grid/grid_in_msh_02_13.cc
@@ -57,7 +57,7 @@ void check_file ()
{
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;
}
}