]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Make compatible with gcc 4.5.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 6 Apr 2010 21:44:13 +0000 (21:44 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 6 Apr 2010 21:44:13 +0000 (21:44 +0000)
git-svn-id: https://svn.dealii.org/trunk@20957 0785d39b-7218-0410-832d-ea1e28bc413d

tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc

index 961656fd998958bbf938dac75f0020c811aa648f..62d7438da8d9e67fdc8ae61003a6dfba08fa29f0 100644 (file)
@@ -49,7 +49,7 @@
 
 #include <fstream>
 #include <sstream>
-#include <boost/bind.hpp>
+#include <base/std_cxx1x/bind.h>
 
 using namespace dealii;
 
@@ -118,9 +118,9 @@ void diff (Vector<double> &diff, const MGDoFHandler<dim> &dof,
     for(unsigned int i=0; i<dofs_per_cell/n_comp; ++i)
     {
       const unsigned int ni = n_comp* i;
-      const unsigned int i0 = mg_dof_indices[ni]; 
-      const unsigned int i1 = mg_dof_indices[ni+1]; 
-      const unsigned int i2 = mg_dof_indices[ni+2]; 
+      const unsigned int i0 = mg_dof_indices[ni];
+      const unsigned int i1 = mg_dof_indices[ni+1];
+      const unsigned int i2 = mg_dof_indices[ni+2];
       diff(i0) = 2*v(i0) - v(i1);
       diff(i1) = 3*v(i1) - 2*v(i2);
       diff(i2) = v(i2) - 3*v(i0);
@@ -164,7 +164,7 @@ void OutputCreator<dim>::cell(
 {
   const FEValuesBase<dim>& fe = info.fe_values();
   const std::vector<std::vector<double> >& uh = info.values[0];
-  
+
   const unsigned int square_root = std::pow(fe.n_quadrature_points, 1./dim)+.5;
   for (unsigned int k1=0; k1<square_root; ++k1)
   {
@@ -180,7 +180,7 @@ void OutputCreator<dim>::cell(
 
 
 template <int dim>
-class LaplaceProblem 
+class LaplaceProblem
 {
   public:
     typedef typename MeshWorker::IntegrationWorker<dim>::CellInfo CellInfo;
@@ -193,7 +193,7 @@ class LaplaceProblem
     void setup_system ();
     void test ();
     void test_boundary ();
-    void output_gpl(const MGDoFHandler<dim> &dof, 
+    void output_gpl(const MGDoFHandler<dim> &dof,
         MGLevelObject<Vector<double> > &v);
     void refine_local ();
 
@@ -245,7 +245,7 @@ void LaplaceProblem<dim>::setup_system ()
 
 template <int dim>
 void
-LaplaceProblem<dim>::output_gpl(const MGDoFHandler<dim> &dof, 
+LaplaceProblem<dim>::output_gpl(const MGDoFHandler<dim> &dof,
     MGLevelObject<Vector<double> > &v)
 {
   MeshWorker::IntegrationWorker<dim> integration_worker;
@@ -306,7 +306,7 @@ void LaplaceProblem<dim>::test ()
   for(unsigned int l=0; l<triangulation.n_levels(); ++l)
   {
     diff(d[l], mg_dof_handler_renumbered, u[l],l);
-    deallog << l << " " << u[l].l2_norm() << '\t' 
+    deallog << l << " " << u[l].l2_norm() << '\t'
       << d[l].l2_norm()<< std::endl;
     for(unsigned int i=0; i<d[l].size(); ++i)
       if(d[l](i)!=0)
index 5e52f86ca6f54ad8b96f66594cc41d86c628c0f3..e159a34c0224b4c92b802a39acacd926da169849 100644 (file)
@@ -47,7 +47,7 @@
 
 #include <fstream>
 #include <sstream>
-#include <boost/bind.hpp>
+#include <base/std_cxx1x/bind.h>
 
 using namespace dealii;
 
@@ -117,9 +117,9 @@ void diff (Vector<double> &diff, const MGDoFHandler<dim> &dof,
     for(unsigned int i=0; i<dofs_per_cell/n_comp; ++i)
     {
       const unsigned int ni = n_comp* i;
-      const unsigned int i0 = mg_dof_indices[ni]; 
-      const unsigned int i1 = mg_dof_indices[ni+1]; 
-      const unsigned int i2 = mg_dof_indices[ni+2]; 
+      const unsigned int i0 = mg_dof_indices[ni];
+      const unsigned int i1 = mg_dof_indices[ni+1];
+      const unsigned int i2 = mg_dof_indices[ni+2];
       diff(i0) = 2*v(i0) - v(i1);
       diff(i1) = 3*v(i1) - 2*v(i2);
       diff(i2) = v(i2) - 3*v(i0);
@@ -182,7 +182,7 @@ void OutputCreator<dim>::cell(
 {
   const FEValuesBase<dim>& fe = info.fe_values();
   const std::vector<std::vector<double> >& uh = info.values[0];
-  
+
   const unsigned int square_root = std::pow(fe.n_quadrature_points, 1./dim)+.5;
   for (unsigned int k1=0; k1<square_root; ++k1)
   {
@@ -198,7 +198,7 @@ void OutputCreator<dim>::cell(
 
 
 template <int dim>
-class LaplaceProblem 
+class LaplaceProblem
 {
   public:
     typedef typename MeshWorker::IntegrationWorker<dim>::CellInfo CellInfo;
@@ -210,7 +210,7 @@ class LaplaceProblem
   private:
     void setup_system ();
     void test ();
-    void output_gpl(const MGDoFHandler<dim> &dof, 
+    void output_gpl(const MGDoFHandler<dim> &dof,
         MGLevelObject<Vector<double> > &v);
     void refine_local ();
 
@@ -271,7 +271,7 @@ void LaplaceProblem<dim>::setup_system ()
 
 template <int dim>
 void
-LaplaceProblem<dim>::output_gpl(const MGDoFHandler<dim> &dof, 
+LaplaceProblem<dim>::output_gpl(const MGDoFHandler<dim> &dof,
     MGLevelObject<Vector<double> > &v)
 {
   MeshWorker::IntegrationWorker<dim> integration_worker;
@@ -341,7 +341,7 @@ void LaplaceProblem<dim>::test ()
   for(unsigned int l=0; l<triangulation.n_levels(); ++l)
   {
     diff(d[l], mg_dof_handler_renumbered, u[l],l);
-    deallog << l << " " << u[l].l2_norm() << '\t' << v[l].l2_norm() << '\t' 
+    deallog << l << " " << u[l].l2_norm() << '\t' << v[l].l2_norm() << '\t'
       << d[l].l2_norm()<< std::endl;
     for(unsigned int i=0; i<d[l].size(); ++i)
       if(d[l](i)!=0)

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.