]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
avoid deprecated functions/headers in steps
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 13 Feb 2013 15:19:38 +0000 (15:19 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 13 Feb 2013 15:19:38 +0000 (15:19 +0000)
git-svn-id: https://svn.dealii.org/trunk@28376 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/examples/step-32/step-32.cc
deal.II/examples/step-34/step-34.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-44/step-44.cc

index 1d369237b11a800a7567270b0ae824e99702938d..e67bc9f1d82156d57b1e0041e5e9d9681e84724b 100644 (file)
@@ -1738,7 +1738,7 @@ namespace Step32
                                                               matrix_for_bc);
         }
 
-    rhs.compress (Add);
+    rhs.compress (VectorOperation::add);
 
     // Now that we have the right linear system, we solve it using the CG
     // method with a simple Jacobi preconditioner:
@@ -2433,7 +2433,7 @@ namespace Step32
          StokesSystem<dim> (stokes_fe));
 
     stokes_matrix.compress();
-    stokes_rhs.compress(Add);
+    stokes_rhs.compress(VectorOperation::add);
 
     rebuild_stokes_matrix = false;
 
@@ -2843,7 +2843,7 @@ namespace Step32
          Assembly::CopyData::
          TemperatureRHS<dim> (temperature_fe));
 
-    temperature_rhs.compress(Add);
+    temperature_rhs.compress(VectorOperation::add);
   }
 
 
index 11aee7ff278f931491dee52369908863e14e8c7d..e5b9c78bb25fb61e6bd7bf2be66a7d7e52214028 100644 (file)
@@ -591,7 +591,7 @@ namespace Step34
         cell->get_dof_indices(local_dof_indices);
 
         const std::vector<Point<dim> > &q_points = fe_v.get_quadrature_points();
-        const std::vector<Point<dim> > &normals = fe_v.get_cell_normal_vectors();
+        const std::vector<Point<dim> > &normals = fe_v.get_normal_vectors();
         wind.vector_value_list(q_points, cell_wind);
 
         // We then form the integral over the current cell for all degrees of
@@ -676,7 +676,7 @@ namespace Step34
                 std::vector<Vector<double> > singular_cell_wind( singular_quadrature.size(),
                                                                  Vector<double>(dim) );
 
-                const std::vector<Point<dim> > &singular_normals = fe_v_singular.get_cell_normal_vectors();
+                const std::vector<Point<dim> > &singular_normals = fe_v_singular.get_normal_vectors();
                 const std::vector<Point<dim> > &singular_q_points = fe_v_singular.get_quadrature_points();
 
                 wind.vector_value_list(singular_q_points, singular_cell_wind);
@@ -947,7 +947,7 @@ namespace Step34
         fe_v.reinit(cell);
 
         const std::vector<Point<dim> > &q_points = fe_v.get_quadrature_points();
-        const std::vector<Point<dim> > &normals = fe_v.get_cell_normal_vectors();
+        const std::vector<Point<dim> > &normals = fe_v.get_normal_vectors();
 
         cell->get_dof_indices(dofs);
         fe_v.get_function_values(phi, local_phi);
index b618ff35b9272ea2286d82975b50bd8a54f4223a..a85eaa45d92daa3c29296f0a73afeb29a48f7cd4 100644 (file)
@@ -33,6 +33,7 @@
 #include <deal.II/lac/solver_gmres.h>
 #include <deal.II/lac/sparse_ilu.h>
 #include <deal.II/lac/sparse_direct.h>
+#include <deal.II/lac/constraint_matrix.h>
 
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/grid_generator.h>
@@ -46,7 +47,6 @@
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_tools.h>
 #include <deal.II/dofs/dof_renumbering.h>
-#include <deal.II/dofs/dof_constraints.h>
 
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_values.h>
index 68678b7b4b5532a57debab5a4c4cb1557619e21a..fb1014185e73949c57e6f7e0d0224b7b9b4f066d 100644 (file)
@@ -21,7 +21,6 @@
 #include <deal.II/base/timer.h>
 #include <deal.II/base/work_stream.h>
 
-#include <deal.II/dofs/dof_constraints.h>
 #include <deal.II/dofs/dof_renumbering.h>
 #include <deal.II/dofs/dof_tools.h>
 
@@ -45,6 +44,7 @@
 #include <deal.II/lac/precondition_selector.h>
 #include <deal.II/lac/solver_cg.h>
 #include <deal.II/lac/sparse_direct.h>
+#include <deal.II/lac/constraint_matrix.h>
 
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/vector_tools.h>

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.