]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Change all occurrences of CellAccessor::active() to CellAccessor::is_active(). 9352/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 16 Jan 2020 19:04:47 +0000 (12:04 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 16 Jan 2020 19:04:47 +0000 (12:04 -0700)
60 files changed:
examples/step-9/step-9.cc
include/deal.II/distributed/cell_data_transfer.templates.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/matrix_free/cuda_hanging_nodes_internal.h
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/meshworker/loop.h
include/deal.II/meshworker/mesh_loop.h
include/deal.II/numerics/cell_data_transfer.templates.h
include/deal.II/numerics/vector_tools.templates.h
source/distributed/cell_weights.cc
source/distributed/fully_distributed_tria.cc
source/distributed/fully_distributed_tria_util.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/dofs/dof_tools_sparsity.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/hp/dof_handler.cc
source/hp/refinement.cc
source/numerics/data_out.cc
source/numerics/data_out_faces.cc
source/numerics/data_out_rotation.cc
source/numerics/solution_transfer.cc
source/numerics/time_dependent.cc
tests/aniso/up_and_down.cc
tests/fail/rt_6.cc
tests/fe/up_and_down.cc
tests/grid/intergrid_constraints.cc
tests/grid/intergrid_map.cc
tests/grid/mesh_smoothing_02.cc
tests/hp/p_adaptivity_absolute_threshold.cc
tests/hp/p_adaptivity_fixed_number.cc
tests/hp/p_adaptivity_flags.cc
tests/hp/p_adaptivity_full.cc
tests/hp/p_adaptivity_reference.cc
tests/hp/p_adaptivity_regularity.cc
tests/hp/p_adaptivity_relative_threshold.cc
tests/mpi/distribute_flux_sparsity_pattern.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/step-40_cuthill_mckee.cc
tests/mpi/step-40_cuthill_mckee_MPI-subset.cc
tests/serialization/dof_handler_01.cc
tests/serialization/hp_dof_handler_01.cc
tests/serialization/triangulation_01.cc
tests/serialization/triangulation_02.cc
tests/sharedtria/tria_custom_refine02.cc
tests/trilinos/elide_zeros.cc

index 8832e46f0f59dcf920caefef705622636083ab27..0bc4b4810c65cc4f40889f265f95a3a87f20a72b 100644 (file)
@@ -1055,7 +1055,7 @@ namespace Step9
           // Then check whether the neighbor is active. If it is, then it
           // is on the same level or one level coarser (if we are not in
           // 1D), and we are interested in it in any case.
-          if (neighbor->active())
+          if (neighbor->is_active())
             scratch_data.active_neighbors.push_back(neighbor);
           else
             {
index a05a1d64d46116945f738e42cac9e44d1176da26..05e25e2234880ea46f24a9e7433cd3d5ef0de903 100644 (file)
@@ -314,7 +314,7 @@ namespace parallel
                        ++child_index)
                     {
                       const auto child = cell->child(child_index);
-                      Assert(child->active() && child->coarsen_flag_set(),
+                      Assert(child->is_active() && child->coarsen_flag_set(),
                              typename dealii::Triangulation<
                                dim>::ExcInconsistentCoarseningFlags());
 
index aa9abaf2624125cef495325c437e490fee4d954f..e6872d77a53a0719315d4e5bc934f5a080c04819 100644 (file)
@@ -3810,7 +3810,7 @@ inline void
 DoFCellAccessor<DoFHandlerType, level_dof_access>::get_dof_indices(
   std::vector<types::global_dof_index> &dof_indices) const
 {
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("get_dof_indices() only works on active cells."));
   Assert(this->is_artificial() == false,
          ExcMessage("Can't ask for DoF indices on artificial cells."));
index c7d63741cd950f01078c996820606033c34204c8..cf7a52468be02b50a8d424bf2815d0da1acd39b4 100644 (file)
@@ -534,7 +534,7 @@ namespace FETools
           // check if at least one child is locally owned on our process
           for (unsigned int child_n = 0; child_n < dealii_cell->n_children();
                ++child_n)
-            if (dealii_cell->child(child_n)->active())
+            if (dealii_cell->child(child_n)->is_active())
               if (dealii_cell->child(child_n)->is_locally_owned())
                 {
                   locally_owned_children = true;
@@ -880,7 +880,7 @@ namespace FETools
 
           for (unsigned int child_n = 0; child_n < dealii_cell->n_children();
                ++child_n)
-            if (dealii_cell->child(child_n)->active())
+            if (dealii_cell->child(child_n)->is_active())
               if (dealii_cell->child(child_n)->is_locally_owned())
                 {
                   locally_owned_children = true;
@@ -1730,7 +1730,7 @@ namespace FETools
                                                               dof2.end(level);
 
           for (; cell != endc; ++cell)
-            if (!cell->active())
+            if (!cell->is_active())
               {
                 // check whether this
                 // cell has active
@@ -1738,7 +1738,7 @@ namespace FETools
                 bool active_children = false;
                 for (unsigned int child_n = 0; child_n < cell->n_children();
                      ++child_n)
-                  if (cell->child(child_n)->active())
+                  if (cell->child(child_n)->is_active())
                     {
                       active_children = true;
                       break;
index 654bfa0ec5b07fa916e6c4ac8dcbf43aacc24366..f076dbc8bc9dbe463108745008b0fb660798c45f 100644 (file)
@@ -402,7 +402,7 @@ namespace IteratorFilters
  *     template <class Iterator>
  *     bool operator () (const Iterator &i) const
  *     {
- *       return (i->active());
+ *       return (i->is_active());
  *     }
  *   };
  * @endcode
@@ -1164,7 +1164,7 @@ namespace IteratorFilters
   inline bool
   Active::operator()(const Iterator &i) const
   {
-    return (i->active());
+    return (i->is_active());
   }
 
 
index 7c225bdbbb148795b9940ad24905553f25cc0e05..5820941335d5f7c563b4a3e9427cbde79217dddf 100644 (file)
@@ -3259,7 +3259,7 @@ namespace GridTools
               // children bound to the present cell
               typename MeshType::cell_iterator neighbor_child =
                 cell->neighbor(n);
-              if (!neighbor_child->active())
+              if (!neighbor_child->is_active())
                 {
                   while (neighbor_child->has_children())
                     neighbor_child = neighbor_child->child(n == 0 ? 1 : 0);
@@ -3284,7 +3284,7 @@ namespace GridTools
                 {
                   // the neighbor must be active
                   // himself
-                  Assert(cell->neighbor(n)->active(), ExcInternalError());
+                  Assert(cell->neighbor(n)->is_active(), ExcInternalError());
                   active_neighbors.push_back(cell->neighbor(n));
                 }
             }
index 65f9afe04ec8257f0b936e524c6eec0ed55806e5..a9fd16453402f3f615c7f6ddb5d96fa4b55635fc 100644 (file)
@@ -3299,8 +3299,8 @@ CellAccessor<dim, spacedim>::refine_flag_set() const
   // but activity may change when refinement is
   // executed and for some reason the refine
   // flag is not cleared).
-  Assert(this->active() || !this->tria->levels[this->present_level]
-                              ->refine_flags[this->present_index],
+  Assert(this->is_active() || !this->tria->levels[this->present_level]
+                                 ->refine_flags[this->present_index],
          ExcRefineCellNotActive());
   return RefinementCase<dim>(
     this->tria->levels[this->present_level]->refine_flags[this->present_index]);
@@ -3313,7 +3313,7 @@ inline void
 CellAccessor<dim, spacedim>::set_refine_flag(
   const RefinementCase<dim> refinement_case) const
 {
-  Assert(this->used() && this->active(), ExcRefineCellNotActive());
+  Assert(this->used() && this->is_active(), ExcRefineCellNotActive());
   Assert(!coarsen_flag_set(), ExcCellFlaggedForCoarsening());
 
   this->tria->levels[this->present_level]->refine_flags[this->present_index] =
@@ -3326,7 +3326,7 @@ template <int dim, int spacedim>
 inline void
 CellAccessor<dim, spacedim>::clear_refine_flag() const
 {
-  Assert(this->used() && this->active(), ExcRefineCellNotActive());
+  Assert(this->used() && this->is_active(), ExcRefineCellNotActive());
   this->tria->levels[this->present_level]->refine_flags[this->present_index] =
     RefinementCase<dim>::no_refinement;
 }
@@ -3523,8 +3523,8 @@ CellAccessor<dim, spacedim>::coarsen_flag_set() const
   // but activity may change when refinement is
   // executed and for some reason the refine
   // flag is not cleared).
-  Assert(this->active() || !this->tria->levels[this->present_level]
-                              ->coarsen_flags[this->present_index],
+  Assert(this->is_active() || !this->tria->levels[this->present_level]
+                                 ->coarsen_flags[this->present_index],
          ExcRefineCellNotActive());
   return this->tria->levels[this->present_level]
     ->coarsen_flags[this->present_index];
@@ -3536,7 +3536,7 @@ template <int dim, int spacedim>
 inline void
 CellAccessor<dim, spacedim>::set_coarsen_flag() const
 {
-  Assert(this->used() && this->active(), ExcRefineCellNotActive());
+  Assert(this->used() && this->is_active(), ExcRefineCellNotActive());
   Assert(!refine_flag_set(), ExcCellFlaggedForRefinement());
 
   this->tria->levels[this->present_level]->coarsen_flags[this->present_index] =
@@ -3549,7 +3549,7 @@ template <int dim, int spacedim>
 inline void
 CellAccessor<dim, spacedim>::clear_coarsen_flag() const
 {
-  Assert(this->used() && this->active(), ExcRefineCellNotActive());
+  Assert(this->used() && this->is_active(), ExcRefineCellNotActive());
   this->tria->levels[this->present_level]->coarsen_flags[this->present_index] =
     false;
 }
@@ -3594,7 +3594,7 @@ template <int dim, int spacedim>
 inline bool
 CellAccessor<dim, spacedim>::is_locally_owned() const
 {
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("is_locally_owned() can only be called on active cells!"));
 #ifndef DEAL_II_WITH_MPI
   return true;
@@ -3636,7 +3636,7 @@ template <int dim, int spacedim>
 inline bool
 CellAccessor<dim, spacedim>::is_ghost() const
 {
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("is_ghost() can only be called on active cells!"));
   if (this->has_children())
     return false;
@@ -3664,7 +3664,7 @@ template <int dim, int spacedim>
 inline bool
 CellAccessor<dim, spacedim>::is_artificial() const
 {
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("is_artificial() can only be called on active cells!"));
 #ifndef DEAL_II_WITH_MPI
   return false;
@@ -3687,7 +3687,7 @@ inline types::subdomain_id
 CellAccessor<dim, spacedim>::subdomain_id() const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("subdomain_id() can only be called on active cells!"));
   return this->tria->levels[this->present_level]
     ->subdomain_ids[this->present_index];
index bb410b1d5fa359e170752e6dc599406c25663872..7cc5d2c31c9502ad84a99912c0cbedcb3c99153c 100644 (file)
@@ -225,7 +225,7 @@ namespace CUDAWrappers
                ++line)
             {
               const unsigned int line_idx = cell->line(line)->index();
-              if (cell->active())
+              if (cell->is_active())
                 line_to_cells[line_idx].push_back(std::make_pair(cell, line));
               else
                 line_to_inactive_cells[line_idx].push_back(
index 768f48695a6a292f20ee47b5fb6dfac4d4d2b26b..6147c731f58ca31c153c26cc7786316c61e398ff 100644 (file)
@@ -182,7 +182,7 @@ namespace internal
           {
             typename dealii::Triangulation<dim>::cell_iterator dcell(
               &triangulation, cell_level.first, cell_level.second);
-            Assert(dcell->active(), ExcInternalError());
+            Assert(dcell->is_active(), ExcInternalError());
           }
 #  endif
 
@@ -578,7 +578,7 @@ namespace internal
           typename dealii::Triangulation<dim>::cell_iterator dcell(
             &triangulation, cell_levels[i].first, cell_levels[i].second);
           if (use_active_cells)
-            Assert(dcell->active(), ExcNotImplemented());
+            Assert(dcell->is_active(), ExcNotImplemented());
           for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
             {
               if (dcell->at_boundary(f) && !dcell->has_periodic_neighbor(f))
index 9d8d56822906c0501c2fb84acb7ac4422f747adb..b31ed2dcb008a996add2b7f82c7ba5ecd2ab1b13 100644 (file)
@@ -2049,7 +2049,7 @@ namespace internal
                   fe_val.reinit(cell_it, face);
 
                   const bool is_local =
-                    (cell_it->active() ?
+                    (cell_it->is_active() ?
                        cell_it->is_locally_owned() :
                        cell_it->is_locally_owned_on_level()) &&
                     (!cell_it->at_boundary(face) ||
index b52d71be148d10a21f691b13b5b34473a7906fdc..dcfa56aa04a97d14d2bac519a975490b5e62f1e6 100644 (file)
@@ -697,7 +697,7 @@ namespace internal
       else if (subdomain_id == numbers::invalid_subdomain_id ||
                cell->subdomain_id() == subdomain_id)
         {
-          Assert(cell->active(), ExcInternalError());
+          Assert(cell->is_active(), ExcInternalError());
           cell_its.emplace_back(cell->level(), cell->index());
         }
     }
index bf07441355583c51af1d6cc6794aa151f5b39b2c..beded44f6c3073f4877c281af55d1c3cbd8d4d57 100644 (file)
@@ -275,7 +275,7 @@ namespace MeshWorker
               if (neighbor->is_level_cell())
                 neighbid = neighbor->level_subdomain_id();
               // subdomain id is only valid for active cells
-              else if (neighbor->active())
+              else if (neighbor->is_active())
                 neighbid = neighbor->subdomain_id();
 
               const bool own_neighbor =
index d301f6f665a3b5c39d17bae2fd6225770566d9ec..35119a28848a10488b9f3157172607a03ccacd71 100644 (file)
@@ -316,7 +316,7 @@ namespace MeshWorker
                 if (neighbor->is_level_cell())
                   neighbor_subdomain_id = neighbor->level_subdomain_id();
                 // subdomain id is only valid for active cells
-                else if (neighbor->active())
+                else if (neighbor->is_active())
                   neighbor_subdomain_id = neighbor->subdomain_id();
 
                 const bool own_neighbor =
index 6ed30befec6fa76cc055fce644380d60d1c43040..f8d5dca075331f1d0b2a2274da1458c8e9c16266 100644 (file)
@@ -105,7 +105,7 @@ CellDataTransfer<dim, spacedim, VectorType>::
                    ++child_index)
                 {
                   const auto sibling = parent->child(child_index);
-                  Assert(sibling->active() && sibling->coarsen_flag_set(),
+                  Assert(sibling->is_active() && sibling->coarsen_flag_set(),
                          typename dealii::Triangulation<
                            dim>::ExcInconsistentCoarseningFlags());
 
@@ -150,7 +150,7 @@ CellDataTransfer<dim, spacedim, VectorType>::unpack(const VectorType &in,
   // Transfer data of persisting cells.
   for (const auto &persisting : persisting_cells_active_index)
     {
-      Assert(persisting.first->active(), ExcInternalError());
+      Assert(persisting.first->is_active(), ExcInternalError());
       out[persisting.first->active_cell_index()] = in[persisting.second];
     }
 
@@ -162,7 +162,7 @@ CellDataTransfer<dim, spacedim, VectorType>::unpack(const VectorType &in,
          ++child_index)
       {
         const auto child = refined.first->child(child_index);
-        Assert(child->active(), ExcInternalError());
+        Assert(child->is_active(), ExcInternalError());
         out[child->active_cell_index()] = in[refined.second];
       }
 
@@ -184,7 +184,7 @@ CellDataTransfer<dim, spacedim, VectorType>::unpack(const VectorType &in,
       const value_type parent_value = coarsening_strategy(children_values);
 
       // Set value for the parent cell.
-      Assert(coarsened.first->active(), ExcInternalError());
+      Assert(coarsened.first->is_active(), ExcInternalError());
       out[coarsened.first->active_cell_index()] = parent_value;
     }
 
index cd8821d924846dc8a48871815e8c1b1b1f08935f..3a97314fa86762aa6607a7fc15ba2fc524d53e2d 100644 (file)
@@ -821,7 +821,7 @@ namespace VectorTools
     bool
     is_locally_owned(const cell_iterator &cell)
     {
-      if (cell->active())
+      if (cell->is_active())
         return cell->is_locally_owned();
 
       for (unsigned int c = 0; c < cell->n_children(); ++c)
@@ -881,7 +881,7 @@ namespace VectorTools
         if (cell1->level() != cell2->level())
           continue;
         // .. or none of them is active.
-        if (!cell1->active() && !cell2->active())
+        if (!cell1->is_active() && !cell2->is_active())
           continue;
 
         Assert(
@@ -891,14 +891,14 @@ namespace VectorTools
             "The two Triangulations are required to have the same parallel partitioning."));
 
         // Skip foreign cells.
-        if (cell1->active() && !cell1->is_locally_owned())
+        if (cell1->is_active() && !cell1->is_locally_owned())
           continue;
-        if (cell2->active() && !cell2->is_locally_owned())
+        if (cell2->is_active() && !cell2->is_locally_owned())
           continue;
 
         // Get and set the corresponding
         // dof_values by interpolation.
-        if (cell1->active())
+        if (cell1->is_active())
           {
             cache.reinit(cell1->get_fe().dofs_per_cell);
             cell1->get_interpolated_dof_values(u1,
index 2eb34fcaec9f1ab82fd87903903ad77a4c7bcdff..9f78643207ed028660c74d85b90fc6fd18133b1d 100644 (file)
@@ -193,7 +193,7 @@ namespace parallel
                  ++child_index)
               {
                 const auto child = cell->child(child_index);
-                Assert(child->active() && child->coarsen_flag_set(),
+                Assert(child->is_active() && child->coarsen_flag_set(),
                        typename dealii::Triangulation<
                          dim>::ExcInconsistentCoarseningFlags());
 
index 726c4cf8c9619a509edbb44d930d6843a38151cb..a86f588f1a58df039b5f4071566e5799d51a275a 100644 (file)
@@ -223,7 +223,7 @@ namespace parallel
           //     (level_)subdomain_ids in the next step)
           for (auto cell = this->begin(); cell != this->end(); ++cell)
             {
-              if (cell->active())
+              if (cell->is_active())
                 cell->set_subdomain_id(
                   dealii::numbers::artificial_subdomain_id);
 
@@ -243,7 +243,7 @@ namespace parallel
                     ++cell;
 
                   // subdomain id
-                  if (cell->active())
+                  if (cell->is_active())
                     cell->set_subdomain_id(cell_info->subdomain_id);
 
                   // level subdomain id
index 8671453c29ff52d01e5f0281fa6587149bf0f418..675cc73ae2d03128080baab945e85aaf6b8957a6 100644 (file)
@@ -199,7 +199,7 @@ namespace parallel
             std::vector<bool> vertices_owned_by_locally_owned_cells(
               tria.n_vertices());
             for (auto cell : tria.cell_iterators())
-              if (cell->active() && cell->subdomain_id() == my_rank)
+              if (cell->is_active() && cell->subdomain_id() == my_rank)
                 add_vertices_of_cell_to_vertices_owned_by_locally_owned_cells(
                   cell, vertices_owned_by_locally_owned_cells);
 
@@ -224,7 +224,7 @@ namespace parallel
             construction_data.cell_infos.resize(1);
 
             for (auto cell : tria.cell_iterators())
-              if (cell->active() && is_locally_relevant(cell))
+              if (cell->is_active() && is_locally_relevant(cell))
                 {
                   // to be filled
                   CellData<dim> cell_info;
@@ -343,7 +343,7 @@ namespace parallel
                     tria.n_vertices());
                 for (auto cell : tria.cell_iterators_on_level(level))
                   if (cell->level_subdomain_id() == my_rank ||
-                      (cell->active() && cell->subdomain_id() == my_rank))
+                      (cell->is_active() && cell->subdomain_id() == my_rank))
                     add_vertices_of_cell_to_vertices_owned_by_locally_owned_cells(
                       cell, vertices_owned_by_locally_owned_cells_on_level);
 
@@ -439,7 +439,7 @@ namespace parallel
             // on active level
             auto is_locally_relevant_on_active_level =
               [&](TriaIterator<CellAccessor<dim, spacedim>> &cell) {
-                if (cell->active())
+                if (cell->is_active())
                   for (unsigned int v = 0;
                        v < GeometryInfo<dim>::vertices_per_cell;
                        ++v)
@@ -459,7 +459,7 @@ namespace parallel
                     tria.n_vertices());
                 for (auto cell : tria.cell_iterators_on_level(level))
                   if (cell->level_subdomain_id() == my_rank ||
-                      (cell->active() && cell->subdomain_id() == my_rank))
+                      (cell->is_active() && cell->subdomain_id() == my_rank))
                     add_vertices_of_cell_to_vertices_owned_by_locally_owned_cells(
                       cell, vertices_owned_by_locally_owned_cells_on_level);
 
index fb45681fb8cdc80eb4253dc1ab14a178fddd620e..5268ec5a7c613026c6889b3177fbef554d955985 100644 (file)
@@ -337,7 +337,7 @@ namespace parallel
                        ++child_index)
                     {
                       const auto child = cell->child(child_index);
-                      Assert(child->active() && child->coarsen_flag_set(),
+                      Assert(child->is_active() && child->coarsen_flag_set(),
                              typename dealii::Triangulation<
                                dim>::ExcInconsistentCoarseningFlags());
 
index 6e357df483f5f74535a3963908d3564735f71cca..f7d4fb5d4d10edd32028879856ba98c0b070f165 100644 (file)
@@ -371,7 +371,7 @@ namespace
         // *---*---*
         // |   | M |
         // *---*---*
-        if (!used && dealii_cell->active() &&
+        if (!used && dealii_cell->is_active() &&
             dealii_cell->is_artificial() == false &&
             dealii_cell->level() + 1 < static_cast<int>(marked_vertices.size()))
           {
@@ -388,7 +388,7 @@ namespace
           }
 
         // Like above, but now the other way around
-        if (!used && dealii_cell->active() &&
+        if (!used && dealii_cell->is_active() &&
             dealii_cell->is_artificial() == false && dealii_cell->level() > 0)
           {
             for (unsigned int v = 0; v < GeometryInfo<dim>::vertices_per_cell;
@@ -1209,7 +1209,7 @@ namespace parallel
                   CELL_REFINE:
                   // double check the condition that we will only ever attach
                   // data to active cells when we get here
-                  Assert(dealii_cell->active(), ExcInternalError());
+                  Assert(dealii_cell->is_active(), ExcInternalError());
                   break;
 
                 case parallel::distributed::Triangulation<dim, spacedim>::
@@ -1218,11 +1218,12 @@ namespace parallel
                   // data to cells with children when we get here. however, we
                   // can only tolerate one level of coarsening at a time, so
                   // check that the children are all active
-                  Assert(dealii_cell->active() == false, ExcInternalError());
+                  Assert(dealii_cell->is_active() == false, ExcInternalError());
                   for (unsigned int c = 0;
                        c < GeometryInfo<dim>::max_children_per_cell;
                        ++c)
-                    Assert(dealii_cell->child(c)->active(), ExcInternalError());
+                    Assert(dealii_cell->child(c)->is_active(),
+                           ExcInternalError());
                   break;
 
                 case parallel::distributed::Triangulation<dim, spacedim>::
@@ -3385,13 +3386,13 @@ namespace parallel
                  ++cell)
               {
                 // nothing to do if we are already on the finest level
-                if (cell->active())
+                if (cell->is_active())
                   continue;
 
                 const unsigned int n_children       = cell->n_children();
                 unsigned int       flagged_children = 0;
                 for (unsigned int child = 0; child < n_children; ++child)
-                  if (cell->child(child)->active() &&
+                  if (cell->child(child)->is_active() &&
                       cell->child(child)->coarsen_flag_set())
                     ++flagged_children;
 
@@ -3399,7 +3400,7 @@ namespace parallel
                 // coarsen flags
                 if (flagged_children < n_children)
                   for (unsigned int child = 0; child < n_children; ++child)
-                    if (cell->child(child)->active())
+                    if (cell->child(child)->is_active())
                       cell->child(child)->clear_coarsen_flag();
               }
           }
@@ -4029,7 +4030,7 @@ namespace parallel
                 cell = this->begin(maybe_coarser_lvl),
                 endc = this->end(lvl);
               for (; cell != endc; ++cell)
-                if (cell->level() == static_cast<int>(lvl) || cell->active())
+                if (cell->level() == static_cast<int>(lvl) || cell->is_active())
                   {
                     const bool is_level_artificial =
                       (cell->level_subdomain_id() ==
index 8b3cdd7eb624b389c306c8a0aa363f3dd130128b..9ff7acd3046344c49c65c8a2f8789ce22fc3d763 100644 (file)
@@ -445,7 +445,7 @@ namespace DoFTools
             typename DoFHandlerType::level_cell_iterator cell = dof.begin(0);
             while (!cell->at_boundary(direction))
               cell = cell->neighbor(direction);
-            while (!cell->active())
+            while (!cell->is_active())
               cell = cell->child(direction);
 
             const unsigned int dofs_per_vertex = cell->get_fe().dofs_per_vertex;
@@ -665,7 +665,7 @@ namespace DoFTools
                       // face twice and hence put the indices the other way
                       // around
                       if (!cell->neighbor_or_periodic_neighbor(face)
-                             ->active() ||
+                             ->is_active() ||
                           (neighbor->subdomain_id() != cell->subdomain_id()))
                         {
                           constraints.add_entries_local_to_global(
@@ -854,7 +854,7 @@ namespace DoFTools
                       // the total ordering.
                       if (neighbor->level() == cell->level() &&
                           neighbor->index() > cell->index() &&
-                          neighbor->active() && neighbor->is_locally_owned())
+                          neighbor->is_active() && neighbor->is_locally_owned())
                         continue;
                       // If we are more refined then the neighbor, then we
                       // will automatically find the active neighbor cell when
@@ -1152,7 +1152,7 @@ namespace DoFTools
                       // is 'greater' in the total ordering.
                       if (neighbor->level() == cell->level() &&
                           neighbor->index() > cell->index() &&
-                          neighbor->active() && neighbor->is_locally_owned())
+                          neighbor->is_active() && neighbor->is_locally_owned())
                         continue;
                       // Again, like the non-hp case: If we are more refined
                       // then the neighbor, then we will automatically find
index 993894c380a9e06295baf2450181c0316b220272..d88b1a6367872548d96ff2f777865f1f0ed75dc8 100644 (file)
@@ -367,7 +367,7 @@ MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::get_vertices(
   const typename DoFHandler<dim, spacedim>::cell_iterator dof_cell(
     *cell, euler_dof_handler);
 
-  Assert(uses_level_dofs || dof_cell->active() == true, ExcInactiveCell());
+  Assert(uses_level_dofs || dof_cell->is_active() == true, ExcInactiveCell());
   AssertDimension(GeometryInfo<dim>::vertices_per_cell,
                   fe_values.n_quadrature_points);
   AssertDimension(fe_to_real.size(),
@@ -2429,7 +2429,7 @@ MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::update_internal_dofs(
          ExcMessage("euler_dof_handler is empty"));
 
   typename DoFHandlerType::cell_iterator dof_cell(*cell, euler_dof_handler);
-  Assert(uses_level_dofs || dof_cell->active() == true, ExcInactiveCell());
+  Assert(uses_level_dofs || dof_cell->is_active() == true, ExcInactiveCell());
   if (uses_level_dofs)
     {
       AssertIndexRange(cell->level(), euler_vector.size());
index 5cbb2919605a8f563237a4e0aab83db6576595b6..7d7d381c2002c596ecfea3ce6d69a5d2bb519bee 100644 (file)
@@ -74,7 +74,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::get_vertices(
 
   // We require the cell to be active since we can only then get nodal
   // values for the shifts
-  Assert(dof_cell->active() == true, ExcInactiveCell());
+  Assert(dof_cell->is_active() == true, ExcInactiveCell());
 
   // now get the values of the shift vectors at the vertices
   Vector<typename VectorType::value_type> mapping_values(
index e4bd088f83cc364baf0c53bf14825b0c28e7db28..c22770c625fc271c5af6eebe87a88be63da17954 100644 (file)
@@ -193,7 +193,7 @@ MappingQEulerian<dim, VectorType, spacedim>::MappingQEulerianGeneric::
   typename DoFHandler<dim, spacedim>::cell_iterator dof_cell(
     *cell, mapping_q_eulerian.euler_dof_handler);
 
-  Assert(mg_vector || dof_cell->active() == true, ExcInactiveCell());
+  Assert(mg_vector || dof_cell->is_active() == true, ExcInactiveCell());
 
   // our quadrature rule is chosen so that each quadrature point corresponds
   // to a support point in the undeformed configuration. We can then query
index 51704290a3f31204e510d5c66e04b63768baa4b7..e526770e4ec178319a890db8b04c63fa93ac5222 100644 (file)
@@ -1386,7 +1386,7 @@ GridOut::write_xfig(const Triangulation<2> &tria,
   for (const auto &cell : tria.cell_iterators())
     {
       // If depth is not encoded, write finest level only
-      if (!xfig_flags.level_depth && !cell->active())
+      if (!xfig_flags.level_depth && !cell->is_active())
         continue;
       // Code for polygon
       out << "2 3  " << xfig_flags.line_style << ' '
@@ -1633,7 +1633,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
 
       materials.insert(cell->material_id());
       levels.insert(cell->level());
-      if (cell->active())
+      if (cell->is_active())
         subdomains.insert(cell->subdomain_id() + 2);
       level_subdomains.insert(cell->level_subdomain_id() + 2);
     }
@@ -2106,7 +2106,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
     {
       for (const auto &cell : tria.cell_iterators_on_level(level_index))
         {
-          if (!svg_flags.convert_level_number_to_height && !cell->active())
+          if (!svg_flags.convert_level_number_to_height && !cell->is_active())
             continue;
 
           // draw the current cell
@@ -2116,7 +2116,8 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
             {
               out << " class=\"p";
 
-              if (!cell->active() && svg_flags.convert_level_number_to_height)
+              if (!cell->is_active() &&
+                  svg_flags.convert_level_number_to_height)
                 out << 's';
 
               switch (svg_flags.coloring)
@@ -2128,7 +2129,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
                     out << static_cast<unsigned int>(cell->level());
                     break;
                   case GridOutFlags::Svg::subdomain_id:
-                    if (cell->active())
+                    if (cell->is_active())
                       out << cell->subdomain_id() + 2;
                     else
                       out << 'X';
@@ -2353,7 +2354,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
                   if (svg_flags.label_level_number ||
                       svg_flags.label_cell_index || svg_flags.label_material_id)
                     out << ',';
-                  if (cell->active())
+                  if (cell->is_active())
                     out << static_cast<
                       std::make_signed<types::subdomain_id>::type>(
                       cell->subdomain_id());
index 1378bcaea0fd1fe9ed39d54e4d8782b28dc34873..30626d0aa21fc15b9fc0f77e96bedabf67f1dea3 100644 (file)
@@ -1724,7 +1724,7 @@ namespace GridTools
                       GeometryInfo<dim>::vertex_to_face[v][vface];
 
                     if (!cell->at_boundary(face) &&
-                        cell->neighbor(face)->active())
+                        cell->neighbor(face)->is_active())
                       {
                         // there is a (possibly) coarser cell behind a
                         // face to which the vertex belongs. the
@@ -2048,7 +2048,7 @@ namespace GridTools
         bool has_predicate =
           false; // Start assuming there's no cells with predicate inside
         std::vector<typename MeshType::active_cell_iterator> active_cells;
-        if (parent_cell->active())
+        if (parent_cell->is_active())
           active_cells = {parent_cell};
         else
           // Finding all active cells descendants of the current one (or the
@@ -2359,7 +2359,7 @@ namespace GridTools
         for (unsigned int i = 0; i < GeometryInfo<dim>::faces_per_cell; ++i)
           {
             if ((cell->at_boundary(i) == false) &&
-                (cell->neighbor(i)->active()))
+                (cell->neighbor(i)->is_active()))
               {
                 typename Triangulation<dim, spacedim>::active_cell_iterator
                   adjacent_cell = cell->neighbor(i);
@@ -2507,7 +2507,7 @@ namespace GridTools
               {
                 if (cell->at_boundary(i) == false)
                   {
-                    if (cell->neighbor(i)->active())
+                    if (cell->neighbor(i)->is_active())
                       {
                         typename Triangulation<dim,
                                                spacedim>::active_cell_iterator
@@ -3068,7 +3068,7 @@ namespace GridTools
                                            const unsigned int n_active_cells,
                                            const unsigned int n_partitions)
     {
-      if (cell->active())
+      if (cell->is_active())
         {
           while (current_cell_idx >=
                  std::floor(static_cast<uint_least64_t>(n_active_cells) *
@@ -3163,12 +3163,12 @@ namespace GridTools
           endc = triangulation.end();
         for (; cell != endc; ++cell)
           {
-            if (cell->active())
+            if (cell->is_active())
               continue;
             bool                                 all_children_active = true;
             std::map<unsigned int, unsigned int> map_cpu_n_cells;
             for (unsigned int n = 0; n < cell->n_children(); ++n)
-              if (!cell->child(n)->active())
+              if (!cell->child(n)->is_active())
                 {
                   all_children_active = false;
                   break;
@@ -3855,7 +3855,7 @@ namespace GridTools
         const typename Triangulation<dim, spacedim>::cell_iterator cell =
           *cell_ptr;
 
-        Assert(!cell->active(),
+        Assert(!cell->is_active(),
                ExcMessage(
                  "This function is only valid for a list of cells that "
                  "have children (i.e., no cell in the list may be active)."));
index c56a0bf09563678b1e9fcf1d7fe9961948a0de00..1b6334018afa10f429e3a86faf0b6adcd71e9f37 100644 (file)
@@ -272,7 +272,7 @@ namespace GridTools
                       GeometryInfo<dim>::vertex_to_face[v][vface];
 
                     if (!cell->at_boundary(face) &&
-                        cell->neighbor(face)->active())
+                        cell->neighbor(face)->is_active())
                       {
                         // there is a (possibly) coarser cell behind a
                         // face to which the vertex belongs. the
@@ -1190,9 +1190,9 @@ namespace GridTools
           {
             // at least one cell is active
             if (remove_ghost_cells &&
-                ((cell_pair->first->active() &&
+                ((cell_pair->first->is_active() &&
                   !cell_pair->first->is_locally_owned()) ||
-                 (cell_pair->second->active() &&
+                 (cell_pair->second->is_active() &&
                   !cell_pair->second->is_locally_owned())))
               {
                 // we only exclude ghost cells for distributed Triangulations
@@ -1209,7 +1209,7 @@ namespace GridTools
     // least one active iterator or have different refinement_cases
     for (cell_pair = cell_list.begin(); cell_pair != cell_list.end();
          ++cell_pair)
-      Assert(cell_pair->first->active() || cell_pair->second->active() ||
+      Assert(cell_pair->first->is_active() || cell_pair->second->is_active() ||
                (cell_pair->first->refinement_case() !=
                 cell_pair->second->refinement_case()),
              ExcInternalError());
index 166782322fca5b9c70fdcd3a3a8d7231e44f41d0..5bc2cb858e01d8c8265e1701ebefffec1a7d1dd1 100644 (file)
@@ -173,11 +173,11 @@ namespace
   cell_is_patch_level_1(
     const TriaIterator<dealii::CellAccessor<dim, spacedim>> &cell)
   {
-    Assert(cell->active() == false, ExcInternalError());
+    Assert(cell->is_active() == false, ExcInternalError());
 
     unsigned int n_active_children = 0;
     for (unsigned int i = 0; i < cell->n_children(); ++i)
-      if (cell->child(i)->active())
+      if (cell->child(i)->is_active())
         ++n_active_children;
 
     return (n_active_children == 0) ||
@@ -205,13 +205,13 @@ namespace
         const unsigned int n_children          = cell->n_children();
 
         for (unsigned int c = 0; c < n_children; ++c)
-          if (cell->child(c)->active() && cell->child(c)->coarsen_flag_set())
+          if (cell->child(c)->is_active() && cell->child(c)->coarsen_flag_set())
             ++children_to_coarsen;
         if (children_to_coarsen == n_children)
           return true;
         else
           for (unsigned int c = 0; c < n_children; ++c)
-            if (cell->child(c)->active())
+            if (cell->child(c)->is_active())
               cell->child(c)->clear_coarsen_flag();
       }
     // no children, so no coarsening
@@ -874,7 +874,7 @@ namespace
           // the same.
           if (dim == 2)
             {
-              if (cell->active() && face->has_children())
+              if (cell->is_active() && face->has_children())
                 {
                   adjacent_cells[2 * face->child(0)->index() + offset] = cell;
                   adjacent_cells[2 * face->child(1)->index() + offset] = cell;
@@ -903,7 +903,7 @@ namespace
               // visit cells on finer levels, so no
               // harm will be done.
               if (face->has_children() &&
-                  (cell->active() ||
+                  (cell->is_active() ||
                    GeometryInfo<dim>::face_refinement_case(
                      cell->refinement_case(), f) ==
                      RefinementCase<dim - 1>::isotropic_refinement))
@@ -4866,7 +4866,7 @@ namespace internal
                   first_child->set_neighbor(1, second_child);
                   if (cell->neighbor(0).state() != IteratorState::valid)
                     first_child->set_neighbor(0, cell->neighbor(0));
-                  else if (cell->neighbor(0)->active())
+                  else if (cell->neighbor(0)->is_active())
                     {
                       // since the neighbors level is always <=level,
                       // if the cell is active, then there are no
@@ -4908,7 +4908,7 @@ namespace internal
 
                   if (cell->neighbor(1).state() != IteratorState::valid)
                     second_child->set_neighbor(1, cell->neighbor(1));
-                  else if (cell->neighbor(1)->active())
+                  else if (cell->neighbor(1)->is_active())
                     {
                       Assert(cell->neighbor(1)->level() <= cell->level(),
                              ExcInternalError());
@@ -11990,10 +11990,10 @@ Triangulation<dim, spacedim>::last_active() const
   if (cell != end())
     {
       // then move to the last active one
-      if (cell->active() == true)
+      if (cell->is_active() == true)
         return cell;
       while ((--cell).state() == IteratorState::valid)
-        if (cell->active() == true)
+        if (cell->is_active() == true)
           return cell;
     }
   return cell;
@@ -13506,7 +13506,7 @@ Triangulation<dim, spacedim>::execute_coarsening()
 
   cell_iterator cell = begin(), endc = end();
   for (; cell != endc; ++cell)
-    if (!cell->active())
+    if (!cell->is_active())
       if (cell->child(0)->coarsen_flag_set())
         {
           cell->set_user_flag();
@@ -13693,13 +13693,13 @@ Triangulation<dim, spacedim>::fix_coarsen_flags()
       for (; cell != endc; ++cell)
         {
           // nothing to do if we are already on the finest level
-          if (cell->active())
+          if (cell->is_active())
             continue;
 
           const unsigned int n_children       = cell->n_children();
           unsigned int       flagged_children = 0;
           for (unsigned int child = 0; child < n_children; ++child)
-            if (cell->child(child)->active() &&
+            if (cell->child(child)->is_active() &&
                 cell->child(child)->coarsen_flag_set())
               {
                 ++flagged_children;
@@ -13867,7 +13867,8 @@ namespace
 
         for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell;
              ++face)
-          if (!cell->at_boundary(face) && (!cell->neighbor(face)->active()) &&
+          if (!cell->at_boundary(face) &&
+              (!cell->neighbor(face)->is_active()) &&
               (cell_will_be_coarsened(cell->neighbor(face))))
             possibly_do_not_produce_unrefined_islands<dim, spacedim>(
               cell->neighbor(face));
@@ -14141,7 +14142,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
             {
               // only do something if this
               // cell will be coarsened
-              if (!cell->active() && cell_will_be_coarsened(cell))
+              if (!cell->is_active() && cell_will_be_coarsened(cell))
                 possibly_do_not_produce_unrefined_islands<dim, spacedim>(cell);
             }
         }
@@ -14171,8 +14172,9 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
           !(smooth_grid & patch_level_1))
         {
           for (const auto &cell : cell_iterators())
-            if (!cell->active() || (cell->active() && cell->refine_flag_set() &&
-                                    cell->is_locally_owned()))
+            if (!cell->is_active() ||
+                (cell->is_active() && cell->refine_flag_set() &&
+                 cell->is_locally_owned()))
               {
                 // check whether all children are active, i.e. not
                 // refined themselves. This is a precondition that the
@@ -14180,9 +14182,9 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                 // flagged for refinement, then all future children
                 // will be active
                 bool all_children_active = true;
-                if (!cell->active())
+                if (!cell->is_active())
                   for (unsigned int c = 0; c < cell->n_children(); ++c)
-                    if (!cell->child(c)->active() ||
+                    if (!cell->child(c)->is_active() ||
                         cell->child(c)->is_ghost() ||
                         cell->child(c)->is_artificial())
                       {
@@ -14234,7 +14236,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                            eliminate_refined_boundary_islands))) &&
                         (total_neighbors != 0))
                       {
-                        if (!cell->active())
+                        if (!cell->is_active())
                           for (unsigned int c = 0; c < cell->n_children(); ++c)
                             {
                               cell->child(c)->clear_refine_flag();
@@ -14401,7 +14403,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
           // children is set then set_refine_flag and
           // clear_coarsen_flag of all children.
           for (const auto &cell : cell_iterators())
-            if (!cell->active())
+            if (!cell->is_active())
               {
                 // ensure the invariant. we can then check whether all
                 // of its children are further refined or not by
@@ -14442,7 +14444,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
               // that we know that it is patch_level_1, i.e. if one of
               // its children is active then so are all, and it isn't
               // going to have any grandchildren at all:
-              if (cell->active() || cell->child(0)->active())
+              if (cell->is_active() || cell->child(0)->is_active())
                 continue;
 
               // cell is not active, and so are none of its
@@ -14453,7 +14455,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
               bool               has_active_grandchildren = false;
 
               for (unsigned int i = 0; i < n_children; ++i)
-                if (cell->child(i)->child(0)->active())
+                if (cell->child(i)->child(0)->is_active())
                   {
                     has_active_grandchildren = true;
                     break;
@@ -14486,7 +14488,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                   // if child is found to be a patch of active cells
                   // itself, then add up how many of its children are
                   // supposed to be coarsened
-                  if (child->child(0)->active())
+                  if (child->child(0)->is_active())
                     for (unsigned int cc = 0; cc < nn_children; ++cc)
                       if (child->child(cc)->coarsen_flag_set())
                         ++n_coarsen_flags;
@@ -14507,7 +14509,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                 for (unsigned int c = 0; c < n_children; ++c)
                   {
                     const cell_iterator child = cell->child(c);
-                    if (child->child(0)->active())
+                    if (child->child(0)->is_active())
                       for (unsigned int cc = 0; cc < child->n_children(); ++cc)
                         child->child(cc)->clear_coarsen_flag();
                   }
@@ -14572,7 +14574,7 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                         // coarsen flag of our neighbor,
                         // fix_coarsen_flags() makes sure, that the
                         // mother cell will not be coarsened
-                        if (cell->neighbor_or_periodic_neighbor(i)->active())
+                        if (cell->neighbor_or_periodic_neighbor(i)->is_active())
                           {
                             if ((!has_periodic_neighbor &&
                                  cell->neighbor_is_coarser(i)) ||
index a9f117e9369f76c7d9b936e5b08ddfe1bab06200..53a56fc02e0b443c8963a1990dce900bbf1cf659 100644 (file)
@@ -1973,7 +1973,7 @@ CellAccessor<dim, spacedim>::set_subdomain_id(
   const types::subdomain_id new_subdomain_id) const
 {
   Assert(this->used(), TriaAccessorExceptions::ExcCellNotUsed());
-  Assert(this->active(),
+  Assert(this->is_active(),
          ExcMessage("set_subdomain_id() can only be called on active cells!"));
   this->tria->levels[this->present_level]->subdomain_ids[this->present_index] =
     new_subdomain_id;
index 357e2b27b6ab726607b88f2687bb4c17310beea7..ac3512c1045ab6a95b2d2e0764b7f1b3e1040134 100644 (file)
@@ -1139,7 +1139,7 @@ namespace internal
                              ++child_index)
                           {
                             const auto sibling = parent->child(child_index);
-                            Assert(sibling->active() &&
+                            Assert(sibling->is_active() &&
                                      sibling->coarsen_flag_set(),
                                    typename dealii::Triangulation<
                                      dim>::ExcInconsistentCoarseningFlags());
@@ -1194,7 +1194,7 @@ namespace internal
 
               if (cell->is_locally_owned())
                 {
-                  Assert(cell->active(), ExcInternalError());
+                  Assert(cell->is_active(), ExcInternalError());
                   cell->set_active_fe_index(persist.second);
                 }
             }
@@ -1210,7 +1210,7 @@ namespace internal
                    ++child_index)
                 {
                   const auto &child = parent->child(child_index);
-                  Assert(child->is_locally_owned() && child->active(),
+                  Assert(child->is_locally_owned() && child->is_active(),
                          ExcInternalError());
                   child->set_active_fe_index(refine.second);
                 }
@@ -1221,7 +1221,7 @@ namespace internal
           for (const auto &coarsen : fe_transfer->coarsened_cells_fe_index)
             {
               const auto &cell = coarsen.first;
-              Assert(cell->is_locally_owned() && cell->active(),
+              Assert(cell->is_locally_owned() && cell->is_active(),
                      ExcInternalError());
               cell->set_active_fe_index(coarsen.second);
             }
index 5d0e02413d71deec3b981b5cc3f49c26b66c7b34..43b3ec6613ddbf4a28058822f255a36041bd420d 100644 (file)
@@ -602,7 +602,7 @@ namespace hp
                      ++child_index)
                   {
                     const auto &child = parent->child(child_index);
-                    if (child->active())
+                    if (child->is_active())
                       {
                         if (child->coarsen_flag_set())
                           ++h_flagged_children;
@@ -623,7 +623,7 @@ namespace hp
                   // drop all h coarsening flags.
                   for (unsigned int child_index = 0; child_index < n_children;
                        ++child_index)
-                    if (parent->child(child_index)->active())
+                    if (parent->child(child_index)->is_active())
                       parent->child(child_index)->clear_coarsen_flag();
               }
           }
index eac86627f28c57003fe0e3f50c1445127724534f..d7870da589791ac17999819cf36087c60fe61ff1 100644 (file)
@@ -918,7 +918,7 @@ DataOut<dim, DoFHandlerType>::build_patches(
       {
         // move forward until active_cell points at the cell (cell) we are
         // looking at to compute the current active_index
-        while (active_cell != this->triangulation->end() && cell->active() &&
+        while (active_cell != this->triangulation->end() && cell->is_active() &&
                decltype(active_cell)(cell) != active_cell)
           {
             ++active_cell;
index 473b7af5d38b8acc6cb663228a2a4811648c9a1f..376f30926ed4c4098f88d02e420e5d10bb0a2dbc 100644 (file)
@@ -295,7 +295,7 @@ DataOutFaces<dim, DoFHandlerType>::build_one_patch(
           // belongs in order to access the cell data. this is not readily
           // available, so choose the following rather inefficient way:
           Assert(
-            cell_and_face->first->active(),
+            cell_and_face->first->is_active(),
             ExcMessage(
               "The current function is trying to generate cell-data output "
               "for a face that does not belong to an active cell. This is "
index c366af22896a94f30fcaaa3e5480962099014a14..6db2d3448c95ca527e72a418758cb442e14e4804 100644 (file)
@@ -413,7 +413,7 @@ DataOutRotation<dim, DoFHandlerType>::build_one_patch(
               // we need to get at the number of the cell to which this face
               // belongs in order to access the cell data. this is not readily
               // available, so choose the following rather inefficient way:
-              Assert((*cell)->active(),
+              Assert((*cell)->is_active(),
                      ExcMessage("Cell must be active for cell data"));
               const unsigned int cell_number = std::distance(
                 this->triangulation->begin_active(),
index 403a4b1b01e6b668b7afc0d99342d20e99fb7e3f..5e453f04cbbcf65e3604ac7f7c61835d297eddc0 100644 (file)
@@ -308,7 +308,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::
   for (typename DoFHandlerType::cell_iterator cell = dof_handler->begin();
        cell != dof_handler->end();
        ++cell)
-    if (!cell->active() && cell->child(0)->coarsen_flag_set())
+    if (!cell->is_active() && cell->child(0)->coarsen_flag_set())
       ++n_coarsen_fathers;
   Assert(n_cells_to_coarsen >= 2 * n_coarsen_fathers, ExcInternalError());
 
@@ -339,7 +339,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::
        ++cell)
     {
       // CASE 1: active cell that remains as it is
-      if (cell->active() && !cell->coarsen_flag_set())
+      if (cell->is_active() && !cell->coarsen_flag_set())
         {
           const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
           indices_on_cell[n_sr].resize(dofs_per_cell);
@@ -367,7 +367,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::
                ++child_index)
             {
               const auto child = cell->child(child_index);
-              Assert(child->active() && child->coarsen_flag_set(),
+              Assert(child->is_active() && child->coarsen_flag_set(),
                      typename dealii::Triangulation<
                        dim>::ExcInconsistentCoarseningFlags());
 
index 99ff0ae1c051fc2c58495241ab8b9b21cd7b772c..d58f5e8e72a8d8822696f2d5fe52025a684bca3d 100644 (file)
@@ -581,9 +581,9 @@ namespace
     // no problem at all, if it is on a lower
     // level than the present one, then it
     // will be refined below anyway.
-    if (new_cell->active())
+    if (new_cell->is_active())
       {
-        if (new_cell->refine_flag_set() && old_cell->active())
+        if (new_cell->refine_flag_set() && old_cell->is_active())
           {
             if (old_cell->coarsen_flag_set())
               old_cell->clear_coarsen_flag();
index 0e9143e11a39e4bb90a9c0c2957f118f8614b435..d6e65be3c714b0cb69ef51c25911c4e2f2f420ed 100644 (file)
@@ -90,7 +90,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         // first make sure that what
         // we do is reasonable. for
@@ -98,7 +98,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
         // to be active, not only
         // some of them
         for (unsigned int c = 0; c < cell->n_children(); ++c)
-          AssertThrow(cell->child(c)->active(), ExcInternalError());
+          AssertThrow(cell->child(c)->is_active(), ExcInternalError());
 
         // then restrict and prolongate
         cell->get_interpolated_dof_values(tmp, v);
@@ -114,7 +114,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         cell->get_interpolated_dof_values(x, v);
         cell->set_dof_values_by_interpolation(v, x2);
index eca863ffbd86e54a5a7870ac8af6f27cc977a7eb..5c53397700f0c7b228600c590d350318fcdac8b0 100644 (file)
@@ -83,7 +83,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         // first make sure that what
         // we do is reasonable. for
@@ -92,7 +92,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
         // some of them
         for (unsigned int c = 0; c < GeometryInfo<dim>::max_children_per_cell;
              ++c)
-          Assert(cell->child(c)->active(), ExcInternalError());
+          Assert(cell->child(c)->is_active(), ExcInternalError());
 
         // then restrict and prolongate
         cell->get_interpolated_dof_values(tmp, v);
@@ -108,7 +108,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         cell->get_interpolated_dof_values(x, v);
         cell->set_dof_values_by_interpolation(v, x2);
index 63c84571e5be0f62fcb18ba5c0042b2ff2f771ac..d355603e9ad0ab0f2635b411692819ab27d6d10c 100644 (file)
@@ -84,7 +84,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         // first make sure that what
         // we do is reasonable. for
@@ -93,7 +93,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
         // some of them
         for (unsigned int c = 0; c < GeometryInfo<dim>::max_children_per_cell;
              ++c)
-          AssertThrow(cell->child(c)->active(), ExcInternalError());
+          AssertThrow(cell->child(c)->is_active(), ExcInternalError());
 
         // then restrict and prolongate
         cell->get_interpolated_dof_values(tmp, v);
@@ -109,7 +109,7 @@ check_element(const Triangulation<dim> &tr, const FiniteElement<dim> &fe)
   for (typename DoFHandler<dim>::cell_iterator cell = dof_handler.begin();
        cell != dof_handler.end();
        ++cell)
-    if (cell->has_children() && cell->child(0)->active())
+    if (cell->has_children() && cell->child(0)->is_active())
       {
         cell->get_interpolated_dof_values(x, v);
         cell->set_dof_values_by_interpolation(v, x2);
index 06878ea106e0eb57e31373c0d42d6d37d817163d..652c4573122bccb952b741c13adef96da88d7907 100644 (file)
@@ -158,7 +158,7 @@ check()
       cell = dof_1.begin();
       endc = dof_1.end();
       for (unsigned int index = 0; cell != endc; ++cell)
-        if (cell->active())
+        if (cell->is_active())
           {
             ++index;
             if (index % (2 * dim) == 0)
@@ -187,7 +187,7 @@ check()
       cell = dof_2.begin();
       endc = dof_2.end();
       for (unsigned int index = 0; cell != endc; ++cell)
-        if (cell->active())
+        if (cell->is_active())
           {
             ++index;
             if (index % (2 * dim) == 1)
index 34895af8d0b203bbe4f4f7d8991d3c5d74581de4..ce2d7c7cf15625c96b80cb4c338cc03be2af10a7 100644 (file)
@@ -87,7 +87,7 @@ check()
       // produces quite random grids
       cell = dof_1.begin();
       for (unsigned int index = 0; cell != endc; ++cell)
-        if (cell->active())
+        if (cell->is_active())
           {
             ++index;
             if (index % 3 == 0)
@@ -97,7 +97,7 @@ check()
       cell = dof_2.begin();
       endc = dof_2.end();
       for (unsigned int index = 0; cell != endc; ++cell)
-        if (cell->active())
+        if (cell->is_active())
           {
             ++index;
             if (index % 3 == 1)
index 4059db508d876021eb64c520ae6b44c14eabc3d4..53c7f7d4480b7a28dc5fd45fe3600beb6270eebe 100644 (file)
@@ -58,11 +58,11 @@ template <int dim>
 bool
 cell_is_patch_level_1(const typename Triangulation<dim>::cell_iterator &cell)
 {
-  Assert(cell->active() == false, ExcInternalError());
+  Assert(cell->is_active() == false, ExcInternalError());
 
   unsigned int n_active_children = 0;
   for (unsigned int i = 0; i < cell->n_children(); ++i)
-    if (cell->child(i)->active())
+    if (cell->child(i)->is_active())
       ++n_active_children;
 
   return (n_active_children == 0) || (n_active_children == cell->n_children());
@@ -90,8 +90,8 @@ test()
        ++cell)
     {
       deallog << "Cell = " << cell
-              << (cell->active() ? " is active " : " is not active ");
-      if (!cell->active())
+              << (cell->is_active() ? " is active " : " is not active ");
+      if (!cell->is_active())
         {
           deallog << "and has children: ";
           for (unsigned int i = 0; i < 4; ++i)
@@ -118,7 +118,7 @@ test()
       AssertThrow((cell->refine_flag_set() == false) &&
                     (cell->coarsen_flag_set() == false),
                   ExcInternalError());
-      if (!cell->active())
+      if (!cell->is_active())
         AssertThrow(cell_is_patch_level_1<2>(cell), ExcInternalError());
     }
 
index e6bdac9bab00b5365a6ff8f89b534697d66e3277..60d2f855c71142eec4411ae0dc6b631b2e952291 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index 324fbed0f876e40c5f9f03d45de9c10ef5a17b82..30a493e7df0275a926e74d167894ee63c0a5c4de 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index 8e14db60e66eae87151127a88c35039753411784..36683b9f73a7a9a6d2f4a33b80e7043e4cfaa22f 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index a9c65d5a45be299ab53703eb79f5acd4143e825b..0419389b5df7030a87f24544b530b00023bf218a 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index ecb0f890800c64d28e77dd1aca88f2226ad7309f..3e2d08f6c5b42196bb1dcdf51c0855afb1d6826e 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index 9a75e20fb615f1ddaf0764e1ada97db7ff59261d..f0ef94f6102379cdc103235842aeba666f937605 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index 63897637fa76bba583b7a8fd8fe1fe8090fc39b2..06891b6bd01ebd9744349a1234cd4b800eacc773 100644 (file)
@@ -65,12 +65,12 @@ setup(Triangulation<dim> &         tria,
                                               endc = dh.end(1);
   for (unsigned int counter = 0; cell != endc; ++counter, ++cell)
     {
-      Assert(!cell->active(), ExcInternalError());
+      Assert(!cell->is_active(), ExcInternalError());
       for (unsigned int child_index = 0; child_index < cell->n_children();
            ++child_index)
         {
           const auto &child = cell->child(child_index);
-          Assert(child->active(), ExcInternalError());
+          Assert(child->is_active(), ExcInternalError());
 
           child->set_active_fe_index(1);
 
index bee6f5d62f0630b8c00896ebe22e8656ae1d27ed..7cc23d4f1a2cd1391dc6d72713c11301ee4bb5dc 100644 (file)
@@ -268,7 +268,7 @@ namespace LinearAdvectionTest
                       }
                     // If the neighbor is not active, then it is at a higher
                     // refinement level (so we do not need to integrate now)
-                    if (neighbor_cell->active())
+                    if (neighbor_cell->is_active())
                       {
                         if (neighbor_cell->is_locally_owned())
                           {
index e708e5cf66412eb8e41dadea745c8b399006bdbd..869dbc6d44424321e9f78ecd41f2d94f2a8bca77 100644 (file)
@@ -216,7 +216,7 @@ test()
           if (coarsen_me)
             for (unsigned int i = 0; i < cell->n_children(); ++i)
               {
-                if (cell->child(i)->active() &&
+                if (cell->child(i)->is_active() &&
                     cell->child(i)->is_locally_owned())
                   {
                     cell->child(i)->clear_refine_flag();
index 0e206e2f03bbd75d69e3b034827770f97ea4f2c1..4a8d99d516d4b3af4be464ed19dfaf63b32989c7 100644 (file)
@@ -217,7 +217,7 @@ test()
           if (coarsen_me)
             for (unsigned int i = 0; i < cell->n_children(); ++i)
               {
-                if (cell->child(i)->active() &&
+                if (cell->child(i)->is_active() &&
                     cell->child(i)->is_locally_owned())
                   {
                     cell->child(i)->clear_refine_flag();
index 65a0289b108a2e3f615a870ce67ad79f8ea2a08b..6eb7b4918fb0cb626d16bcfa3e6841bb4392bc83 100644 (file)
@@ -166,7 +166,7 @@ namespace Step40
                    ++face)
                 {
                   if ((cell->face(face)->at_boundary()) ||
-                      (cell->neighbor(face)->active() &&
+                      (cell->neighbor(face)->is_active() &&
                        cell->neighbor(face)->is_ghost()))
                     {
                       fe_face_values.reinit(cell, face);
index 7516e42d8066417e6b9f5436a3ab7f08ec1d4fcb..d5c26c9bc215d2fd7626ae54ac07073fe4f0e667 100644 (file)
@@ -167,7 +167,7 @@ namespace Step40
                    ++face)
                 {
                   if ((cell->face(face)->at_boundary()) ||
-                      (cell->neighbor(face)->active() &&
+                      (cell->neighbor(face)->is_active() &&
                        cell->neighbor(face)->is_ghost()))
                     {
                       fe_face_values.reinit(cell, face);
index 1a6ff582daa1a663c00c2dbbd234f4f9e6255cd2..88820d95183ff32da312b0241d9bcefb43b52a54 100644 (file)
@@ -70,7 +70,7 @@ namespace dealii
               }
           }
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             (c1->subdomain_id() != c2->subdomain_id()))
           return false;
 
index 8b9a86029a96fba0149a0342c961af4b16d28d11..bf34814090129e6e3a0c9350584a666c44fd396b 100644 (file)
@@ -71,7 +71,7 @@ namespace dealii
               }
           }
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             (c1->subdomain_id() != c2->subdomain_id()))
           return false;
 
@@ -84,15 +84,15 @@ namespace dealii
         if (c1->user_flag_set() != c2->user_flag_set())
           return false;
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             c1->get_fe().get_name() != c2->get_fe().get_name())
           return false;
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             c1->active_fe_index() != c2->active_fe_index())
           return false;
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             c1->future_fe_index() != c2->future_fe_index())
           return false;
 
index e05328f29decb2ab438e512113b5ef0adefa566a..73b5d53e757f9d20bd272503d48604b71b79bd1e 100644 (file)
@@ -75,7 +75,7 @@ namespace dealii
               }
           }
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             (c1->subdomain_id() != c2->subdomain_id()))
           return false;
 
@@ -94,7 +94,7 @@ namespace dealii
         if (c1->manifold_id() != c2->manifold_id())
           return false;
 
-        if (c1->active() && c2->active())
+        if (c1->is_active() && c2->is_active())
           if (c1->active_cell_index() != c2->active_cell_index())
             return false;
 
index 239f4d95fe2aa365bb8e942509662d417c004332..fbda19ba3057e40137e5a083b259fe9bdfa061fb 100644 (file)
@@ -77,7 +77,7 @@ namespace dealii
               }
           }
 
-        if (c1->active() && c2->active() &&
+        if (c1->is_active() && c2->is_active() &&
             (c1->subdomain_id() != c2->subdomain_id()))
           return false;
 
@@ -96,7 +96,7 @@ namespace dealii
         if (c1->manifold_id() != c2->manifold_id())
           return false;
 
-        if (c1->active() && c2->active())
+        if (c1->is_active() && c2->is_active())
           if (c1->active_cell_index() != c2->active_cell_index())
             return false;
 
index 05549406a63c6e8869ab588882724e6d908c6da4..8e392586fde43166576d184492c02d0bf0762b4e 100644 (file)
@@ -55,7 +55,7 @@ mypartition(parallel::shared::Triangulation<dim> &tria)
                                                                        lvl);
       for (; cell != endc; ++cell)
         {
-          if (cell->active())
+          if (cell->is_active())
             cell->set_level_subdomain_id(cell->subdomain_id());
           else
             cell->set_level_subdomain_id(cell->child(0)->level_subdomain_id());
index b1f84bee9604ba1c8eb6e9b8a8acd841ec68a66a..c0ec5c07eafb07cd565ca65e2de8a6c0a95911b3 100644 (file)
@@ -263,7 +263,7 @@ namespace LinearAdvectionTest
                       }
                     // If the neighbor is not active, then it is at a higher
                     // refinement level (so we do not need to integrate now)
-                    if (neighbor_cell->active())
+                    if (neighbor_cell->is_active())
                       {
                         if (neighbor_cell->is_locally_owned())
                           {

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.