]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
modifications for gcc 3.1: 1st round
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 26 Jun 2002 12:28:55 +0000 (12:28 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 26 Jun 2002 12:28:55 +0000 (12:28 +0000)
git-svn-id: https://svn.dealii.org/trunk@6190 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
tests/base/Makefile
tests/base/polynomial1d.cc
tests/base/polynomial_test.cc
tests/base/reference.cc
tests/deal.II/derivatives.cc
tests/deal.II/dof_test.cc
tests/deal.II/grid_test.cc
tests/deal.II/wave-test-3.cc
tests/fe/derivatives.cc
tests/fe/fe_tools_test.cc
tests/fe/internals.cc
tests/fe/mapping.cc
tests/fe/mapping_q1_eulerian.cc
tests/fe/performance.cc
tests/fe/shapes.cc
tests/lac/block_vector.cc

index b60f5bcd694a1e4150d35a8263f7f635c436a16e..91ee243a6f56751281c22963ad71831b8bba1029 100644 (file)
@@ -20,14 +20,14 @@ default: run-tests
 
 ############################################################
 
-logtest.exe        : logtest.go            $(lib-base.g)
-polynomial_test.exe: polynomial_test.go    $(lib-base.g)
-polynomial1d.exe   : polynomial1d.go       $(lib-base.g)
-quadrature_test.exe: quadrature_test.go    $(libraries)
-reference.exe      : reference.go abort.go $(libraries)
-tensor.exe         : tensor.go             $(libraries)
-timer.exe          : timer.go              $(libraries)
-vector2d.exe       : vector2d.go           $(libraries)
+logtest.exe        : logtest.go                  $(lib-base.g)
+polynomial_test.exe: polynomial_test.go abort.go $(lib-base.g)
+polynomial1d.exe   : polynomial1d.go             $(lib-base.g)
+quadrature_test.exe: quadrature_test.go          $(libraries)
+reference.exe      : reference.go abort.go       $(libraries)
+tensor.exe         : tensor.go                   $(libraries)
+timer.exe          : timer.go                    $(libraries)
+vector2d.exe       : vector2d.go                 $(libraries)
 auto_derivative_function.exe        : auto_derivative_function.go            $(libraries)
 
 
index 6e00b697c25dbb44871d750675b337c48337fd81..89d864b0b1fa32539fb2b644ec4e41d0faf276f4 100644 (file)
@@ -46,7 +46,7 @@ int main ()
 
   std::vector<Polynomial<double> > p;
 
-  deallog << "Legendre" << endl;
+  deallog << "Legendre" << std::endl;
   
   for (unsigned int i=0;i<15;++i)
     p.push_back (Legendre<double>(i));
@@ -57,7 +57,7 @@ int main ()
              << " =" << scalar_product(p[i], p[j]) << std::endl;
 
 
-  deallog << "LagrangeEquidistant" << endl;
+  deallog << "LagrangeEquidistant" << std::endl;
   
   p.clear();
   for (unsigned int i=0;i<6;++i)
index ca89fec27d503720635cef5a8e4a4582759cd4a8..976c01385a63499178b7d5e5a193c2360f671989 100644 (file)
 #include <base/tensor_product_polynomials.h>
 #include <base/polynomial_space.h>
 
-//using std;
-
-extern "C"
-void abort()
-{}
-
 
 template<int dim, class POLY>
 void check_poly(const Point<dim>& x,
                const POLY& p)
 {
   const unsigned int n = p.n();
-  vector<double> values (n);
-  vector<Tensor<1,dim> > gradients(n);
-  vector<Tensor<2,dim> > second(n);
+  std::vector<double> values (n);
+  std::vector<Tensor<1,dim> > gradients(n);
+  std::vector<Tensor<2,dim> > second(n);
   
   p.compute (x, values, gradients, second);
   
@@ -50,15 +44,15 @@ void check_poly(const Point<dim>& x,
       for (unsigned int d1=0;d1<dim;++d1)
        for (unsigned int d2=0;d2<dim;++d2)
          deallog << second[k][d1][d2] << '\t';
-      deallog << endl;
+      deallog << std::endl;
     }
-  deallog << endl;
+  deallog << std::endl;
 }
 
 
 template <int dim>
 void
-check_tensor (const vector<Polynomial<double> >& v,
+check_tensor (const std::vector<Polynomial<double> >& v,
              const Point<dim>& x)
 {
   deallog.push("Tensor");
@@ -70,7 +64,7 @@ check_tensor (const vector<Polynomial<double> >& v,
 
 template <int dim>
 void
-check_poly (const vector<Polynomial<double> >& v,
+check_poly (const std::vector<Polynomial<double> >& v,
            const Point<dim>& x)
 {
   deallog.push("Polyno");
@@ -81,7 +75,7 @@ check_poly (const vector<Polynomial<double> >& v,
 
 
 void
-check_dimensions (const vector<Polynomial<double> >& p)
+check_dimensions (const std::vector<Polynomial<double> >& p)
 {
   deallog.push("1d");
   check_tensor(p, Point<1>(.5));
@@ -104,7 +98,7 @@ int main()
   deallog.attach(logfile);
   deallog.depth_console(0);
 
-  vector<Polynomial<double> > p;
+  std::vector<Polynomial<double> > p;
   for (unsigned int i=0;i<3;++i)
     p.push_back (LagrangeEquidistant(3, i));
 
index f131b7e798bf8581353f034afe542516a9641a24..a7fc66cf554b2f0220e1e1e7497c881252058839 100644 (file)
@@ -48,7 +48,7 @@ int main()
   std::ofstream logfile("reference.output");
   deallog.attach(logfile);
   deallog.depth_console(0);
-  std::cerr = logfile;
+  std::cerr.rdbuf(logfile.rdbuf());
   Test a("A");
   const Test b("B");
   SmartPointer<Test>       r=&a;
index 30ff96010ccb9cdd1df48f75bb57e0e8189a50d0..c6cfc4f150d9cd2efa6d8ad1b83297192d57606c 100644 (file)
@@ -85,8 +85,8 @@ check (const unsigned int level,
   
   SparseMatrix<double> A(A_pattern);
   
-  DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
-  const DoFHandler<dim>::cell_iterator end = dof.end();
+  typename DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
+  const typename DoFHandler<dim>::cell_iterator end = dof.end();
 
   for (; cell != end;++cell)
     {
index 26a503fd1ce6c06d060d9e176b587e5572d065d0..090bc73fccbaefd49e5a97945009256c2d3e7f48 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -243,7 +243,7 @@ void TestCases<dim>::run (const unsigned int test_case)
        tria->begin_active()->set_refine_flag ();
        tria->execute_coarsening_and_refinement ();
 
-       Triangulation<dim>::active_cell_iterator cell;
+       typename Triangulation<dim>::active_cell_iterator cell;
        for (int i=0; i<(dim==2 ? 3 : 2); ++i) 
          {
                                             // refine the presently
@@ -275,7 +275,7 @@ void TestCases<dim>::run (const unsigned int test_case)
        tria->begin_active()->set_refine_flag();
        tria->execute_coarsening_and_refinement ();
        
-       Triangulation<dim>::active_cell_iterator cell, endc;
+       typename Triangulation<dim>::active_cell_iterator cell, endc;
        for (int i=0; i<4-dim; ++i) 
          {
            cell = tria->begin_active();
index 5934586395bf17c16f6c0543fa89b670721baeba..ac7972e7aff6a8c6aa4bdba760986f2cffc0433e 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -197,7 +197,7 @@ void test (const int test_case)
        tria.begin_active()->set_refine_flag ();
        tria.execute_coarsening_and_refinement ();
 
-       Triangulation<dim>::active_cell_iterator cell;
+       typename Triangulation<dim>::active_cell_iterator cell;
        for (int i=0; i<(dim==2 ? 3 : 2); ++i) 
          {
                                             // refine the presently
@@ -234,7 +234,7 @@ void test (const int test_case)
        tria.begin_active()->set_refine_flag();
        tria.execute_coarsening_and_refinement ();
        
-       Triangulation<dim>::active_cell_iterator cell, endc;
+       typename Triangulation<dim>::active_cell_iterator cell, endc;
        const unsigned int steps[4] = { 0, 2, 2, 2 };
        for (unsigned int i=0; i<steps[dim]; ++i) 
          {
index 6748fb48acc717232ef1814814fd0ff32c82286a..d7118e3b9572acd547dfcee376e5d08b707e2bb7 100644 (file)
@@ -57,7 +57,7 @@ class TimeStepBase_Wave :  public TimeStepBase_Tria<dim>{
   public:
     TimeStepBase_Wave ();
     TimeStepBase_Wave (const double                    time,
-                      TimeStepBase_Tria<dim>::Flags   flags,
+                      typename TimeStepBase_Tria<dim>::Flags   flags,
                       const WaveParameters<dim>      &parameters);
     const TimeStep_Primal<dim> & get_timestep_primal () const;
     const TimeStep_Dual<dim> &   get_timestep_dual () const;
@@ -1888,7 +1888,7 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
   final_u_bar.reinit (dof->n_dofs());
   final_v_bar.reinit (dof->n_dofs());
 
-  DoFHandler<dim>::active_cell_iterator cell, primal_cell, endc;
+  typename DoFHandler<dim>::active_cell_iterator cell, primal_cell, endc;
   cell = dof->begin_active ();
   endc = dof->end ();
   primal_cell = primal_dof->begin_active();
@@ -1970,7 +1970,7 @@ void IntegratedValueAtOrigin<dim>::compute_functionals (Vector<double> &j1,
   j1.reinit (dof->n_dofs());
   j2.reinit (dof->n_dofs());
 
-  DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
+  typename DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
                                        endc = dof->end();
 
   Point<dim> origin;
@@ -2011,8 +2011,8 @@ void SeismicSignal<dim>::compute_functionals (Vector<double> &j1,
   j1.reinit (dof->n_dofs());
   j2.reinit (dof->n_dofs());
 
-  DoFHandler<dim>::active_cell_iterator cell, endc;
-  DoFHandler<dim>::face_iterator        face;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::face_iterator        face;
   cell = dof->begin_active();
   endc = dof->end();
 
@@ -2067,8 +2067,8 @@ void EarthSurface<dim>::compute_functionals (Vector<double> &j1,
   j1.reinit (dof->n_dofs());
   j2.reinit (dof->n_dofs());
 
-  DoFHandler<dim>::active_cell_iterator cell, endc;
-  DoFHandler<dim>::face_iterator        face;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::face_iterator        face;
   cell = dof->begin_active();
   endc = dof->end();
 
@@ -2119,8 +2119,8 @@ void SplitSignal<dim>::compute_functionals (Vector<double> &j1,
   if ((time<=1.6) || (time>1.8))
     return;
   
-  DoFHandler<dim>::active_cell_iterator cell, endc;
-  DoFHandler<dim>::face_iterator        face;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::face_iterator        face;
   cell = dof->begin_active();
   endc = dof->end();
 
@@ -2225,7 +2225,7 @@ void OneBranch1d<dim>::compute_functionals (Vector<double> &j1,
   if ((time<=2.5-time_step) || (time>2.5))
     return;
 
-  DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
   cell = dof->begin_active();
   endc = dof->end();
 
@@ -2267,7 +2267,7 @@ void SecondCrossing<dim>::compute_functionals (Vector<double> &j1,
   if ((time<=2.4-time_step) || (time>2.4))
     return;
 
-  DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
   cell = dof->begin_active();
   endc = dof->end();
 
@@ -2310,14 +2310,14 @@ void HuyghensWave<dim>::compute_functionals (Vector<double> &j1,
   p(0) = 0.75;
   const Point<dim> evaluation_point (p);
 
-  const DoFHandler<dim>::cell_iterator endc = dof->end(3);
+  const typename DoFHandler<dim>::cell_iterator endc = dof->end(3);
   bool point_found = false;
-  for (DoFHandler<dim>::cell_iterator cell=dof->begin(3);
+  for (typename DoFHandler<dim>::cell_iterator cell=dof->begin(3);
        (cell!=endc) && !point_found; ++cell)
     for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex) 
       if (cell->vertex(vertex) == evaluation_point)
        {
-         DoFHandler<dim>::cell_iterator terminal_cell = cell;
+         typename DoFHandler<dim>::cell_iterator terminal_cell = cell;
          while (terminal_cell->has_children())
            terminal_cell = terminal_cell->child(vertex);
          
@@ -2438,7 +2438,7 @@ template <int dim>
 double EvaluateEnergyContent<dim>::compute_energy (const PartOfDomain pod) const {
   const double y_offset = 300000000;
 
-  DoFHandler<dim>::active_cell_iterator cell, endc;
+  typename DoFHandler<dim>::active_cell_iterator cell, endc;
   cell = dof->begin_active ();
   endc = dof->end ();
 
@@ -2535,7 +2535,7 @@ void EvaluateIntegratedValueAtOrigin<dim>::reset () {
 
 template <int dim>
 double EvaluateIntegratedValueAtOrigin<dim>::evaluate () {
-  DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
+  typename DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
                                        endc = dof->end();
 
   double     value_at_origin = 0;
@@ -2603,7 +2603,7 @@ double EvaluateSeismicSignal<dim>::evaluate () {
   std::ofstream out((base_file_name + ".seismic").c_str());
   AssertThrow (out, typename EvaluationBase<dim>::ExcIO());
   
-  DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
+  typename DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
                                        endc = dof->end();
   double u_integrated=0;
   FEFaceValues<dim> face_values (*fe, *quadrature_face,
@@ -2692,7 +2692,7 @@ double EvaluateSplitSignal<dim>::evaluate () {
     return 0;
 
   const unsigned int n_q_points = quadrature_face->n_quadrature_points;
-  DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
+  typename DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
                                        endc = dof->end();
   double u_integrated=0;
   FEFaceValues<dim> face_values (*fe, *quadrature_face, UpdateFlags(update_values | update_JxW_values));
@@ -2702,7 +2702,7 @@ double EvaluateSplitSignal<dim>::evaluate () {
     for (unsigned int face_no=0; face_no<GeometryInfo<dim>::faces_per_cell; ++face_no)
       if (cell->face(face_no)->center()(0) == 1.5)
        {
-         DoFHandler<dim>::face_iterator face=cell->face(face_no);
+         typename DoFHandler<dim>::face_iterator face=cell->face(face_no);
          bool wrong_face = face->center()(1) > 0.0625;
          if (!wrong_face)
            for (unsigned int v=0; v<GeometryInfo<dim>::vertices_per_face; ++v)
@@ -2907,14 +2907,14 @@ double EvaluateHuyghensWave<dim>::evaluate ()
   p(0) = 0.75;
   const Point<dim> evaluation_point (p);
 
-  const DoFHandler<dim>::cell_iterator endc = dof->end(3);
+  const typename DoFHandler<dim>::cell_iterator endc = dof->end(3);
   bool point_found = false;
-  for (DoFHandler<dim>::cell_iterator cell=dof->begin(3);
+  for (typename DoFHandler<dim>::cell_iterator cell=dof->begin(3);
        (cell!=endc) && !point_found; ++cell)
     for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
       if (cell->vertex(vertex) == evaluation_point)
        {
-         DoFHandler<dim>::cell_iterator terminal_cell = cell;
+         typename DoFHandler<dim>::cell_iterator terminal_cell = cell;
          while (terminal_cell->has_children())
            terminal_cell = terminal_cell->child(vertex);
          
@@ -3775,28 +3775,28 @@ void WaveParameters<dim>::set_initial_functions (const std::string &u_name,
   for (unsigned int i=0; i<2; ++i)
     {
       if (names[i]=="eigenmode")
-       functions[i] = new InitialValues<dim>::EigenMode();
+       functions[i] = new typename InitialValues<dim>::EigenMode();
       else
        if (names[i]=="zero")
          functions[i] = new ZeroFunction<dim>();
        else
          if (names[i]=="center-kink")
-           functions[i] = new InitialValues<dim>::CenterKink();
+           functions[i] = new typename InitialValues<dim>::CenterKink();
          else
            if (names[i]=="bump")
-             functions[i] = new InitialValues<dim>::Bump();
+             functions[i] = new typename InitialValues<dim>::Bump();
            else
              if (names[i]=="small bump")
-               functions[i] = new InitialValues<dim>::SmallBump();
+               functions[i] = new typename InitialValues<dim>::SmallBump();
              else
                if (names[i]=="shifted bump")
-                 functions[i] = new InitialValues<dim>::ShiftedBump();
+                 functions[i] = new typename InitialValues<dim>::ShiftedBump();
                else
                  if (names[i]=="plateau")
-                   functions[i] = new InitialValues<dim>::Plateau ();
+                   functions[i] = new typename InitialValues<dim>::Plateau ();
                  else
                    if (names[i]=="earthquake")
-                     functions[i] = new InitialValues<dim>::Earthquake ();
+                     functions[i] = new typename InitialValues<dim>::Earthquake ();
                    else
                      AssertThrow (false, ExcUnknownName(names[i]));
     };
@@ -3816,13 +3816,13 @@ void WaveParameters<dim>::set_coefficient_functions (const std::string &name) {
   
   if (name=="kink")
     {
-      stiffness = new Coefficients<dim>::Kink();
+      stiffness = new typename Coefficients<dim>::Kink();
       stiffness_constant = false;
     }
   else
     if (name=="gradient")
       {
-       stiffness = new Coefficients<dim>::Gradient();
+       stiffness = new typename Coefficients<dim>::Gradient();
        stiffness_constant = false;
       }
     else
@@ -3834,13 +3834,13 @@ void WaveParameters<dim>::set_coefficient_functions (const std::string &name) {
       else
        if (name=="preliminary earth model")
          {
-           stiffness = new Coefficients<dim>::PreliminaryEarthModel();
+           stiffness = new typename Coefficients<dim>::PreliminaryEarthModel();
            stiffness_constant = false;
          }
        else
          if (name=="distorted")
            {
-             stiffness = new Coefficients<dim>::Distorted();
+             stiffness = new typename Coefficients<dim>::Distorted();
              stiffness_constant = false;
          }
          else
@@ -3855,26 +3855,26 @@ void WaveParameters<dim>::set_boundary_functions (const std::string &name) {
   
   if (name=="wave from left") 
     {
-      boundary_values_u = new BoundaryValues<dim>::WaveFromLeft_u ();
-      boundary_values_v = new BoundaryValues<dim>::WaveFromLeft_v ();
+      boundary_values_u = new typename BoundaryValues<dim>::WaveFromLeft_u ();
+      boundary_values_v = new typename BoundaryValues<dim>::WaveFromLeft_v ();
     }
   else
     if (name=="fast wave from left") 
       {
-       boundary_values_u = new BoundaryValues<dim>::FastWaveFromLeft_u ();
-       boundary_values_v = new BoundaryValues<dim>::FastWaveFromLeft_v ();
+       boundary_values_u = new typename BoundaryValues<dim>::FastWaveFromLeft_u ();
+       boundary_values_v = new typename BoundaryValues<dim>::FastWaveFromLeft_v ();
       }
     else
       if (name=="wave from left center")
        {
-         boundary_values_u = new BoundaryValues<dim>::WaveFromLeftCenter_u ();
-         boundary_values_v = new BoundaryValues<dim>::WaveFromLeftCenter_v ();
+         boundary_values_u = new typename BoundaryValues<dim>::WaveFromLeftCenter_u ();
+         boundary_values_v = new typename BoundaryValues<dim>::WaveFromLeftCenter_v ();
        }
       else
        if (name=="wave from left bottom")
          {
-           boundary_values_u = new BoundaryValues<dim>::WaveFromLeftBottom_u ();
-           boundary_values_v = new BoundaryValues<dim>::WaveFromLeftBottom_v ();
+           boundary_values_u = new typename BoundaryValues<dim>::WaveFromLeftBottom_u ();
+           boundary_values_v = new typename BoundaryValues<dim>::WaveFromLeftBottom_v ();
          }
        else
          if (name=="zero")
@@ -3943,7 +3943,7 @@ void WaveParameters<dim>::set_dual_functional (const std::string &name) {
       dual_functional = new IntegratedValueAtOrigin<dim> ();
     else
       if (name == "seismic signature")
-       dual_functional = new SeismicSignal<dim> ();
+       dual_functional = new  SeismicSignal<dim> ();
       else
        if (name == "split signal")
          dual_functional = new SplitSignal<dim> ();
@@ -4003,7 +4003,7 @@ void WaveParameters<1>::make_coarse_grid (const std::string &name) {
                                           cells,
                                           SubCellData());
 
-       Triangulation<dim>::active_cell_iterator cell = coarse_grid->begin_active();
+       typename Triangulation<dim>::active_cell_iterator cell = coarse_grid->begin_active();
        (++cell)->set_refine_flag ();
        (++cell)->set_refine_flag ();
        coarse_grid->execute_coarsening_and_refinement ();
@@ -4694,7 +4694,7 @@ TimeStepBase_Wave<dim>::TimeStepBase_Wave ():
 
 template <int dim>
 TimeStepBase_Wave<dim>::TimeStepBase_Wave (const double                    time,
-                                          TimeStepBase_Tria<dim>::Flags   flags,
+                                          typename TimeStepBase_Tria<dim>::Flags   flags,
                                           const WaveParameters<dim>      &parameters)
                :
                TimeStepBase_Tria<dim> (time,
@@ -4711,7 +4711,7 @@ TimeStepBase_Wave<dim>::TimeStepBase_Wave (const double                    time,
                                         (parameters.refinement_strategy ==
                                          WaveParameters<dim>::dual_estimator),
                                         true)),
-               parameters (parameters)
+                                           parameters (parameters)
 {};
 
 
@@ -5054,10 +5054,10 @@ void TimeStep_Wave<dim>::transfer_old_solutions (Vector<double> &old_u,
   
   Assert (old_dof_handler != 0, ExcInternalError());
 
-  DoFHandler<dim>::cell_iterator old_cell = old_dof_handler->begin(),
+  typename DoFHandler<dim>::cell_iterator old_cell = old_dof_handler->begin(),
                                 new_cell = present_dof_handler->begin();
   for (; old_cell != (old_dof_handler->get_tria().n_levels() == 1  ?
-                     static_cast<DoFHandler<dim>::cell_iterator>(old_dof_handler->end()) :
+                     static_cast<typename DoFHandler<dim>::cell_iterator>(old_dof_handler->end()) :
                      old_dof_handler->begin(1));
        ++old_cell, new_cell)
     transfer_old_solutions (old_cell, new_cell,
@@ -5402,7 +5402,7 @@ void TimeStep_Dual<dim>::build_rhs (Vector<double> &right_hand_side1,
   Assert (previous_time_level.tria->n_cells(0) == tria->n_cells(0),
          typename TimeStep_Wave<dim>::ExcCoarsestGridsDiffer());
 
-  typedef DoFHandler<dim>::cell_iterator cell_iterator;
+  typedef typename DoFHandler<dim>::cell_iterator cell_iterator;
 
   FEValues<dim> fe_values (fe, quadrature,
                           UpdateFlags(update_values |
@@ -5425,12 +5425,13 @@ cell_iterator old_cell = previous_time_level.dof_handler->begin(),
 
 template <int dim>
 void
-TimeStep_Dual<dim>::build_rhs (const DoFHandler<dim>::cell_iterator &old_cell,
-                              const DoFHandler<dim>::cell_iterator &new_cell,
+TimeStep_Dual<dim>::build_rhs (const typename DoFHandler<dim>::cell_iterator &old_cell,
+                              const typename DoFHandler<dim>::cell_iterator &new_cell,
                               FEValues<dim>        &fe_values,
                               Vector<double>       &right_hand_side1,
-                              Vector<double>       &right_hand_side2) {
-  typedef DoFHandler<dim>::cell_iterator cell_iterator;
+                              Vector<double>       &right_hand_side2)
+{
+  typedef typename DoFHandler<dim>::cell_iterator cell_iterator;
 
   if (old_cell->has_children() && new_cell->has_children()) 
     {
@@ -5554,7 +5555,7 @@ TimeStep_Dual<dim>::build_rhs (const DoFHandler<dim>::cell_iterator &old_cell,
 
 template <int dim>
 unsigned int
-TimeStep_Dual<dim>::collect_from_children (const DoFHandler<dim>::cell_iterator &old_cell,
+TimeStep_Dual<dim>::collect_from_children (const typename DoFHandler<dim>::cell_iterator &old_cell,
                                           FEValues<dim>  &fe_values,
                                           Vector<double> &rhs1,
                                           Vector<double> &rhs2) const {
@@ -5580,7 +5581,7 @@ TimeStep_Dual<dim>::collect_from_children (const DoFHandler<dim>::cell_iterator
       
   for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c) 
     {
-      const DoFHandler<dim>::cell_iterator old_child = old_cell->child(c);
+      const typename DoFHandler<dim>::cell_iterator old_child = old_cell->child(c);
 
       child_rhs1.clear ();
       child_rhs2.clear ();
@@ -5647,7 +5648,7 @@ TimeStep_Dual<dim>::collect_from_children (const DoFHandler<dim>::cell_iterator
 
 template <int dim>
 unsigned int
-TimeStep_Dual<dim>::distribute_to_children (const DoFHandler<dim>::cell_iterator &new_cell,
+TimeStep_Dual<dim>::distribute_to_children (const typename DoFHandler<dim>::cell_iterator &new_cell,
                                            FEValues<dim>         &fe_values,
                                            const Vector<double>  &old_dof_values_u,
                                            const Vector<double>  &old_dof_values_v,
@@ -5675,7 +5676,7 @@ TimeStep_Dual<dim>::distribute_to_children (const DoFHandler<dim>::cell_iterator
 
   for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c) 
     {
-      const DoFHandler<dim>::cell_iterator new_child = new_cell->child(c);
+      const typename DoFHandler<dim>::cell_iterator new_child = new_cell->child(c);
 
       fe.prolongate(c).vmult (local_old_dof_values_u,
                                   old_dof_values_u);
@@ -5907,9 +5908,9 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_dual () {
 
   if (true)
     {
-      DoFHandler<dim>::active_cell_iterator
+      typename DoFHandler<dim>::active_cell_iterator
        cell = primal_problem.dof_handler->begin_active();
-      const DoFHandler<dim>::active_cell_iterator
+      const typename DoFHandler<dim>::active_cell_iterator
        endc = primal_problem.dof_handler->end();
       for (; cell!=endc; ++cell)
        cell->clear_user_pointer();
@@ -5927,12 +5928,12 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_dual () {
                                           update_JxW_values |
                                           update_q_points));
 
-      DoFHandler<dim>::cell_iterator
+      typename DoFHandler<dim>::cell_iterator
        primal_cell     = primal_problem.dof_handler->begin(),
        dual_cell       = dual_problem.dof_handler->begin(),
        primal_cell_old = primal_problem_old.dof_handler->begin(),
        dual_cell_old   = dual_problem_old.dof_handler->begin();
-      const DoFHandler<dim>::cell_iterator
+      const typename DoFHandler<dim>::cell_iterator
        endc            = primal_problem.dof_handler->end(0);
 
       for (; primal_cell!=endc; (++primal_cell, ++dual_cell,
@@ -5950,9 +5951,9 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_dual () {
 
 
   Vector<float>::iterator i = estimated_error_per_cell.begin();
-  DoFHandler<dim>::active_cell_iterator
+  typename DoFHandler<dim>::active_cell_iterator
     cell = primal_problem.dof_handler->begin_active();
-  const DoFHandler<dim>::active_cell_iterator
+  const typename DoFHandler<dim>::active_cell_iterator
     endc = primal_problem.dof_handler->end();
   for (; cell!=endc; ++cell, ++i)
     {
@@ -5970,10 +5971,10 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_dual () {
 
 template <int dim>
 void
-TimeStep_ErrorEstimation<dim>::estimate_error_dual (const DoFHandler<dim>::cell_iterator &primal_cell,
-                                                   const DoFHandler<dim>::cell_iterator &dual_cell,
-                                                   const DoFHandler<dim>::cell_iterator &primal_cell_old,
-                                                   const DoFHandler<dim>::cell_iterator &dual_cell_old,
+TimeStep_ErrorEstimation<dim>::estimate_error_dual (const typename DoFHandler<dim>::cell_iterator &primal_cell,
+                                                   const typename DoFHandler<dim>::cell_iterator &dual_cell,
+                                                   const typename DoFHandler<dim>::cell_iterator &primal_cell_old,
+                                                   const typename DoFHandler<dim>::cell_iterator &dual_cell_old,
                                                    CellwiseError  &cellwise_error,
                                                    FEValues<dim>  &fe_values) const {
   
@@ -6125,8 +6126,8 @@ Assert (false, ExcInternalError());
 
 template <int dim>
 void TimeStep_ErrorEstimation<dim>::
-compute_error_on_new_children (const DoFHandler<dim>::cell_iterator &primal_cell,
-                              const DoFHandler<dim>::cell_iterator &dual_cell,
+compute_error_on_new_children (const typename DoFHandler<dim>::cell_iterator &primal_cell,
+                              const typename DoFHandler<dim>::cell_iterator &dual_cell,
                               const Vector<double>  &local_u_old,
                               const Vector<double>  &local_v_old,
                               const Vector<double>  &local_u_bar_old,
@@ -6150,7 +6151,7 @@ for (unsigned int child=0; child<GeometryInfo<dim>::children_per_cell; ++child)
       dual_fe.prolongate(child).vmult (child_u_bar_old, local_u_bar_old);
       dual_fe.prolongate(child).vmult (child_v_bar_old, local_v_bar_old);
 
-      const DoFHandler<dim>::cell_iterator
+      const typename DoFHandler<dim>::cell_iterator
        new_primal_child = primal_cell->child(child),
        new_dual_child   = dual_cell->child(child);
 
@@ -6194,8 +6195,8 @@ for (unsigned int child=0; child<GeometryInfo<dim>::children_per_cell; ++child)
 
 template <int dim>
 typename TimeStep_ErrorEstimation<dim>::ErrorOnCell
-TimeStep_ErrorEstimation<dim>::collect_error_from_children (const DoFHandler<dim>::cell_iterator &primal_cell_old,
-                                                           const DoFHandler<dim>::cell_iterator &dual_cell_old,
+TimeStep_ErrorEstimation<dim>::collect_error_from_children (const typename DoFHandler<dim>::cell_iterator &primal_cell_old,
+                                                           const typename DoFHandler<dim>::cell_iterator &dual_cell_old,
                                                            const Vector<double>  &local_u,
                                                            const Vector<double>  &local_v,
                                                            const Vector<double>  &local_u_bar,
@@ -6231,7 +6232,7 @@ TimeStep_ErrorEstimation<dim>::collect_error_from_children (const DoFHandler<dim
       dual_fe.prolongate(child).vmult (child_Ih_u_bar_old, local_Ih_u_bar_old);
       dual_fe.prolongate(child).vmult (child_Ih_v_bar_old, local_Ih_v_bar_old);
 
-      const DoFHandler<dim>::cell_iterator
+      const typename DoFHandler<dim>::cell_iterator
        old_primal_child = primal_cell_old->child(child),
        old_dual_child   = dual_cell_old->child(child);
 
@@ -6287,7 +6288,7 @@ error_sum += error_formula (old_dual_child,
 
 template <int dim>
 typename TimeStep_ErrorEstimation<dim>::ErrorOnCell
-TimeStep_ErrorEstimation<dim>::error_formula (const DoFHandler<dim>::active_cell_iterator &cell,
+TimeStep_ErrorEstimation<dim>::error_formula (const typename DoFHandler<dim>::active_cell_iterator &cell,
                                              const Vector<double>  &local_u,
                                              const Vector<double>  &local_v,
                                              const Vector<double>  &local_u_bar,
@@ -6322,7 +6323,7 @@ TimeStep_ErrorEstimation<dim>::error_formula (const DoFHandler<dim>::active_cell
 
 template <int dim>
 typename TimeStep_ErrorEstimation<dim>::ErrorOnCell
-TimeStep_ErrorEstimation<dim>::error_formula (const DoFHandler<dim>::active_cell_iterator &cell,
+TimeStep_ErrorEstimation<dim>::error_formula (const typename DoFHandler<dim>::active_cell_iterator &cell,
                                              const Vector<double>  &local_u,
                                              const Vector<double>  &local_v,
                                              const Vector<double>  &local_u_bar,
@@ -7156,7 +7157,7 @@ void TimeStep_Primal<dim>::build_rhs (Vector<double> &right_hand_side1,
   Assert (previous_time_level.tria->n_cells(0) == tria->n_cells(0),
          typename TimeStep_Wave<dim>::ExcCoarsestGridsDiffer());
 
-  typedef DoFHandler<dim>::cell_iterator cell_iterator;
+  typedef typename DoFHandler<dim>::cell_iterator cell_iterator;
 
   FEValues<dim> fe_values (fe, quadrature,
                           UpdateFlags(update_values |
@@ -7179,12 +7180,12 @@ cell_iterator old_cell = previous_time_level.dof_handler->begin(),
 
 template <int dim>
 void
-TimeStep_Primal<dim>::build_rhs (const DoFHandler<dim>::cell_iterator &old_cell,
-                                const DoFHandler<dim>::cell_iterator &new_cell,
+TimeStep_Primal<dim>::build_rhs (const typename DoFHandler<dim>::cell_iterator &old_cell,
+                                const typename DoFHandler<dim>::cell_iterator &new_cell,
                                 FEValues<dim>        &fe_values,
                                 Vector<double>       &right_hand_side1,
                                 Vector<double>       &right_hand_side2) {
-  typedef DoFHandler<dim>::cell_iterator cell_iterator;
+  typedef typename DoFHandler<dim>::cell_iterator cell_iterator;
   
   if (old_cell->has_children() && new_cell->has_children()) 
     {
@@ -7310,10 +7311,11 @@ rhs1 = local_M_u;
 
 template <int dim>
 unsigned int
-TimeStep_Primal<dim>::collect_from_children (const DoFHandler<dim>::cell_iterator &old_cell,
+TimeStep_Primal<dim>::collect_from_children (const typename DoFHandler<dim>::cell_iterator &old_cell,
                                             FEValues<dim>  &fe_values,
                                             Vector<double> &rhs1,
-                                            Vector<double> &rhs2) const {
+                                            Vector<double> &rhs2) const
+{
   unsigned int level_difference = 1;  
   
   const TimeStep_Primal<dim> &previous_time_level
@@ -7337,7 +7339,7 @@ FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
   for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c) 
     {
-      const DoFHandler<dim>::cell_iterator old_child = old_cell->child(c);
+      const typename DoFHandler<dim>::cell_iterator old_child = old_cell->child(c);
 
       child_rhs1.clear ();
       child_rhs2.clear ();
@@ -7405,7 +7407,7 @@ FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
 template <int dim>
 unsigned int
-TimeStep_Primal<dim>::distribute_to_children (const DoFHandler<dim>::cell_iterator &new_cell,
+TimeStep_Primal<dim>::distribute_to_children (const typename DoFHandler<dim>::cell_iterator &new_cell,
                                              FEValues<dim>         &fe_values,
                                              const Vector<double>  &old_dof_values_u,
                                              const Vector<double>  &old_dof_values_v,
@@ -7433,7 +7435,7 @@ TimeStep_Primal<dim>::distribute_to_children (const DoFHandler<dim>::cell_iterat
 
   for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c) 
     {
-      const DoFHandler<dim>::cell_iterator new_child = new_cell->child(c);
+      const typename DoFHandler<dim>::cell_iterator new_child = new_cell->child(c);
 
       fe.prolongate(c).vmult (local_old_dof_values_u,
                              old_dof_values_u);
index 6ba0201d92c3fa8d00c6346bc2e1cc85ddaa59b7..8b8f02f327456cc04d93f312ae2d75536fc311c3 100644 (file)
@@ -31,7 +31,7 @@ plot_derivatives(Mapping<dim>& mapping,
   Triangulation<dim> tr;
   DoFHandler<dim> dof(tr);
   GridGenerator::hyper_cube(tr, 2., 5.);
-  DoFHandler<dim>::cell_iterator c = dof.begin();
+  typename DoFHandler<dim>::cell_iterator c = dof.begin();
   dof.distribute_dofs(finel);
 
   const unsigned int div = 1;
index ab9325b2a60563967010063919dc594402785bc1..2089a39031a8235265e956f1c8c57dee1fc16b9a 100644 (file)
@@ -89,9 +89,9 @@ template<int dim>
 void test(const Triangulation<dim> &tria,
          const Mapping<dim> &mapping,
          const FiniteElement<dim> &fe1,
-         const string &fe_string1,
+         const std::string &fe_string1,
          const FiniteElement<dim> &fe2,
-         const string &fe_string2,
+         const std::string &fe_string2,
          const unsigned int testcase)
 {
   DoFHandler<dim> dof_handler1 (tria);
@@ -143,13 +143,13 @@ void test(const Triangulation<dim> &tria,
   data_out.attach_dof_handler (dof_handler1);
   data_out.add_data_vector (function1, fe_string1);
   data_out.build_patches (2);
-  string file1_name=fe_string1+"_function.gnuplot";
-  ofstream file1(file1_name.c_str());
+  std::string file1_name=fe_string1+"_function.gnuplot";
+  std::ofstream file1(file1_name.c_str());
   data_out.write_gnuplot(file1);
   file1.close();
   data_out.clear();
 
-  string file2_name=fe_string1+"_";
+  std::string file2_name=fe_string1+"_";
   switch (testcase)
     {
       case 1:
@@ -170,11 +170,11 @@ void test(const Triangulation<dim> &tria,
       default:
            Assert(false, ExcNotImplemented());
     }
-  deallog << file2_name << endl;
+  deallog << file2_name << std::endl;
   
   data_out.build_patches (2);
   data_out.write_gnuplot(deallog.get_file_stream());
-  ofstream file2(file2_name.c_str());
+  std::ofstream file2(file2_name.c_str());
   file2.setf(std::ios::showpoint | std::ios::left);
   data_out.write_gnuplot(file2);
   file2.close();
index f0071c1a81bca870a9370f8b42fb3b1ccee26735..ba11469ee20dde3394c46503cdc89d0be962f99f 100644 (file)
@@ -17,6 +17,7 @@
 #include <fe/fe_values.h>
 #include <vector>
 #include <fstream>
+#include <iostream>
 #include <iomanip>
 #include <string>
 
@@ -31,10 +32,10 @@ void print_formatted (const FullMatrix<number> &A,
       for (unsigned int j=0; j<A.n(); ++j)
        {
          if (A(i,j) != 0)
-           deallog << std::setw(width) << setprecision(precision)
+           deallog << std::setw(width) << std::setprecision(precision)
                    << A(i,j);
          else
-           deallog << std::setw(width) << setprecision(precision)
+           deallog << std::setw(width) << std::setprecision(precision)
                    << "~";
          deallog << ' ';
        };
index cf74d62f8d391f63f9c6bb96dfea1fe604ef5d03..b6f082468a5dba4699d24b12a9d2b296a26b4012 100644 (file)
 #include <vector>
 #include <fstream>
 #include <string>
-#include <strstream>
+
+#ifdef HAVE_STD_STRINGSTREAM
+#  include <sstream>
+#  define SSTREAM std::ostringstream
+#else
+#  include <strstream>
+#  define SSTREAM std::ostrstream
+#endif
 
 #define PRECISION 2
 
@@ -31,8 +38,8 @@ template<int dim>
 inline void
 plot_transformation(Mapping<dim> &mapping,
                    FiniteElement<dim> &fe,
-                   DoFHandler<dim>::cell_iterator &cell,
-                   const char* name)
+                   typename DoFHandler<dim>::cell_iterator &cell,
+                   const std::string& name)
 {
   const unsigned int div = 7;
 
@@ -71,8 +78,8 @@ template<int dim>
 inline void
 plot_faces(Mapping<dim> &mapping,
           FiniteElement<dim> &fe,
-          DoFHandler<dim>::cell_iterator &cell,
-          const char* name)
+          typename DoFHandler<dim>::cell_iterator &cell,
+          const std::string& name)
 {
   deallog.push(name);
 
@@ -115,8 +122,8 @@ template<int dim>
 inline void
 plot_subfaces(Mapping<dim> &mapping,
              FiniteElement<dim> &fe,
-             DoFHandler<dim>::cell_iterator &cell,
-             const char* name)
+             typename DoFHandler<dim>::cell_iterator &cell,
+             const std::string& name)
 {
   deallog.push(name);
 
@@ -162,7 +169,7 @@ inline void
 plot_faces(Mapping<1>&,
           FiniteElement<1>&,
           DoFHandler<1>::cell_iterator&,
-          const char*)
+          const std::string&)
 {};
 
 
@@ -172,7 +179,7 @@ inline void
 plot_subfaces(Mapping<1>&,
              FiniteElement<1>&,
              DoFHandler<1>::cell_iterator&,
-             const char*)
+             const std::string&)
 {};
 
 
@@ -181,7 +188,7 @@ template<int dim>
 inline void
 compute_area(Mapping<dim> &mapping,
             FiniteElement<dim> &fe,
-            DoFHandler<dim>::cell_iterator &cell)
+            typename DoFHandler<dim>::cell_iterator &cell)
 {
   QGauss4<dim> gauss4;
   FEValues<dim> fe_values(mapping, fe, gauss4,
@@ -466,7 +473,7 @@ void mapping_test()
     {
       DoFHandler<dim> dof(*tria_ptr[i]);
       dof.distribute_dofs(fe_q4);      
-      DoFHandler<dim>::cell_iterator cell = dof.begin_active();
+      typename DoFHandler<dim>::cell_iterator cell = dof.begin_active();
       
       deallog << "Triangulation" << i << ":" << std::endl;
 
@@ -474,34 +481,32 @@ void mapping_test()
       for (unsigned int j=0; j<mapping_size; ++j)
        if (show[i][j])
          {
-           char* st2 = new char[100];
-
            if (true)
              {
-               std::ostrstream ost(st2, 99);
+               SSTREAM ost;
                ost << "Mapping" << dim << "d-" << i << '-'
-                   << mapping_strings[j] << std::ends;
-               deallog << st2 << std::endl;
-               plot_transformation(*mapping_ptr[j], fe_q4, cell, st2);
+                   << mapping_strings[j];
+               deallog << ost.str() << std::endl;
+               plot_transformation(*mapping_ptr[j], fe_q4, cell, ost.str());
                compute_area(*mapping_ptr[j], fe_q4, cell);
              }
            
            if (dim>1)
              {
-               std::ostrstream ost(st2, 99);
+               SSTREAM ost;
                ost << "MappingFace" << dim << "d-" << i << '-'
-                   << mapping_strings[j] << std::ends;
-               deallog << st2 << std::endl;        
-               plot_faces(*mapping_ptr[j], fe_q4, cell, st2);
+                   << mapping_strings[j];
+               deallog << ost.str() << std::endl;          
+               plot_faces(*mapping_ptr[j], fe_q4, cell, ost.str());
              }
 
            if (dim>1)
              {
-               std::ostrstream ost(st2, 99);
+               SSTREAM ost;
                ost << "MappingSubface" << dim << "d-" << i << '-'
-                   << mapping_strings[j] << std::ends;
-               deallog << st2 << std::endl;        
-               plot_subfaces(*mapping_ptr[j], fe_q4, cell, st2);
+                   << mapping_strings[j];
+               deallog << ost.str() << std::endl;          
+               plot_subfaces(*mapping_ptr[j], fe_q4, cell, ost.str());
              }
 
            
@@ -527,9 +532,7 @@ void mapping_test()
                Point<dim> p_re_unit=mapping.transform_real_to_unit_cell(cell, p_real);
                deallog << "p_unit=" << p_unit << ",  p_real=" << p_real
                        << ",  p_re_unit=" << p_re_unit << std::endl;
-             }
-           
-           delete[] st2;
+             }     
          }    
     }
 
index 029b64623c770bcd85e7aa8212938d681a970c07..de6e29afa8934ddd71c606f434831098f2377422 100644 (file)
@@ -53,7 +53,7 @@ show_values(FiniteElement<dim>& fe,
                                      update_JxW_values |
                                      update_gradients |
                                      update_second_derivatives));
-  DoFHandler<dim>::cell_iterator c = dof.begin();
+  typename DoFHandler<dim>::cell_iterator c = dof.begin();
   fe_values.reinit(c);
 
   for (unsigned int k=0; k<quadrature_formula.n_quadrature_points; ++k)
index 4cc3cbb3b5c2d93f0e418a45f6a43691f7068701..07dfafdb772fc0fba18d32d33cfede27195b2475 100644 (file)
 #include <fe/fe_values.h>
 #include <vector>
 #include <fstream>
-#include <strstream>
 #include <string>
 
+#ifdef HAVE_STD_STRINGSTREAM
+#  include <sstream>
+#else
+#  include <strstream>
+#endif
+
 template <int dim>
 void performance (Triangulation<dim>& tr,
                  const Mapping<dim>& mapping,
index f8ccf43bcc2a84cb22b3ff191f60105ab774fcfc..04091e7b3bd71d12f01fdb210efeab4082b0ff81 100644 (file)
@@ -32,7 +32,7 @@ plot_shape_functions(Mapping<dim>& mapping,
   Triangulation<dim> tr;
   DoFHandler<dim> dof(tr);
   GridGenerator::hyper_cube(tr, 0., 1.);
-  DoFHandler<dim>::cell_iterator c = dof.begin();
+  typename DoFHandler<dim>::cell_iterator c = dof.begin();
   dof.distribute_dofs(finel);
 
   const unsigned int div = 11;
@@ -103,7 +103,7 @@ plot_face_shape_functions(Mapping<dim>& mapping,
   DoFHandler<dim> dof(tr);
   GridGenerator::hyper_cube(tr, 0., 1.);
   tr.refine_global(1);
-  DoFHandler<dim>::active_cell_iterator c = dof.begin_active();
+  typename DoFHandler<dim>::active_cell_iterator c = dof.begin_active();
   ++c;
   c->set_refine_flag();
   tr.execute_coarsening_and_refinement ();
@@ -241,7 +241,7 @@ void test_compute_functions (const Mapping<dim> &mapping,
   FEValues<dim> fe_values(mapping, fe, q, UpdateFlags(update_values|
                                                      update_gradients|
                                                      update_second_derivatives));
-  DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
+  typename DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
   fe_values.reinit(cell);
 
   bool coincide=true;
index 5dd982fe4246071014ca1c5282e7787a74f27ac9..24930da8a130eb9c4eba6c6a943d97d96cd4e62e 100644 (file)
@@ -141,7 +141,7 @@ int main ()
   logfile.precision(3);
   deallog.attach(logfile);
   deallog.depth_console(0);
-  std::cerr = logfile;
+  std::cerr.rdbuf(logfile.rdbuf());
   
   try
     {

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.