]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Adjust testsuite.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 10 Dec 2015 15:52:18 +0000 (09:52 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 10 Dec 2015 15:54:21 +0000 (09:54 -0600)
49 files changed:
doc/news/changes.h
tests/bits/data_out_07.cc
tests/bits/data_out_common.h
tests/bits/dof_tools_06.cc
tests/bits/dof_tools_13.cc
tests/bits/dof_tools_13a.cc
tests/bits/dof_tools_19.cc
tests/bits/step-14.cc
tests/codim_one/surface.cc
tests/dofs/accessor_01.cc
tests/dofs/accessor_02.cc
tests/dofs/dof_renumbering.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_renumbering_07.cc
tests/fail/hp-step-14.cc
tests/fail/rt_crash_01.cc
tests/grid/grid_tools_halo_layer_04.cc
tests/grid/grid_tools_halo_layer_05.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/matrix_free/copy.cc
tests/matrix_free/get_functions_common.h
tests/matrix_free/get_functions_gl.cc
tests/matrix_free/get_functions_mappingq.cc
tests/matrix_free/get_functions_q_hierarchical.cc
tests/matrix_free/get_functions_rect.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_common.h
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/no_index_initialize.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/thread_correctness.cc
tests/matrix_free/thread_correctness_hp.cc
tests/matrix_free/update_mapping_only.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/mg_renumbered_01.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_select.cc
tests/trilinos/mg_transfer_prebuilt_01.cc

index 44103108d1a5cdb256aa89f3d770cac66047e8c7..a6215cb6183d20da41272ca729480e24bd224b0c 100644 (file)
@@ -491,12 +491,19 @@ inconvenience this causes.
 
 
 <ol>
-  <li> New: There is now a function Triangulation::get_tria() that
+  <li> New: There is now a function Triangulation::get_triangulation() that
   allows writing code to get at the underlying triangulation for
   everything that looks like a container, i.e., both Triangulation
   or DoFHandler objects.
   <br>
-  (Wolfgang Bangerth, 2015/12/07)
+  (Wolfgang Bangerth, 2015/12/10)
+  </li>
+
+  <li> Deprecated: The functions DoFHandler::get_tria() and
+  hp::DoFHandler::get_tria() were deprecated. UseDoFHandler::get_triangulation() and
+  hp::DoFHandler::get_triangulation() instead.
+  <br>
+  (Wolfgang Bangerth, 2015/12/10)
   </li>
 
   <li> Improved: Many more functions in namespace GridTools and class
index b6f4c85e45befcef4e90e2415d40312189196aa2..b70ca501bd7d9f1a62275c9160b02eaf7e326a88 100644 (file)
@@ -32,7 +32,7 @@ check_this (const DoFHandler<dim> &dof_handler,
             const Vector<double>  &v_cell)
 {
   DataOut<dim> data_out;
-  data_out.attach_triangulation (dof_handler.get_tria());
+  data_out.attach_triangulation (dof_handler.get_triangulation());
   data_out.add_data_vector (v_cell, "cell_data");
   data_out.build_patches ();
 
index a3ad763f09c4adbf279de46f5d161e524a447c13..d0b4d67130c155dc5643be293d254af84cf4f619 100644 (file)
@@ -90,7 +90,7 @@ check (const FiniteElement<dim> &fe,
   Vector<double> v_node (dof_handler.n_dofs());
   for (unsigned int i=0; i<v_node.size(); ++i) v_node(i) = i;
 
-  Vector<double> v_cell (dof_handler.get_tria().n_active_cells());
+  Vector<double> v_cell (dof_handler.get_triangulation().n_active_cells());
   for (unsigned int i=0; i<v_cell.size(); ++i) v_cell(i) = i;
 
   // call main function in .cc files
index 2af25f8879bec7185bfcb017514af2a495309100..081c0e76f3e43764a850dc40c111c67332961cc1 100644 (file)
@@ -30,7 +30,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
   std::vector<bool> dofs(dof_handler.n_dofs());
 
-  for (unsigned int level=0; level<dof_handler.get_tria().n_levels(); ++level)
+  for (unsigned int level=0; level<dof_handler.get_triangulation().n_levels(); ++level)
     {
       DoFTools::extract_subdomain_dofs (dof_handler,
                                         level,
index 489883f0037b94f8ca6b7f605c20c28da97e85aa..58876f4e097dd76318080d248f10490b693c192c 100644 (file)
@@ -35,7 +35,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   if (dof_handler.get_fe().is_primitive() == false)
     return;
 
-  Vector<double> cell_data (dof_handler.get_tria().n_active_cells());
+  Vector<double> cell_data (dof_handler.get_triangulation().n_active_cells());
   for (unsigned int i=0; i<cell_data.size(); ++i)
     cell_data(i) = i;
 
index dc3ab7b127026055e194394f83bedad7f36f90d4..73d2ad1f9eb69981032fe864d3f6e5a9d5c0c38f 100644 (file)
@@ -41,7 +41,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   if (dof_handler.get_fe().is_primitive() == false)
     return;
 
-  Vector<double> cell_data (dof_handler.get_tria().n_active_cells());
+  Vector<double> cell_data (dof_handler.get_triangulation().n_active_cells());
   for (unsigned int i=0; i<cell_data.size(); ++i)
     cell_data(i) = i;
 
index 89ddce35bca1b0887d6e97bda2b8c3fa3b2235d2..507cd9b4346e6dc32cdea26f726f8503f945551d 100644 (file)
@@ -78,7 +78,7 @@ check_this (const DoFHandler<dim> &dof_handler)
   cm.distribute (solution);
 
   // Evaluate error
-  Vector<double> cellwise_errors (dof_handler.get_tria ().n_active_cells());
+  Vector<double> cellwise_errors (dof_handler.get_triangulation ().n_active_cells());
   VectorTools::integrate_difference (dof_handler, solution, test_func,
                                      cellwise_errors, quadrature,
                                      VectorTools::L2_norm);
index 6cfc93d2592bfd95c57d2c1c313b3fe88cc23c79..d8fd7c46a23300042e7d892d7b83f1b1a94d4a88 100644 (file)
@@ -265,7 +265,7 @@ namespace Evaluation
              << ".eps"
              << std::ends;
 
-    GridOut().write_eps (dof_handler.get_tria(),
+    GridOut().write_eps (dof_handler.get_triangulation(),
                          deallog.get_file_stream());
   }
 }
@@ -1682,7 +1682,7 @@ namespace LaplaceSolver
         face_integrals[cell->face(face_no)] = -1e20;
 
     error_indicators.reinit (dual_solver.dof_handler
-                             .get_tria().n_active_cells());
+                             .get_triangulation().n_active_cells());
 
     const unsigned int n_threads = MultithreadInfo::n_threads();
     for (unsigned int i=0; i<n_threads; ++i)
index 66eb1d3b70180e99f7d6d61dfb9b28446b85853a..ab589df19bfc7241021a0ca55eb43885a48fd259 100644 (file)
@@ -90,7 +90,7 @@ void test(std::string filename)
   deallog<<"Approximate measure of hyper sphere = "<<area<<std::endl;
   deallog<<"Error = "<<std::fabs(dim*2*numbers::PI-area)<<std::endl;
   deallog << "Average error in norms: "
-          << ( normals/dof_handler.get_tria().n_active_cells()
+          << ( normals/dof_handler.get_triangulation().n_active_cells()
                /fe_values.n_quadrature_points)
           << std::endl;
 
index a98e07760cded20400825280ced18a52df95db3e..38c7d7ffed58d2c89c95f9c8796c238883a33e59 100644 (file)
@@ -44,7 +44,7 @@ template <typename DoFHandlerType>
 void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2)
 {
   typename DoFHandlerType::active_cell_iterator a = d1.begin_active();
-  typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_tria().n_levels()-1);
+  typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_triangulation().n_levels()-1);
 
   deallog << "a " << a << std::endl
           << "l " << l << std::endl;
index a98e07760cded20400825280ced18a52df95db3e..38c7d7ffed58d2c89c95f9c8796c238883a33e59 100644 (file)
@@ -44,7 +44,7 @@ template <typename DoFHandlerType>
 void test_in_dim(const DoFHandlerType &d1, const DoFHandlerType &d2)
 {
   typename DoFHandlerType::active_cell_iterator a = d1.begin_active();
-  typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_tria().n_levels()-1);
+  typename DoFHandlerType::cell_iterator l = d1.begin(d1.get_triangulation().n_levels()-1);
 
   deallog << "a " << a << std::endl
           << "l " << l << std::endl;
index 6d232b223a574706a7cd6596f4a88cd875ffe12f..0eb632f4a7d51ca746847576825c72699e5309b5 100644 (file)
@@ -116,7 +116,7 @@ check_renumbering(DoFHandler<dim> &mgdof, bool discontinuous)
   print_dofs (dof);
 
   // Check level ordering
-  for (unsigned int level=0; level<dof.get_tria().n_levels(); ++level)
+  for (unsigned int level=0; level<dof.get_triangulation().n_levels(); ++level)
     {
       print_dofs (mgdof, level);
 
index 6887ad3f9d34ec242053c5e53a13e9275f0c31c2..dd848b6b6868ec44ee3775b1b2a5e8502aa7576f 100644 (file)
@@ -123,7 +123,7 @@ check_renumbering(DoFHandler<dim> &mgdof)
   DoFRenumbering::downstream(dof, direction);
   print_dofs (dof);
   // Check level ordering
-  for (unsigned int level=0; level<dof.get_tria().n_levels(); ++level)
+  for (unsigned int level=0; level<dof.get_triangulation().n_levels(); ++level)
     {
       deallog << "Level " << level << std::endl;
       DoFRenumbering::downstream(mgdof, level, direction);
@@ -134,7 +134,7 @@ check_renumbering(DoFHandler<dim> &mgdof)
   DoFRenumbering::downstream(dof, direction, true);
   print_dofs (dof);
   // Check level ordering
-  for (unsigned int level=0; level<dof.get_tria().n_levels(); ++level)
+  for (unsigned int level=0; level<dof.get_triangulation().n_levels(); ++level)
     {
       deallog << "Level " << level << std::endl;
       DoFRenumbering::downstream(mgdof, level, direction, true);
index 5096e464425968cb557f2292a8656dd6e23d1c1e..6247e975be854159133fe1957a815af631da845f 100644 (file)
@@ -78,7 +78,7 @@ check_renumbering(DoFHandler<dim> &dof)
   deallog << element.get_name() << std::endl;
 
   DoFRenumbering::boost::Cuthill_McKee(dof);
-  for (unsigned int level=0; level<dof.get_tria().n_levels(); ++level)
+  for (unsigned int level=0; level<dof.get_triangulation().n_levels(); ++level)
     DoFRenumbering::Cuthill_McKee(dof, level);
   print_dofs (dof);
 }
index 05a808ac453592ae78558e8a1c78bb2f6863467b..9ca8b7ca385aedb103f8545acc41d8dd38b171b9 100644 (file)
@@ -265,7 +265,7 @@ namespace Evaluation
              << ".eps"
              << std::ends;
 
-    GridOut().write_eps (dof_handler.get_tria(),
+    GridOut().write_eps (dof_handler.get_triangulation(),
                          deallog.get_file_stream());
   }
 }
@@ -1682,7 +1682,7 @@ namespace LaplaceSolver
         face_integrals[cell->face(face_no)] = -1e20;
 
     error_indicators.reinit (dual_solver.dof_handler
-                             .get_tria().n_active_cells());
+                             .get_triangulation().n_active_cells());
 
     const unsigned int n_threads = MultithreadInfo::n_threads();
     Threads::ThreadGroup<> threads;
index 62298e8fc314428375430670822d0fea91f11f57..fd03f077a059fdc5c1cbdbc14e1161a6e903bb4a 100644 (file)
@@ -75,7 +75,7 @@ check_this (const DoFHandler<dim> &dof_handler)
             ExcInternalError());
 
   // Evaluate error
-  Vector<double> cellwise_errors (dof_handler.get_tria ().n_active_cells());
+  Vector<double> cellwise_errors (dof_handler.get_triangulation ().n_active_cells());
   VectorTools::integrate_difference (dof_handler, solution, test_func,
                                      cellwise_errors, quadrature,
                                      VectorTools::L2_norm);
index 7c80262942dfd71e9de536b6b98bd7471593aecb..7fdd45ab9fae274b630cdf26a65ffd01b2b5cc38 100644 (file)
@@ -46,7 +46,7 @@ template <int dim>
 void
 write_vtk (const hp::DoFHandler<dim> &dof_handler, const std::string filename)
 {
-  Vector<double> active_fe_index (dof_handler.get_tria().n_active_cells());
+  Vector<double> active_fe_index (dof_handler.get_triangulation().n_active_cells());
   int count = 0;
   typename hp::DoFHandler<dim>::active_cell_iterator
   cell = dof_handler.begin_active(),
index 6d5371d2bfc8ec42580ea355559d99e16d9f81b1..2f24712ee7d5d442bfc2a2786f4e4a5c882dbbe3 100644 (file)
@@ -46,7 +46,7 @@ template <int dim>
 void
 write_vtk (const hp::DoFHandler<dim> &dof_handler, const std::string filename)
 {
-  Vector<double> active_fe_index (dof_handler.get_tria().n_active_cells());
+  Vector<double> active_fe_index (dof_handler.get_triangulation().n_active_cells());
   int count = 0;
   typename hp::DoFHandler<dim>::active_cell_iterator
   cell = dof_handler.begin_active(),
index 5b9bf0beedbd0981ef77b0b2ee22257fbee27808..b176553b937ed03c9d4d135324c7ca7bb07028fb 100644 (file)
@@ -132,7 +132,7 @@ void assemble_mg_matrix(DoFHandler<dim> &dof_handler,
     dof_handler.begin_mg(), dof_handler.end_mg(),
     dof_info, info_box, matrix_integrator, assembler);
 
-  const unsigned int nlevels = dof_handler.get_tria().n_levels();
+  const unsigned int nlevels = dof_handler.get_triangulation().n_levels();
   for (unsigned int level=0; level<nlevels; ++level)
     {
       for (unsigned int i=0; i<dof_handler.n_dofs(level); ++i)
index f00ce6eb041380326384495f8d67e2722c9e254e..f648a168fa4dba8279e450f49ae568aa13fb4b91 100644 (file)
@@ -93,8 +93,8 @@ test_mesh(DoFHandler<dim> &mgdofs)
   BlockVector<double> faces(n_functionals);
   for (unsigned int i=0; i<n_functionals; ++i)
     {
-      cells.block(i).reinit(dofs.get_tria().n_cells());
-      faces.block(i).reinit(dofs.get_tria().n_faces());
+      cells.block(i).reinit(dofs.get_triangulation().n_cells());
+      faces.block(i).reinit(dofs.get_triangulation().n_faces());
     }
   cells.collect_sizes();
   faces.collect_sizes();
index 6af22fcd76e38ec8257c95e1cec426a5b62686d6..d9888d1ddb2db01dc410510652e97e28f3d01cde 100644 (file)
@@ -224,7 +224,7 @@ test_simple(DoFHandler<dim> &mgdofs)
   MGLevelObject<SparseMatrix<double> > mg_matrix_dg_up;
   MGLevelObject<SparseMatrix<double> > mg_matrix_dg_down;
 
-  const unsigned int n_levels = mgdofs.get_tria().n_levels();
+  const unsigned int n_levels = mgdofs.get_triangulation().n_levels();
 
   mg_sparsity.resize(0, n_levels-1);
   mg_sparsity_dg_interface.resize(0, n_levels-1);
index 087c6ed0285323f2c29dde6e0ad6783c02527c6c..77d5bfe5dafd66c31bc52130e86b282dff518872 100644 (file)
@@ -237,7 +237,7 @@ test_simple(DoFHandler<dim> &mgdofs)
   MGLevelObject<SparseMatrix<double> > mg_matrix_dg_up;
   MGLevelObject<SparseMatrix<double> > mg_matrix_dg_down;
 
-  const unsigned int n_levels = mgdofs.get_tria().n_levels();
+  const unsigned int n_levels = mgdofs.get_triangulation().n_levels();
 
   mg_sparsity.resize(0, n_levels-1);
   mg_sparsity_dg_interface.resize(0, n_levels-1);
index 7a2ba0ade8bd33d30bfe79367fb7f27f3dfd1b4c..08ea2d414de06e864c974aecbd07a6506e3c0ed6 100644 (file)
@@ -72,7 +72,7 @@ void sub_test()
                                                 constraints);
       constraints.close();
 
-      //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+      //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
       //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
       //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index bf0aa20f758fab6553dc1b40bd4bd1ca8536c6fc..a2b079eb8167b595436df2e8a371698eb53ce9a8 100644 (file)
@@ -218,7 +218,7 @@ void do_test (const DoFHandler<dim> &dof,
 {
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
   // use this for info on problem
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index e92c41660b004900e212d38403e2f2d91d334dca..33e22457962623aea47437d5af062944a3caf1d6 100644 (file)
@@ -53,7 +53,7 @@ void test ()
   constraints.close();
 
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index b58f01ea660f725d889c471d56a3bc8836018a4c..488ea3cbf21acbcdc11e39d9b0821ae5d924450c 100644 (file)
@@ -54,7 +54,7 @@ void test ()
   // get_functions_common, but here we have to
   // manually choose another mapping
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index 9844e654592f8db23e7d15278eedc22865ead6af..3a8b3c292134ec8e8afb171401c1847857dc2c7c 100644 (file)
@@ -55,7 +55,7 @@ void test ()
   constraints.close();
 
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index 09b0223a8603d5b8bc0ab239274601c3f3370358..d927ae484746529ffb5786b79b5c5fee56f2958a 100644 (file)
@@ -76,7 +76,7 @@ void test ()
   // get_functions_common, but here we have to
   // manually choose non-rectangular tests.
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index b02597741f4a0d021dd7a136ab6e5cea5751a1a9..11efbf386391254e030caff6f0b4d3019c193fca 100644 (file)
@@ -107,7 +107,7 @@ void do_test (const DoFHandler<dim> &dof,
               const ConstraintMatrix &constraints)
 {
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index 86fe0d6d4aa8a6fa200de5e0bd3276d2ce3f7406..811d030f733305aa35225f119e27918012093e41 100644 (file)
@@ -95,7 +95,7 @@ void do_test (const DoFHandler<dim> &dof,
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
   if (parallel_option > 0)
     deallog << "Parallel option: " << parallel_option << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index a375b50478993f73acb203e302e55e0197b0ddfe..daae99c8c69ec4a8a8cdca4286df2991bffc456d 100644 (file)
@@ -96,7 +96,7 @@ void do_test (const DoFHandler<dim>  &dof,
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
   if (parallel_option > 0)
     deallog << "Parallel option: " << parallel_option << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index 31d3678ce6f5bb530591b791c3b1def6841a9dde..f74e6e0c16779bf2d188c361b19b9412a69fb4b5 100644 (file)
@@ -47,7 +47,7 @@ void do_test (const DoFHandler<dim> &dof,
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
   if (parallel_option > 0)
     deallog << "Parallel option: " << parallel_option << std::endl;
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index 7e3261f2db74646a988e2f9c9152324ee96d57ac..f67b85d0f67f8876da186231c998510fe3ea86d7 100644 (file)
@@ -158,7 +158,7 @@ void test ()
   sparsity.copy_from (csp);
   SparseMatrix<double> system_matrix (sparsity);
 
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index 224b0de81229052e26d7d35ca134e553c035d561..683a030cc4d664233c43e4b1782a018eb0134173 100644 (file)
@@ -53,7 +53,7 @@ void test ()
                                             constraints);
   constraints.close ();
 
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
 
   // set up MatrixFree
index a753b01ba7697366ff781eaa649975f1ea164d99..8a5434a73c94edbec78f78a66e528ab988b26b37 100644 (file)
@@ -113,7 +113,7 @@ void do_test (const DoFHandler<dim> &dof,
               const ConstraintMatrix &constraints)
 {
   // use this for info on problem
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
index b45ffcbab914b483641fc1518bb75d08eec0812f..41c13b2e4e4afde15db9cb47ae68401fb1c381c1 100644 (file)
@@ -81,7 +81,7 @@ public:
         endc = dof_handler.end(level);
         for (; cell!=endc; ++cell)
           {
-            if (dof_handler.get_tria().locally_owned_subdomain()!=numbers::invalid_subdomain_id
+            if (dof_handler.get_triangulation().locally_owned_subdomain()!=numbers::invalid_subdomain_id
                 && cell->level_subdomain_id()==numbers::artificial_subdomain_id)
               continue;
             const FiniteElement<dim> &fe = cell->get_fe();
@@ -339,8 +339,8 @@ void do_test (const DoFHandler<dim>  &dof,
   typedef LaplaceOperator<dim,fe_degree,n_q_points_1d,number> LevelMatrixType;
 
   MGLevelObject<LevelMatrixType> mg_matrices;
-  mg_matrices.resize(0, dof.get_tria().n_levels()-1);
-  for (unsigned int level = 0; level<dof.get_tria().n_levels(); ++level)
+  mg_matrices.resize(0, dof.get_triangulation().n_levels()-1);
+  for (unsigned int level = 0; level<dof.get_triangulation().n_levels(); ++level)
     {
       mg_matrices[level].initialize(mapping, dof, dirichlet_boundaries, level);
     }
@@ -356,8 +356,8 @@ void do_test (const DoFHandler<dim>  &dof,
   mg_smoother;
 
   MGLevelObject<typename SMOOTHER::AdditionalData> smoother_data;
-  smoother_data.resize(0, dof.get_tria().n_levels()-1);
-  for (unsigned int level = 0; level<dof.get_tria().n_levels(); ++level)
+  smoother_data.resize(0, dof.get_triangulation().n_levels()-1);
+  for (unsigned int level = 0; level<dof.get_triangulation().n_levels(); ++level)
     {
       smoother_data[level].smoothing_range = 15.;
       smoother_data[level].degree = 5;
index 3c03522e71f03ee44694c42128b5e7495efea40b..4182008864025c22944a4b7a73805142f7aeddf9 100644 (file)
@@ -75,7 +75,7 @@ void sub_test()
                                                 constraints);
       constraints.close();
 
-      //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+      //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
       //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
       //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index fa4f127be614d3e0719041412d22bf007b741584..ff3dd4b98ed5a28cf564711d31059ffab1f63c27 100644 (file)
@@ -135,7 +135,7 @@ void do_test (const unsigned int parallel_option)
                                             constraints);
   constraints.close ();
 
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells() << std::endl;
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells() << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
 
index 3fbeb15f783e895297bfdb0036cb187975c8e556..df67a0a92604e6046b262229239796ebd8b3b652 100644 (file)
@@ -45,7 +45,7 @@ void test ()
 
   deallog << "Testing " << dof.get_fe().get_name() << std::endl;
   // use this for info on problem
-  //std::cout << "Number of cells: " << dof.get_tria().n_active_cells()
+  //std::cout << "Number of cells: " << dof.get_triangulation().n_active_cells()
   //          << std::endl;
   //std::cout << "Number of degrees of freedom: " << dof.n_dofs() << std::endl;
   //std::cout << "Number of constraints: " << constraints.n_constraints() << std::endl;
@@ -64,7 +64,7 @@ void test ()
   constraints.distribute(solution);
 
   FESystem<dim> fe_sys(dof.get_fe(), dim);
-  DoFHandler<dim> dofh_eulerian(dof.get_tria());
+  DoFHandler<dim> dofh_eulerian(dof.get_triangulation());
   dofh_eulerian.distribute_dofs(fe_sys);
 
   MatrixFree<dim,double> mf_data;
index 0c30454be58f0c5d8cfea62565fe223c26689d4b..b16fa4a71f8307bbc3a1ba9b5dcc8dbb5d13a935 100644 (file)
@@ -121,7 +121,7 @@ void initialize (const DoFHandler<dim> &dof,
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
   std::vector<types::global_dof_index> face_indices(dofs_per_face);
 
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       for (typename DoFHandler<dim>::cell_iterator
            cell = dof.begin_mg(l);
@@ -153,7 +153,7 @@ void print (const DoFHandler<dim> &dof,
 {
   const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       deallog << std::endl;
       deallog << "Level " << l << std::endl;
index b7e1cc3ad54baeb9fe1dafdf33a6cccb79349da6..5599c95deb5f558fad1f8530d8b0affb70bcb578 100644 (file)
@@ -121,7 +121,7 @@ void initialize (const DoFHandler<dim> &dof,
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
   std::vector<types::global_dof_index> face_indices(dofs_per_face);
 
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       for (typename DoFHandler<dim>::cell_iterator
            cell = dof.begin_mg(l);
@@ -153,7 +153,7 @@ void print (const DoFHandler<dim> &dof,
 {
   const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       deallog << std::endl;
       deallog << "Level " << l << std::endl;
index c38f23d1409d0d0155f453f63c582e8e56fdab1d..3a9778d4638d17f60c4597f94530a91889758ad4 100644 (file)
@@ -136,7 +136,7 @@ void print(const DoFHandler<dim> &dof, std::vector<std::vector<bool> > &interfac
 {
   const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
   std::vector<unsigned int> dof_indices(dofs_per_cell);
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       deallog << std::endl;
       deallog << "Level " << l << std::endl;
index a72ff876b62fb9d34e581b6b1abd3c15bc977450..ba954a3ad78e78495dd368a2395d508035cd9bd8 100644 (file)
@@ -164,7 +164,7 @@ void print(const DoFHandler<dim> &dof, std::vector<std::vector<bool> > &interfac
 {
   const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       deallog << std::endl;
       deallog << "Level " << l << std::endl;
index 8116482e73729ce166c0f33fd20553f8e5cac234..ec1d21241dbd44247918969d4261dca1eb55376d 100644 (file)
@@ -131,7 +131,7 @@ void print (const DoFHandler<dim> &dof,
 {
   const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
   std::vector<types::global_dof_index> dof_indices(dofs_per_cell);
-  for (unsigned int l=0; l<dof.get_tria().n_levels(); ++l)
+  for (unsigned int l=0; l<dof.get_triangulation().n_levels(); ++l)
     {
       deallog << std::endl;
       deallog << "Level " << l << std::endl;
index 149f85b2d7a7fe25c2bd52f331c0cd2bbed87dc6..36cf2562e80637fd9d97dc73b73d5983284351fc 100644 (file)
@@ -58,7 +58,7 @@ reinit_vector_by_blocks (
   if (ndofs.size() == 0)
     {
       std::vector<std::vector<types::global_dof_index> >
-      new_dofs(mg_dof.get_tria().n_levels(),
+      new_dofs(mg_dof.get_triangulation().n_levels(),
                std::vector<types::global_dof_index>(selected.size()));
       std::swap(ndofs, new_dofs);
       MGTools::count_dofs_per_block (mg_dof, ndofs);
@@ -105,7 +105,7 @@ void check_block(const FiniteElement<dim> &fe,
 
   for (unsigned int l=0; l<tr.n_levels(); ++l)
     DoFRenumbering::component_wise(mgdof, l);
-  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_tria().n_levels(),
+  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_triangulation().n_levels(),
                                                               std::vector<types::global_dof_index>(fe.n_blocks()));
   MGTools::count_dofs_per_block(mgdof, mg_ndofs);
 
index 84567a374b38d9684639f237a2d94327d33d0dba..9c1a02f24e04561a5a766017db5a74be75789df4 100644 (file)
@@ -57,7 +57,7 @@ reinit_vector_by_blocks (
   if (ndofs.size() == 0)
     {
       std::vector<std::vector<types::global_dof_index> >
-      new_dofs(mg_dof.get_tria().n_levels(),
+      new_dofs(mg_dof.get_triangulation().n_levels(),
                std::vector<types::global_dof_index>(selected.size()));
       std::swap(ndofs, new_dofs);
       MGTools::count_dofs_per_block (mg_dof, ndofs);
@@ -91,7 +91,7 @@ void check_select(const FiniteElement<dim> &fe, unsigned int selected)
 
   for (unsigned int l=0; l<tr.n_levels(); ++l)
     DoFRenumbering::component_wise(mgdof, l);
-  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_tria().n_levels(),
+  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_triangulation().n_levels(),
                                                               std::vector<types::global_dof_index>(fe.n_blocks()));
   MGTools::count_dofs_per_block(mgdof, mg_ndofs);
 
index 98dad7ab9cec9bb44be3a4ac7881a527de6a34f3..60d6b8b6f18585d55722c84a57af05e9ef4f4fee 100644 (file)
@@ -60,7 +60,7 @@ reinit_vector_by_blocks (
   if (ndofs.size() == 0)
     {
       std::vector<std::vector<types::global_dof_index> >
-      new_dofs(mg_dof.get_tria().n_levels(),
+      new_dofs(mg_dof.get_triangulation().n_levels(),
                std::vector<types::global_dof_index>(selected.size()));
       std::swap(ndofs, new_dofs);
       MGTools::count_dofs_per_block (mg_dof, ndofs);
@@ -92,7 +92,7 @@ reinit_vector_by_blocks (
   if (ndofs.size() == 0)
     {
       std::vector<std::vector<types::global_dof_index> >
-      new_dofs(mg_dof.get_tria().n_levels(),
+      new_dofs(mg_dof.get_triangulation().n_levels(),
                std::vector<types::global_dof_index>(selected.size()));
       std::swap(ndofs, new_dofs);
       MGTools::count_dofs_per_block (mg_dof, ndofs);
@@ -148,7 +148,7 @@ void check_block(const FiniteElement<dim> &fe)
   // Store sizes
   vector<types::global_dof_index> ndofs(fe.n_blocks());
   DoFTools::count_dofs_per_block(mgdof, ndofs);
-  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_tria().n_levels(),
+  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_triangulation().n_levels(),
                                                               std::vector<types::global_dof_index>(fe.n_blocks()));
   MGTools::count_dofs_per_block(mgdof, mg_ndofs);
 
index 9e373785d44fe802908650305147cb00b1edebe2..fc3586ef3105d8785712a123dcd519411e96be25 100644 (file)
@@ -67,7 +67,7 @@ void check_select(const FiniteElement<dim> &fe,
   for (unsigned int l=0; l<tr.n_levels(); ++l)
     DoFRenumbering::component_wise(mgdof, l, mg_target_component);
 
-  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_tria().n_levels());
+  std::vector<std::vector<types::global_dof_index> > mg_ndofs(mgdof.get_triangulation().n_levels());
   MGTools::count_dofs_per_component(mgdof, mg_ndofs, true, mg_target_component);
 
   deallog << "Global  dofs:";
index 118f0030b384fbab75f7676eb203bf728e4d5cf9..45a152fc1b83c9b4ce142d3a93749764ecb46434 100644 (file)
@@ -45,7 +45,7 @@ reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
 {
   const dealii::parallel::distributed::Triangulation<dim,spacedim> *tria =
     (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
-     (&mg_dof.get_tria()));
+     (&mg_dof.get_triangulation()));
   AssertThrow(tria!=NULL, ExcMessage("multigrid with Trilinos vectors only works with distributed Triangulation!"));
 
   for (unsigned int level=v.min_level();

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.