]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Rename common include files to have suffix .h instead of .h.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 19 Sep 2010 17:26:04 +0000 (17:26 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 19 Sep 2010 17:26:04 +0000 (17:26 +0000)
git-svn-id: https://svn.dealii.org/trunk@22070 0785d39b-7218-0410-832d-ea1e28bc413d

93 files changed:
tests/bits/data_out_01.cc
tests/bits/data_out_02.cc
tests/bits/data_out_03.cc
tests/bits/data_out_04.cc
tests/bits/data_out_05.cc
tests/bits/data_out_common.h [new file with mode: 0644]
tests/bits/data_out_faces_01.cc
tests/bits/data_out_faces_02.cc
tests/bits/data_out_faces_03.cc
tests/bits/data_out_faces_04.cc
tests/bits/data_out_rotation_01.cc
tests/bits/data_out_rotation_02.cc
tests/bits/data_out_rotation_03.cc
tests/bits/data_out_rotation_04.cc
tests/bits/data_out_stack_01.cc
tests/bits/data_out_stack_02.cc
tests/bits/dof_tools_00a.cc
tests/bits/dof_tools_01a.cc
tests/bits/dof_tools_01a_constraints_false.cc
tests/bits/dof_tools_01a_constraints_true.cc
tests/bits/dof_tools_01a_subdomain.cc
tests/bits/dof_tools_01b.cc
tests/bits/dof_tools_01b_x.cc
tests/bits/dof_tools_01c.cc
tests/bits/dof_tools_01d.cc
tests/bits/dof_tools_01d_x.cc
tests/bits/dof_tools_02a.cc
tests/bits/dof_tools_02a_constraints_false.cc
tests/bits/dof_tools_02a_constraints_true.cc
tests/bits/dof_tools_02a_subdomain.cc
tests/bits/dof_tools_02b.cc
tests/bits/dof_tools_02b_x.cc
tests/bits/dof_tools_02c.cc
tests/bits/dof_tools_02d.cc
tests/bits/dof_tools_02d_x.cc
tests/bits/dof_tools_03.cc
tests/bits/dof_tools_04.cc
tests/bits/dof_tools_05.cc
tests/bits/dof_tools_06.cc
tests/bits/dof_tools_07.cc
tests/bits/dof_tools_08.cc
tests/bits/dof_tools_09.cc
tests/bits/dof_tools_10.cc
tests/bits/dof_tools_11.cc
tests/bits/dof_tools_12.cc
tests/bits/dof_tools_13.cc
tests/bits/dof_tools_13a.cc
tests/bits/dof_tools_14.cc
tests/bits/dof_tools_15a.cc
tests/bits/dof_tools_15b.cc
tests/bits/dof_tools_15b_x.cc
tests/bits/dof_tools_15c.cc
tests/bits/dof_tools_15d.cc
tests/bits/dof_tools_15d_x.cc
tests/bits/dof_tools_16a.cc
tests/bits/dof_tools_16b.cc
tests/bits/dof_tools_16b_x.cc
tests/bits/dof_tools_16c.cc
tests/bits/dof_tools_16d.cc
tests/bits/dof_tools_16d_x.cc
tests/bits/dof_tools_17a.cc
tests/bits/dof_tools_17b.cc
tests/bits/dof_tools_17b_x.cc
tests/bits/dof_tools_17c.cc
tests/bits/dof_tools_17d.cc
tests/bits/dof_tools_17d_x.cc
tests/bits/dof_tools_18a.cc
tests/bits/dof_tools_18b.cc
tests/bits/dof_tools_18b_x.cc
tests/bits/dof_tools_18c.cc
tests/bits/dof_tools_18d.cc
tests/bits/dof_tools_18d_x.cc
tests/bits/dof_tools_19.cc
tests/bits/dof_tools_20.cc
tests/bits/dof_tools_common.h [new file with mode: 0644]
tests/bits/fe_tools_02.cc
tests/bits/fe_tools_03.cc
tests/bits/fe_tools_04.cc
tests/bits/fe_tools_05.cc
tests/bits/fe_tools_06.cc
tests/bits/fe_tools_07.cc
tests/bits/fe_tools_08.cc
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/bits/fe_tools_12.cc
tests/bits/fe_tools_13.cc
tests/bits/fe_tools_14.cc
tests/bits/fe_tools_common.h [new file with mode: 0644]
tests/bits/fe_tools_cpfqpm_01.cc
tests/bits/fe_tools_cpfqpm_02.cc
tests/bits/fe_tools_cpfqpm_03.cc
tests/bits/fe_tools_cpfqpm_04.cc

index b37d6943a6f13382b7b17067204efe8697f516f6..980b00b0a76fbcd4e36d8eac45413dd22946bdf0 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out.h>
 
index 8583ecdaaea61cab6cf7fbc6731fc3f3d5fa9f14..24a28461d5a983568df6cda1a1d87bdd709b809e 100644 (file)
@@ -15,7 +15,7 @@
 
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out.h>
 
index 3cd1d92f4925949bf149eca2db85ea654cc1d978..bac21022487bcbb36b5ad71bb4699909669defcf 100644 (file)
@@ -16,7 +16,7 @@
 // make sure that the result is the same
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out.h>
 
index 05ddf24957b5742ea5192752b31c5f0283f1c03c..8b906ddba67ed649fbb0622d27d74fdd35ad949e 100644 (file)
@@ -19,7 +19,7 @@
 // files with vector components in them
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out.h>
 
index 238609cb376a9e864986a7ee4f1dd4481acb7303..f45d7b318f38cffd62b9655d6a72179cd9914a47 100644 (file)
@@ -21,7 +21,7 @@
 // more than one vector field
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out.h>
 
diff --git a/tests/bits/data_out_common.h b/tests/bits/data_out_common.h
new file mode 100644 (file)
index 0000000..de196c0
--- /dev/null
@@ -0,0 +1,162 @@
+//----------------------------  dof_tools_common.cc  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2003, 2004, 2005, 2008, 2010 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_tools_common.cc  ---------------------------
+
+
+// common framework for the various dof_tools_*.cc tests
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <lac/vector.h>
+#include <lac/block_vector.h>
+#include <grid/tria.h>
+#include <grid/tria_iterator.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_accessor.h>
+#include <dofs/dof_handler.h>
+#include <dofs/dof_tools.h>
+#include <fe/fe_q.h>
+#include <fe/fe_dgq.h>
+#include <fe/fe_dgp.h>
+#include <fe/fe_nedelec.h>
+#include <fe/fe_system.h>
+
+#include <fstream>
+#include <iomanip>
+#include <iomanip>
+#include <string>
+
+
+// forward declaration of the function that must be provided in the
+// .cc files
+template <int dim>
+void
+check_this (const DoFHandler<dim> &dof_handler,
+            const Vector<double>  &v_node,
+            const Vector<double>  &v_cell);
+
+// forward declaration of a variable with the name of the output file
+extern std::string output_file_name;
+
+
+// take a vector, and make a block vector out of it
+void
+make_block_vector (const Vector<double> &in,
+                   BlockVector<double>  &out)
+{
+  std::vector<unsigned int> block_sizes(2);
+  block_sizes[0] = in.size() / 2;
+  block_sizes[1] = in.size() - block_sizes[0];
+
+  out.reinit (block_sizes);
+  std::copy (in.begin(), in.end(), out.begin());
+}
+
+
+
+
+template <int dim>
+void
+check (const FiniteElement<dim> &fe,
+       const std::string        &name)
+{
+  deallog << "Checking " << name
+          << " in " << dim << "d:"
+          << std::endl;
+  
+                                   // create tria and dofhandler
+                                   // objects. set different boundary
+                                   // and sub-domain ids
+  Triangulation<dim> tria;
+  GridGenerator::hyper_cube(tria, 0., 1.);
+  tria.refine_global (1);
+  tria.begin_active()->set_refine_flag();
+  tria.execute_coarsening_and_refinement ();
+
+  DoFHandler<dim> dof_handler (tria);
+  dof_handler.distribute_dofs (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());
+  for (unsigned int i=0; i<v_cell.size(); ++i) v_cell(i) = i;
+  
+                                   // call main function in .cc files
+  check_this (dof_handler, v_node, v_cell);
+}
+
+
+
+
+
+#define CHECK(EL,deg,dim)\
+ { FE_ ## EL<dim> EL(deg);   \
+   check(EL, #EL #deg); }
+
+#define CHECK_ALL(EL,deg)\
+ { CHECK(EL,deg,1); \
+   CHECK(EL,deg,2); \
+   CHECK(EL,deg,3); \
+ }
+
+
+int
+main()
+{
+  try
+    {
+      std::ofstream logfile(output_file_name.c_str());
+      deallog << std::setprecision (2);
+      logfile << std::setprecision (2);
+      deallog.attach(logfile);
+      deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+      CHECK_ALL(Q,1);
+      CHECK_ALL(Q,2);
+      CHECK_ALL(Q,3);
+
+      CHECK_ALL(DGQ,0);
+      CHECK_ALL(DGQ,1);
+      CHECK_ALL(DGQ,2);
+
+      CHECK(Nedelec, 0, 2);
+      CHECK(Nedelec, 0, 3);
+  
+      return 0;
+    }
+  catch (std::exception &exc)
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Exception on processing: " << std::endl
+               << exc.what() << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    }
+  catch (...) 
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Unknown exception!" << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    };
+}
+
index 27ba6060d7a6bdfda6bdb2b9e455019e49a98f21..6691e2127a020a397d812796a5fb52ccb40f072f 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  data_out_faces_01.cc  ---------------------------
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_faces.h>
 
@@ -64,7 +64,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index f3dc777b95c68aa032828a6d0aa90cd21b6bd324..b78ed925d77b64f31f694e62d9181350023e9d0c 100644 (file)
@@ -14,7 +14,7 @@
 // same as the the test with number _01, but check for block vectors
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_faces.h>
 
@@ -72,7 +72,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index e3ec61306d42c6cc494f4f1e6bd065f0c90273e7..036ab2324128f1b0675a3675a94f691463921c15 100644 (file)
@@ -16,7 +16,7 @@
 // make sure that the result is the same
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_faces.h>
 
@@ -120,7 +120,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 4b5962bb37b20a2980337ab2016f5e7845fe13b5..162beb1ecea9e91cafe0889b5fe03e2d7291c881 100644 (file)
@@ -19,7 +19,7 @@
 // files with vector components in them
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_faces.h>
 
@@ -162,7 +162,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 17e9a546fffbc087ed9e191e30c44b61bf4d3bb5..4115508f63939e53f61665ea71058ecfd8d68251 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  data_out_rotation_01.cc  ---------------------------
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_rotation.h>
 
@@ -69,7 +69,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 81f1f84c3198e6d136fbac612e9f440975490a67..54a6d041b7d4f7c1ad1af9c5e1d106685ff10f18 100644 (file)
@@ -15,7 +15,7 @@
 
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_rotation.h>
 
@@ -76,7 +76,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index ad335d9241978855f486122b72b11e388605e87b..f587ee0f7867a519bca6e00883ca24791903e214 100644 (file)
@@ -16,7 +16,7 @@
 // make sure that the result is the same
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_rotation.h>
 
@@ -119,7 +119,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index a94b9943990377a2eaff6ee543a1a49b58c3e862..cd104386970c8caae696e3cc7b8aa11cbacd38b8 100644 (file)
@@ -19,7 +19,7 @@
 // files with vector components in them
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_rotation.h>
 
@@ -161,7 +161,7 @@ check_this (const DoFHandler<dim> &dof_handler,
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in data_out_common.cc), we
+                                  // declared in data_out_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index cad49f0d185a1b5b73fd90960bec8bcd2f8819df..2a71158082893735670b9761681561592233711e 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  data_out_stack_01.cc  ---------------------------
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_stack.h>
 
index 82cede56e85294f5b2dee6212335ea18c9e3289c..1c7693cdf57d394a895edd83763d0c2d2dc4da35 100644 (file)
@@ -16,7 +16,7 @@
 // on some it failed linking in the past due to non-existence of weak symbols
 
 #include "../tests.h"
-#include "data_out_common.cc"
+#include "data_out_common.h"
 #include <lac/sparsity_pattern.h>
 #include <numerics/data_out_stack.h>
 
index 3fddcbf8f988340b32b8ecdee01861854389d67a..3998f0eb6c66a275ad9d82cb1c9c01057de99b44 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::
index 3c53ba6d37e0fac226d1be9ffa7a005c37234c4b..483e9206542d0054c608aa19bb204d3faba8fd45 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 34904d00268a59cc9e98523095e9792e701244e9..57e14103252901c44a2bc4d63c10425a12b05ad3 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 5caa2ee45b08281ab9e31129e713bee7f65bacf3..9ab19b342bb39a3516cf367012960175f0ea2c01 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index be9f2f6903c03190826fa9ef638302e118ab1f98..212f57274398206b321df595913d1f54a24e7ad0 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 7221ff2528ab96d0cd0ceace6f67907f11793634..931ebee2c9437abf155d3a90f8ccb0ef54acd27e 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
index 9142ee5fa99bfb3491871e43da2bafab1a307509..9cbc62eae515d42b0945c4404fa7438b7a3c4111 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
index 7a402f7ccd8651968c6d7e9c9bba2b416143d5bb..7442b8ed638443505b2dbb34c976449ab19181bc 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 3a033d0403e0e2d5c9b5eaee909c814377c29bf0..a9bb6237a28618fbad57bf22fa34545e0a23807c 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 9b081241cbf09de3ed3fd240bcc8e1dc3fa89d63..c779ac145c3a4c982eaf61674e43bb6e073af6a7 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 91ccbd80e4814295808e9a767aa74d5cd43ea133..f34c53a967c1a26edf30d2ad259af18b82e791d5 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 50ff01accd19c75840d7efea9fa96cfe1e4b9581..7b4eebcd4a320a01a58564968cb3e436d907312d 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 0f381665a3a23a607ab8beb8f2ec51c88cd94b25..52c848562b9fef54b93bfce606906e51bf6a41c5 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index a42f90815ca098a22c4f293c764303ab0dbe59b1..787f0b2e9fb4a0632bf50bfa0172733de1f04a55 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------------------------------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 1d2e6256e5d1c39d6e3fa410b589314bd285b755..11ee7b4f1af9e69ebc93eb4ede2bbef8ae82c534 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
index 62977e73ff60b6d2adff6e0b19577ba0d325a647..39480d69a06832b986bc6a521005822b1a104814 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
index d1ade8aba73946df6b19f62cf21fdb432be48642..c137e83de89d86d6ffdd2307be34f32acb31c8f5 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 6e3f9a9cf4ab5f1d7782bf9ee1a1ba77851f6f8f..b54403c6d12479bc049c100b1def329773c39193 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 3a70ea79710bb259ceb76fcde90918623862b526..6d5dd931f2a7d0d9f7ca48a47cf08aebc26b8c90 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_2d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 81f225354a76255513b86d7ecae2df736d4be242..288248b76a82e2910a8c97bb6eddb90a4f1bff6f 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_3.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/constraint_matrix.h>
 #include <lac/vector.h>
 
index eb31ed83f0aba17a62cf1ff4da24ca7d723c8fe9..e79752834307a663e913c821aa7c26c04f191953 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_4.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::extract_hanging_node_constraints
index fac861f0684df677af60d0c4fb81d5bf5b0aac22..02d92ebb0864fffead96e0da0560193302ca0449 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_5.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::extract_boundary_dofs
index 38d820304a4809e74e94cc3915e95bac29465f21..24b0ca6df3b6e0cd4611bdd0685ebd39944f71dc 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_6.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::extract_subdomain_dofs
index 8fb3fe421d18da881a69a820a33fd0b3d207f125..0b6392252fc9756e245f676ec9654360abc44a01 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_7.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::count_dofs_per_component
index 1259dd42a6c21d63f543dff61b371cd9a9dd2347..4ae17eb7b4df8dee16e4bd04a3118751abd0d763 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_8.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::map_dof_to_boundary_indices(const DoFHandler<int>     &,
index 53719f470fed85d15284030488feaa1699ed4a73..86d2e01edc8348c43b09ee4c85ecb39c7aec5217 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_9.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::map_dof_to_boundary_indices(const DoFHandler<int>     &,
index 2180d659c97a3d732e14717b374997b8ffef8708..47e036ecc002292d76bed4c0b8a354a9fc326ea6 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_10.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <fe/mapping_q.h>
 
 // check
index 7fbd37c770b10f3a1b63a902058c9685aaf93033..f2f6954b23b83a388f686f43da13848ad10a3be9 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_11.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <fe/mapping_q.h>
 
 // check
index 90f5b7f9c63d8c5d3cba63968c5e2269fc75586f..672cc365eccf244d97c4a5b059b3dca2c1685900 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_12.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::extract_dofs
index 8fab0ea12c186fe04d1aadec7aa77366b52e77f0..14bd8f3e251cf7ef49ad0d6a9c1d36fda01470ea 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_13.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/vector.h>
 
 // check
index 5766db2dcdade9ab1f918011eb2701c14b14e8da..f4abcd45e86aaacef7080b76f09236bb41cb1152 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_13a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/vector.h>
 
 // check
index 4a19f07b182a03b77f9d2373d22f68f0fbdff406..7700ed0bdfd17f25768f21cdaf3a621695de3376 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_14.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/vector.h>
 
 // check
index be950096da0c6b92a3666bbc04515cc1d6ef32d9..589d3c7a0d91d312b705c391e5f8d27b4d172b2b 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index e21d0d3637e05fceaaeac6b6159b2ef486909168..c733555e035b9fbbfe8c666b6a6d975ff59f9226 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
index 853ca2938ec1c92cf6f1d90b14e31815634f57ad..f6c3e6eb41d99eaaa040a78f84886bf1fab8b6ab 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
index 083c0f0df4127421385413c41a73dd694a42f4a1..91d544d72cd7b8df4f63bab0d6e0685593a25444 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index a79aa86b744f594a66cccb235561477b45c090a5..bbea900ad99bcf2d658d5e1f2cf9fa9dda5bbb80 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 1528ccaf0624f7a722b38af53d6c06feb34177d4..39d3dc85afb2f03bb915d1a3ffd6a24b32aa0960 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index a5806df6334bcce1a4fb85e9c557adeabbd50815..be64be888cbad094e24303b964d73b9e8bc370a3 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 20565b23de78ef5191ea33c15b451623363f864e..a88349025755668a86a68613a6504d5650321eb0 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
index 3055534e73924da4944eb94eb1002e5d196e1860..f6bab51993f26bbe91534039902a3f90afb4ad92 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
index 2f80a79e1ee2ae0f28dd1c4e4e4a3318da2ecd7e..0ef2ac4d419b640d55fa735de0a02c0fab80b860 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 3b9d1a49555149b23bce5b22ba1148a0c2c4c55a..f602d0aeab57ceb9601a5513a06f44a73f2257bb 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 14fa01f21b32ec78fd740b0c0dd123a2c3811e94..7637aeb1261acb99dd8a3aa0d0362bb70476bfb0 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index eb4751a91dd5e9f1f1c1a4a4f1599e4229a3be93..b4cdab0e7d2b3c1d96658f95066bdb558339e2f3 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 16f8079254688a8042cd2a534cd3d9d7e995c683..489227131687f1aeba31ebd76d69a55576c10434 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
index 6f637f16583c0e42f479cc993e0ba00347c4184b..e34f6f8d6a8f9651a06c15f43c86867f0ff80ffa 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
index ee04cf45c49f7ed16a6a52c0f725863eb3b67726..11e63c79ee4e0a7761b2bdb283a1191bd10cc6ad 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 42f5821f7d382287faa2852a633ae52350d33c71..5547b979886ffaf86132f6f46f476f6760221afe 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 59b81cd49076c3cb61a90a350785a211074f3ee7..0415c3a11a8d499a32a20a2eb3e88bd6df3cdf16 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
index 9b954d09dad76267eb3526f4a0c197f5f4edb2e0..437188562808a0dea3726ae78b5d3bf3dbcbf12b 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1a.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
@@ -94,7 +94,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 8f62bf955a35cdfe5ff7aba5be19708b86e89ca6..e5126fd95cb02cb13a7eed4eab5db9bf33906144 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_sparsity_pattern.h>
 
 // check
@@ -88,7 +88,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index abe35467eaba61f509e4463e5416f11e736384fb..47a28945d142743fc5e68834af39e0d58090e2ec 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1b.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/compressed_set_sparsity_pattern.h>
 
 // check
@@ -89,7 +89,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 5b10b70c5211261c16cb437df1eac1648ff4d1f9..187e4d3428d0ab3bee2117bff2de02875f0fc698 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1c.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
@@ -123,7 +123,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 5326a5c27b712a8cbfc2da02f93d81c4ed70c44b..b2ca187bad123675d48784ffe6bb9dc1ba5499b3 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
@@ -122,7 +122,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index d19d168422f4b22f2da489ce1dd8c36d16810345..0cf0dd7ad17d9120f573b64ca87791c239f16af0 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_1d.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/block_sparsity_pattern.h>
 
 // check
@@ -122,7 +122,7 @@ check_this (const DoFHandler<dim> &dof_handler)
 {
                                   // since we can't forward declare
                                   // check_this in this file (it is forward
-                                  // declared in dof_tools_common.cc), we
+                                  // declared in dof_tools_common.h), we
                                   // also can't make the driver file aware of
                                   // the overload for 1d. to avoid linker
                                   // errors, we can consequently not overload
index 52b7691ea91e235abb3db8b4f2846e89a3f8cd40..6a4eee1f99a7676afa8da6bb300cb34114b6a1c8 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_19.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 #include <lac/constraint_matrix.h>
 #include <base/function.h>
 #include <base/quadrature_lib.h>
index 4055fd8432bec0883ae90d3123948a987bdd0ee1..ed57b46f9a6616336922046c990f13109e03e3b9 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  dof_tools_5.cc  ---------------------------
 
 #include "../tests.h"
-#include "dof_tools_common.cc"
+#include "dof_tools_common.h"
 
 // check
 //   DoFTools::extract_dofs_with_support_on_boundary
diff --git a/tests/bits/dof_tools_common.h b/tests/bits/dof_tools_common.h
new file mode 100644 (file)
index 0000000..67bb978
--- /dev/null
@@ -0,0 +1,249 @@
+//----------------------------  dof_tools_common.h  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2003, 2004, 2005, 2006, 2008, 2010 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  dof_tools_common.h  ---------------------------
+
+
+// common framework for the various dof_tools_*.cc tests
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <grid/tria.h>
+#include <grid/tria_iterator.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_accessor.h>
+#include <dofs/dof_handler.h>
+#include <dofs/dof_tools.h>
+#include <fe/fe_q.h>
+#include <fe/fe_dgq.h>
+#include <fe/fe_dgp.h>
+#include <fe/fe_nedelec.h>
+#include <fe/fe_raviart_thomas.h>
+#include <fe/fe_system.h>
+
+#include <fstream>
+#include <iomanip>
+#include <iomanip>
+#include <string>
+
+
+// forward declaration of the function that must be provided in the
+// .cc files
+template <int dim>
+void
+check_this (const DoFHandler<dim> &dof_handler);
+
+// forward declaration of a variable with the name of the output file
+extern std::string output_file_name;
+
+
+void
+output_bool_vector (std::vector<bool> &v)
+{
+for (unsigned int i=0; i<v.size(); ++i)
+    deallog << (v[i] ? '1' : '0');
+  deallog << std::endl;
+}
+
+
+
+template <int dim>
+void
+set_boundary_ids (Triangulation<dim> &tria)
+{  
+  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
+    tria.begin_active()->face(f)->set_boundary_indicator (f);
+}
+
+
+void
+set_boundary_ids (Triangulation<1> &)
+{}
+  
+
+
+template <int dim>
+void
+check (const FiniteElement<dim> &fe,
+       const std::string        &name)
+{
+  deallog << "Checking " << name
+          << " in " << dim << "d:"
+          << std::endl;
+  
+                                   // create tria and dofhandler
+                                   // objects. set different boundary
+                                   // and sub-domain ids
+  Triangulation<dim> tria;
+  GridGenerator::hyper_cube(tria, 0., 1.);
+  set_boundary_ids (tria);
+  tria.refine_global (1);
+  for (int i=0; i<2; ++i)
+    {
+      tria.begin_active()->set_refine_flag();
+      tria.execute_coarsening_and_refinement ();
+    }
+  for (typename Triangulation<dim>::active_cell_iterator
+         cell=tria.begin_active();
+       cell!=tria.end(); ++cell)
+    cell->set_subdomain_id (cell->level());
+  DoFHandler<dim> dof_handler (tria);
+  dof_handler.distribute_dofs (fe);
+
+                                   // call main function in .cc files
+  check_this (dof_handler);
+}
+
+
+
+
+
+#define CHECK(EL,deg,dim)\
+ { FE_ ## EL<dim> EL(deg);   \
+   check(EL, #EL #deg); }
+
+#define CHECK_SYS1(sub1,N1,dim) \
+ { FESystem<dim> q(sub1, N1);   \
+   check(q, #sub1 #N1); }
+
+#define CHECK_SYS2(sub1,N1,sub2,N2,dim) \
+ { FESystem<dim> q(sub1, N1, sub2, N2); \
+   check(q, #sub1 #N1 #sub2 #N2); }
+
+#define CHECK_SYS3(sub1,N1,sub2,N2,sub3,N3,dim)   \
+ { FESystem<dim> q(sub1, N1, sub2, N2, sub3, N3); \
+   check(q, #sub1 #N1 #sub2 #N2 #sub3 #N3); }
+
+
+#define CHECK_ALL(EL,deg)\
+ { CHECK(EL,deg,1); \
+   CHECK(EL,deg,2); \
+   CHECK(EL,deg,3); \
+ }
+
+
+int
+main()
+{
+  try
+    {
+      std::ofstream logfile(output_file_name.c_str());
+      logfile << std::setprecision (2);
+      deallog << std::setprecision (2);
+      deallog.attach(logfile);
+      deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+      CHECK_ALL(Q,1);
+      CHECK_ALL(Q,2);
+      CHECK_ALL(Q,3);
+
+      CHECK_ALL(DGQ,0);
+      CHECK_ALL(DGQ,1);
+      CHECK_ALL(DGQ,3);
+
+      CHECK_ALL(DGP,0);
+      CHECK_ALL(DGP,1);
+      CHECK_ALL(DGP,3);
+
+      CHECK(Nedelec, 0, 2);
+      CHECK(Nedelec, 0, 3);
+
+      CHECK(RaviartThomas, 0, 2);
+      CHECK(RaviartThomas, 1, 2);
+      CHECK(RaviartThomas, 2, 2);
+
+      CHECK(RaviartThomasNodal, 0, 2);
+      CHECK(RaviartThomasNodal, 1, 2);
+      CHECK(RaviartThomasNodal, 2, 2);
+      CHECK(RaviartThomasNodal, 0, 3);
+      CHECK(RaviartThomasNodal, 1, 3);
+      CHECK(RaviartThomasNodal, 2, 3);
+      
+      CHECK_SYS1(FE_Q<1>(1),  3,1);
+      CHECK_SYS1(FE_DGQ<1>(2),2,1);
+      CHECK_SYS1(FE_DGP<1>(3),1,1);
+
+      CHECK_SYS1(FE_Q<2>(1),  3,2);
+      CHECK_SYS1(FE_DGQ<2>(2),2,2);
+      CHECK_SYS1(FE_DGP<2>(3),1,2);
+
+      CHECK_SYS1(FE_Q<3>(1),  3,3);
+      CHECK_SYS1(FE_DGQ<3>(2),2,3);
+      CHECK_SYS1(FE_DGP<3>(3),1,3);
+
+
+      CHECK_SYS2(FE_Q<1>(1),  3,FE_DGQ<1>(2),2,1);
+      CHECK_SYS2(FE_DGQ<1>(2),2,FE_DGP<1>(3),1,1);
+      CHECK_SYS2(FE_DGP<1>(3),1,FE_DGQ<1>(2),2,1);
+
+      CHECK_SYS2(FE_Q<2>(1),  3,FE_DGQ<2>(2),2,2);
+      CHECK_SYS2(FE_DGQ<2>(2),2,FE_DGP<2>(3),1,2);
+      CHECK_SYS2(FE_DGP<2>(3),1,FE_DGQ<2>(2),2,2);
+
+      CHECK_SYS3(FE_Q<1>(1),  3,FE_DGP<1>(3),1,FE_Q<1>(1),3,1);
+      CHECK_SYS3(FE_DGQ<1>(2),2,FE_DGQ<1>(2),2,FE_Q<1>(3),3,1);
+      CHECK_SYS3(FE_DGP<1>(3),1,FE_DGP<1>(3),1,FE_Q<1>(2),3,1);
+
+      CHECK_SYS3(FE_Q<2>(1),  3,FE_DGP<2>(3),1,FE_Q<2>(1),3,2);
+      CHECK_SYS3(FE_DGQ<2>(2),2,FE_DGQ<2>(2),2,FE_Q<2>(3),3,2);
+      CHECK_SYS3(FE_DGP<2>(3),1,FE_DGP<2>(3),1,FE_Q<2>(2),3,2);
+
+      CHECK_SYS3(FE_DGQ<3>(1),  3,FE_DGP<3>(3),1,FE_Q<3>(1),3,3);
+
+                                       // systems of systems  
+      CHECK_SYS3((FESystem<2>(FE_Q<2>(1),3)), 3,
+                 FE_DGQ<2>(0), 1,
+                 FE_Q<2>(1), 3,
+                 2);
+      CHECK_SYS3(FE_DGQ<2>(3), 1,
+                 FESystem<2>(FE_DGQ<2>(0),3), 1,
+                 FESystem<2>(FE_Q<2>(2),1,
+                             FE_DGQ<2>(0),1),2,
+                 2);
+
+                                       // systems with Nedelec elements
+      CHECK_SYS2 (FE_DGQ<2>(3), 1,
+                  FE_Nedelec<2>(0), 2,
+                  2);
+      CHECK_SYS3(FE_Nedelec<2>(0), 1,
+                 FESystem<2>(FE_DGQ<2>(1),2), 1,
+                 FESystem<2>(FE_Q<2>(2),1,
+                             FE_Nedelec<2>(0),2),2,
+                 2);
+  
+      return 0;
+    }
+  catch (std::exception &exc)
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Exception on processing: " << std::endl
+               << exc.what() << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    }
+  catch (...) 
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Unknown exception!" << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    };
+}
+
index 5498ae3637b3ddbb00010db2b80cb9e77a8c9243..7e80451edd81a023b57391cac166e70a88b8feb3 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_02.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 625d2c1f2c56ea51f6bb0e2ab75ecfb61eb36acc..f9ccb76383ec0230ec02e650fa46ebd9dfd6df90 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_03.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index a39af2b25d967b8bdad1f2c895836b22381df498..04c70bb81f7dffcdc311d156ba0fc1890774f379 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_04.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 2a2c7664de5dab9962654d7a290fd908b281e642..df55e197f0ec7490cde96f075cf4205b8f1da898 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_05.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index fd6a978c34e7aa6f82c4578591aa6cd5162a0478..66c43c464fea7c4d82678dd9c77393a4e4b5fa31 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_06.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 11df65e009e7c4d9cb74caa77621f271f3f1f439..c8fad0dde82145508beea446c71643991f8504b9 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_07.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index b7c6a548dc207b5da0c3eac75a66ff748adf4535..0d80ff8badd37a405c27026aa44c1499f65e97ee 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_08.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 8ccb53927993adb65c769f3a8b0c32f2fe3ae462..772e4230a87ee4699b6c737479cfbe10726680ab 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_09.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index 1a30242177be638b53663153f25260bfc31dd482..1fb6ee972285cd75db687770f009edb4d15db941 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_10.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index c3e7f093b6f989564af42bcb8b80aad0ed4be293..f77f62889e77dc0cb2856a9cf64bbc712afd783a 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_11.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <lac/sparsity_pattern.h>
 
 // check
index e586103d2968a4ab590bd86cef75159fd2ae85e1..0cbc2f1559f38535b87934371712c86a3afe9d02 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_12.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 
 // check
 //   FETools::get_projection_matrix
index ef711335f9904ccc2cc260cde8c4817c522f2746..5d401922a2e6260431cea78ac806d6a1436dc17c 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_13.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 
 // check
 //   FE::face_to_equivalent_cell_index
index 24fab8adb567b620e9ebc52f15e75ee4eb0a1476..7cfbca70d5530aea71233e681b294288c1f11a63 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_14.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 
 // check
 //   FE::hp_constraints_are_implemented ()
diff --git a/tests/bits/fe_tools_common.h b/tests/bits/fe_tools_common.h
new file mode 100644 (file)
index 0000000..8624d1c
--- /dev/null
@@ -0,0 +1,318 @@
+//----------------------------  fe_tools_common.h  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2010 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  fe_tools_common.h  ---------------------------
+
+
+// common framework for the various fe_tools_*.cc tests
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <grid/tria.h>
+#include <grid/tria_iterator.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_accessor.h>
+#include <dofs/dof_handler.h>
+#include <dofs/dof_tools.h>
+#include <lac/constraint_matrix.h>
+#include <lac/vector.h>
+#include <fe/fe_q.h>
+#include <fe/fe_dgq.h>
+#include <fe/fe_dgp.h>
+#include <fe/fe_nedelec.h>
+#include <fe/fe_system.h>
+#include <fe/fe_tools.h>
+
+#include <fstream>
+#include <iomanip>
+#include <iomanip>
+#include <string>
+#include <memory>
+
+
+// forward declaration of the function that must be provided in the
+// .cc files
+template <int dim>
+void
+check_this (const FiniteElement<dim> &fe1,
+            const FiniteElement<dim> &fe2);
+
+// forward declaration of a variable with the name of the output file
+extern std::string output_file_name;
+
+  
+
+// output some indicators for a given matrix. we don't write out the
+// entire matrix since this would blow up our output files beyond
+// reasonable limits
+void
+output_matrix (const FullMatrix<double> &m)
+{
+  if ((m.m() == 0) || (m.n() == 0))
+    {
+      deallog << "(Empty matrix)" << std::endl;
+      return;
+    }
+  
+  deallog << m.l1_norm() << ' ' << m.linfty_norm()
+          << std::endl;
+  if (m.m() == m.n())
+    deallog << m.frobenius_norm() << std::endl;
+  
+  for (unsigned int i=0; i<std::min(m.m(),m.n()); ++i)
+    deallog << m(i,i) << ' ' << m(i,std::min(m.m(),m.n())-i-1) << ' ';
+  deallog << std::endl;
+}
+
+
+// output some indicators for a given vector
+template <class VECTOR>
+void
+output_vector (const VECTOR &v)
+{
+  deallog << v.l1_norm() << ' ' << v.l2_norm() << ' ' << v.linfty_norm()
+          << std::endl;
+
+                                   // write out at most 20 equispaced
+                                   // elements of the vector
+  for (unsigned int i=0; i<v.size(); i+=std::max(1U,v.size()/20))
+    deallog << v(i) << ' ';
+  deallog << std::endl;
+}
+
+
+
+
+template <int dim>
+Triangulation<dim> * make_tria ()
+{
+  Triangulation<dim> *tria = new Triangulation<dim>();
+  GridGenerator::hyper_cube(*tria, 0., 1.);
+  tria->refine_global (1);
+  for (int i=0; i<2; ++i)
+    {
+      tria->begin_active()->set_refine_flag();
+      tria->execute_coarsening_and_refinement ();
+    }
+  return tria;
+}
+
+
+
+template <int dim>
+DoFHandler<dim> * make_dof_handler (const Triangulation<dim> &tria,
+                                    const FiniteElement<dim> &fe)
+{
+  DoFHandler<dim> *dof_handler = new DoFHandler<dim>(tria);
+  dof_handler->distribute_dofs (fe);
+  return dof_handler;
+}
+
+
+
+template <int dim>
+void
+check (const FiniteElement<dim> &fe1,
+       const FiniteElement<dim> &fe2,
+       const std::string        &name)
+{
+  deallog << "Checking " << name
+          << " in " << dim << "d:"
+          << std::endl;
+  
+                                   // call main function in .cc files
+  check_this (fe1, fe2);
+}
+
+
+
+
+
+#define CHECK(EL1,deg1,EL2,deg2,dim)\
+ { FE_ ## EL1<dim> fe1(deg1);   \
+   FE_ ## EL2<dim> fe2(deg2);   \
+   check(fe1, fe2, #EL1 #deg1 " against " #EL2 #deg2); \
+   check(fe2, fe1, #EL2 #deg2 " against " #EL1 #deg1); \
+ }
+
+#define CHECK_SYS1(sub1_1,N1_1,sub2_1,N2_1,dim) \
+ { FESystem<dim> fe1(sub1_1, N1_1);   \
+   FESystem<dim> fe2(sub2_1, N2_1);   \
+   check(fe1, fe2, #sub1_1 #N1_1 " against " #sub2_1 #N2_1); \
+   check(fe2, fe1, #sub2_1 #N2_1 " against " #sub1_1 #N1_1); \
+ }
+
+/*
+#define CHECK_SYS2(sub1,N1,sub2,N2,dim) \
+ { FESystem<dim> q(sub1, N1, sub2, N2); \
+   check(q, #sub1 #N1 #sub2 #N2); }
+
+#define CHECK_SYS3(sub1,N1,sub2,N2,sub3,N3,dim)   \
+ { FESystem<dim> q(sub1, N1, sub2, N2, sub3, N3); \
+   check(q, #sub1 #N1 #sub2 #N2 #sub3 #N3); }
+
+*/
+#define CHECK_ALL(EL1,deg1,EL2,deg2)\
+ { CHECK(EL1,deg1,EL2,deg2,1); \
+   CHECK(EL1,deg1,EL2,deg2,2); \
+   CHECK(EL1,deg1,EL2,deg2,3); \
+ }
+
+
+int
+main()
+{
+  try
+    {
+      std::ofstream logfile(output_file_name.c_str());
+      deallog << std::setprecision (2);
+      deallog.attach(logfile);
+      deallog.depth_console(0);
+      deallog.threshold_double(1.e-10);
+
+      CHECK_ALL(Q,1,Q,1);
+      CHECK_ALL(Q,1,Q,2);
+      CHECK_ALL(Q,1,Q,3);
+      CHECK_ALL(Q,2,Q,2);
+      CHECK_ALL(Q,2,Q,3);
+      CHECK_ALL(Q,3,Q,3);
+
+      CHECK_ALL(DGQ,0,DGQ,0);
+      CHECK_ALL(DGQ,0,DGQ,1);
+      CHECK_ALL(DGQ,0,DGQ,2);
+      CHECK_ALL(DGQ,0,DGQ,4);
+      CHECK_ALL(DGQ,1,DGQ,1);
+      CHECK_ALL(DGQ,1,DGQ,3);
+      CHECK_ALL(DGQ,2,DGQ,2);
+      CHECK_ALL(DGQ,2,DGQ,2);
+      CHECK_ALL(DGQ,2,DGQ,4);
+      CHECK_ALL(DGQ,3,DGQ,3);
+
+      CHECK_ALL(DGP,0,DGP,0);
+      CHECK_ALL(DGP,0,DGP,1);
+      CHECK_ALL(DGP,0,DGP,2);
+      CHECK_ALL(DGP,0,DGP,4);
+      CHECK_ALL(DGP,1,DGP,1);
+      CHECK_ALL(DGP,1,DGP,3);
+      CHECK_ALL(DGP,2,DGP,2);
+      CHECK_ALL(DGP,2,DGP,2);
+      CHECK_ALL(DGP,2,DGP,4);
+      CHECK_ALL(DGP,3,DGP,3);
+      
+      CHECK(Nedelec, 0, Nedelec, 0, 2);
+      CHECK(Nedelec, 0, Nedelec, 0, 3);
+  
+
+      CHECK_SYS1(FE_Q<1>(1),  3,
+                 FE_Q<1>(2),  3,
+                 1);
+      CHECK_SYS1(FE_DGQ<1>(2),2,
+                 FE_DGQ<1>(3),2,
+                 1);
+      CHECK_SYS1(FE_DGP<1>(3),1,
+                 FE_DGP<1>(1),1,
+                 1);
+
+      CHECK_SYS1(FE_Q<2>(1),  3,
+                 FE_Q<2>(2),  3,
+                 2);
+      CHECK_SYS1(FE_DGQ<2>(2),2,
+                 FE_DGQ<2>(3),2,
+                 2);
+      CHECK_SYS1(FE_DGP<2>(3),1,
+                 FE_DGP<2>(1),1,
+                 2);
+
+      CHECK_SYS1(FE_Q<3>(1),  3,
+                 FE_Q<3>(2),  3,
+                 3);
+      CHECK_SYS1(FE_DGQ<3>(2),2,
+                 FE_DGQ<3>(3),2,
+                 3);
+      CHECK_SYS1(FE_DGP<3>(3),1,
+                 FE_DGP<3>(1),1,
+                 3);
+
+
+/*
+      CHECK_SYS2(FE_Q<1>(1),  3,FE_DGQ<1>(2),2,1);
+      CHECK_SYS2(FE_DGQ<1>(2),2,FE_DGP<1>(3),1,1);
+      CHECK_SYS2(FE_DGP<1>(3),1,FE_DGQ<1>(2),2,1);
+
+      CHECK_SYS2(FE_Q<2>(1),  3,FE_DGQ<2>(2),2,2);
+      CHECK_SYS2(FE_DGQ<2>(2),2,FE_DGP<2>(3),1,2);
+      CHECK_SYS2(FE_DGP<2>(3),1,FE_DGQ<2>(2),2,2);
+
+      CHECK_SYS2(FE_Q<3>(1)  ,3,FE_DGQ<3>(2),2,3);
+      CHECK_SYS2(FE_DGQ<3>(2),2,FE_DGP<3>(3),1,3);
+      CHECK_SYS2(FE_DGP<3>(3),1,FE_DGQ<3>(2),2,3);
+
+
+      CHECK_SYS3(FE_Q<1>(1),  3,FE_DGP<1>(3),1,FE_Q<1>(1),3,1);
+      CHECK_SYS3(FE_DGQ<1>(2),2,FE_DGQ<1>(2),2,FE_Q<1>(3),3,1);
+      CHECK_SYS3(FE_DGP<1>(3),1,FE_DGP<1>(3),1,FE_Q<1>(2),3,1);
+
+      CHECK_SYS3(FE_Q<2>(1),  3,FE_DGP<2>(3),1,FE_Q<2>(1),3,2);
+      CHECK_SYS3(FE_DGQ<2>(2),2,FE_DGQ<2>(2),2,FE_Q<2>(3),3,2);
+      CHECK_SYS3(FE_DGP<2>(3),1,FE_DGP<2>(3),1,FE_Q<2>(2),3,2);
+
+      CHECK_SYS3(FE_Q<3>(1),  3,FE_DGP<3>(3),1,FE_Q<3>(1),3,3);
+      CHECK_SYS3(FE_DGQ<3>(2),2,FE_DGQ<3>(2),2,FE_Q<3>(3),3,3);
+      CHECK_SYS3(FE_DGP<3>(3),1,FE_DGP<3>(3),1,FE_Q<3>(2),3,3);
+
+                                       // systems of systems  
+      CHECK_SYS3((FESystem<2>(FE_Q<2>(1),3)), 3,
+                 FE_DGQ<2>(3), 1,
+                 FE_Q<2>(1), 3,
+                 2);
+      CHECK_SYS3(FE_DGQ<2>(3), 1,
+                 FESystem<2>(FE_DGQ<2>(3),3), 1,
+                 FESystem<2>(FE_Q<2>(2),3,
+                             FE_DGQ<2>(0),1),2,
+                 2);
+
+                                       // systems with Nedelec elements
+      CHECK_SYS2 (FE_DGQ<2>(3), 1,
+                  FE_Nedelec<2>(0), 2,
+                  2);
+      CHECK_SYS3(FE_Nedelec<2>(0), 1,
+                 FESystem<2>(FE_DGQ<2>(3),3), 1,
+                 FESystem<2>(FE_Q<2>(2),3,
+                             FE_Nedelec<2>(0),2),2,
+                 2);
+*/  
+      return 0;
+    }
+  catch (std::exception &exc)
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Exception on processing: " << std::endl
+               << exc.what() << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    }
+  catch (...) 
+    {
+      deallog << std::endl << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      deallog << "Unknown exception!" << std::endl
+               << "Aborting!" << std::endl
+               << "----------------------------------------------------"
+               << std::endl;
+      return 1;
+    };
+}
+
index c667375a551766a269e7e7b1b8f7765e4d02f6f2..2cf444b9c06423db6ca5db84b1f5e2fbf54e085f 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_cpfqpm_01.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <base/quadrature_lib.h>
 
 // check
index 2581691dc4b70ad1e4d504bf887efaf49e89d943..815bc90e6009b6ca5193a84543189615a6ff2e08 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_cpfqpm_02.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <base/quadrature_lib.h>
 
 // check
index 7fcc40cd16d227d1ee025dabe353603c36eca8f6..c8178f98156254a21738f4f5cd9dbe76a067ad7b 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_cpfqpm_03.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <base/quadrature_lib.h>
 
 // check
index 8ed81b5cb93563e443d2cbab1f1b7bc2440a6476..8cbc834e9b1d76478fa5619dcdec239d1f23362c 100644 (file)
@@ -12,7 +12,7 @@
 //----------------------------  fe_tools_cpfqpm_04.cc  ---------------------------
 
 #include "../tests.h"
-#include "fe_tools_common.cc"
+#include "fe_tools_common.h"
 #include <base/quadrature_lib.h>
 
 // check

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.