From: wolf Date: Mon, 20 Dec 1999 09:45:48 +0000 (+0000) Subject: Remove template arg from VectorTools. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=38228a9fb8190c8c3b29129e352f74d557a941c1;p=dealii-svn.git Remove template arg from VectorTools. git-svn-id: https://svn.dealii.org/trunk@2085 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/Attic/examples/convergence/convergence.cc b/deal.II/deal.II/Attic/examples/convergence/convergence.cc index 3c06838402..3b09adeaed 100644 --- a/deal.II/deal.II/Attic/examples/convergence/convergence.cc +++ b/deal.II/deal.II/Attic/examples/convergence/convergence.cc @@ -350,7 +350,7 @@ int PoissonProblem::run (const unsigned int level) { Vector h1_seminorm_error_per_cell, h1_error_per_cell; cout << " Calculating L1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, l1_error_per_cell, *quadrature, L1_norm); @@ -358,7 +358,7 @@ int PoissonProblem::run (const unsigned int level) { l1_error.push_back (l1_error_per_cell.l1_norm()); cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, l2_error_per_cell, *quadrature, L2_norm); @@ -366,7 +366,7 @@ int PoissonProblem::run (const unsigned int level) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, linfty_error_per_cell, *quadrature, Linfty_norm); @@ -374,7 +374,7 @@ int PoissonProblem::run (const unsigned int level) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1-seminorm error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, h1_seminorm_error_per_cell, *quadrature, H1_seminorm); @@ -382,7 +382,7 @@ int PoissonProblem::run (const unsigned int level) { h1_seminorm_error.push_back (h1_seminorm_error_per_cell.l2_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, h1_error_per_cell, *quadrature, H1_norm); @@ -407,12 +407,12 @@ int PoissonProblem::run (const unsigned int level) { // Vector projected_solution; // ConstraintMatrix constraints; // constraints.close (); -// VectorTools::project (*dof, constraints, *fe, +// VectorTools::project (*dof, constraints, *fe, // StraightBoundary(), *quadrature, // sol, projected_solution, false, // *boundary_quadrature); // cout << " Calculating L2 error of projected solution... "; -// VectorTools::integrate_difference (*dof_handler, +// VectorTools::integrate_difference (*dof_handler, // projected_solution, sol, // l2_error_per_cell, // *quadrature, *fe, L2_norm); diff --git a/deal.II/deal.II/Attic/examples/error-estimation/error-estimation.cc b/deal.II/deal.II/Attic/examples/error-estimation/error-estimation.cc index 9d6b65fdbe..2aa1b4e5da 100644 --- a/deal.II/deal.II/Attic/examples/error-estimation/error-estimation.cc +++ b/deal.II/deal.II/Attic/examples/error-estimation/error-estimation.cc @@ -521,7 +521,7 @@ void PoissonProblem::run (ParameterHandler &prm) { QGauss3 q; cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, l2_error_per_cell, q, L2_norm); @@ -529,7 +529,7 @@ void PoissonProblem::run (ParameterHandler &prm) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, linfty_error_per_cell, q, Linfty_norm); @@ -537,7 +537,7 @@ void PoissonProblem::run (ParameterHandler &prm) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, h1_error_per_cell, q, H1_norm); diff --git a/deal.II/deal.II/Attic/examples/multigrid/multigrid.cc b/deal.II/deal.II/Attic/examples/multigrid/multigrid.cc index a862bdda17..a4bfcc9fab 100644 --- a/deal.II/deal.II/Attic/examples/multigrid/multigrid.cc +++ b/deal.II/deal.II/Attic/examples/multigrid/multigrid.cc @@ -399,7 +399,7 @@ void PoissonProblem::assemble (const Equation &equation, for (FunctionMap::const_iterator bc=dirichlet_bc.begin(); bc != dirichlet_bc.end(); ++bc) - VectorTools::interpolate_boundary_values (*dof, + VectorTools::interpolate_boundary_values (*dof, bc->first, *bc->second, boundary_value_list); @@ -511,7 +511,7 @@ int PoissonProblem::run (const unsigned int level) { Vector h1_seminorm_error_per_cell, h1_error_per_cell; cout << " Calculating L1 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, l1_error_per_cell, *quadrature, L1_norm); @@ -519,7 +519,7 @@ int PoissonProblem::run (const unsigned int level) { l1_error.push_back (l1_error_per_cell.l1_norm()); cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, l2_error_per_cell, *quadrature, L2_norm); @@ -527,7 +527,7 @@ int PoissonProblem::run (const unsigned int level) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, linfty_error_per_cell, *quadrature, Linfty_norm); @@ -535,7 +535,7 @@ int PoissonProblem::run (const unsigned int level) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1-seminorm error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, h1_seminorm_error_per_cell, *quadrature, H1_seminorm); @@ -543,7 +543,7 @@ int PoissonProblem::run (const unsigned int level) { h1_seminorm_error.push_back (h1_seminorm_error_per_cell.l2_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, h1_error_per_cell, *quadrature, H1_norm); @@ -568,12 +568,12 @@ int PoissonProblem::run (const unsigned int level) { // Vector projected_solution; // ConstraintMatrix constraints; // constraints.close (); -// VectorTools::project (*dof, constraints, *fe, +// VectorTools::project (*dof, constraints, *fe, // StraightBoundary(), *quadrature, // sol, projected_solution, false, // *boundary_quadrature); // cout << " Calculating L2 error of projected solution... "; -// VectorTools::integrate_difference (*dof, +// VectorTools::integrate_difference (*dof, // projected_solution, sol, // l2_error_per_cell, // *quadrature, *fe, L2_norm); diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 521261f480..675fa5a0f5 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -251,24 +251,9 @@ enum NormType { * * @author Wolfgang Bangerth, 1998 */ -template class VectorTools { public: - /** - * Declare a data type which denotes a - * mapping between a boundary indicator - * and the function denoting the boundary - * values on this part of the boundary. - * Only one boundary function may be given - * for each boundary indicator, which is - * guaranteed by the #map# data type. - * - * See the general documentation of this - * class for more detail. - */ - typedef map*> FunctionMap; - /** * Compute the interpolation of * #function# at the support @@ -281,6 +266,7 @@ class VectorTools * See the general documentation of this * class for further information. */ + template static void interpolate (const DoFHandler &dof, const Function &function, Vector &vec); @@ -297,11 +283,12 @@ class VectorTools * #transfer#. Curved boundaries * are neglected so far. */ - static void interpolate(const DoFHandler &high_dof, - const DoFHandler &low_dof, - const FullMatrix &transfer, - const Vector &high, - Vector &low); + template + static void interpolate (const DoFHandler &high_dof, + const DoFHandler &low_dof, + const FullMatrix &transfer, + const Vector &high, + Vector &low); /** * Compute the projection of @@ -335,6 +322,7 @@ class VectorTools * See the general documentation of this * class for further information. */ + template static void project (const DoFHandler &dof, const ConstraintMatrix &constraints, const Quadrature &quadrature, @@ -350,6 +338,7 @@ class VectorTools * See the general documentation of this * class for further information. */ + template static void create_right_hand_side (const DoFHandler &dof, const Quadrature &q, const Function &rhs, @@ -398,6 +387,7 @@ class VectorTools * See the general doc for more * information. */ + template static void interpolate_boundary_values (const DoFHandler &dof, const unsigned char boundary_component, const Function &boundary_function, @@ -425,8 +415,9 @@ class VectorTools * See the general documentation of this * class for further information. */ + template static void project_boundary_values (const DoFHandler &dof, - const FunctionMap &boundary_function, + const map*> &boundary_function, const Quadrature&q, map &boundary_values); @@ -473,6 +464,7 @@ class VectorTools * See the general documentation of this * class for more information. */ + template static void integrate_difference (const DoFHandler &dof, const Vector &fe_function, const Function &exact_solution, diff --git a/deal.II/deal.II/source/numerics/base.cc b/deal.II/deal.II/source/numerics/base.cc index 67db86386e..a393d3bd43 100644 --- a/deal.II/deal.II/source/numerics/base.cc +++ b/deal.II/deal.II/source/numerics/base.cc @@ -129,10 +129,10 @@ void ProblemBase::assemble (const Equation &equation, for (FunctionMap::const_iterator dirichlet = dirichlet_bc.begin() ; dirichlet != dirichlet_bc.end() ; ++dirichlet) - VectorTools::interpolate_boundary_values (*dof_handler, - dirichlet->first, - *(dirichlet->second), - boundary_value_list); + VectorTools::interpolate_boundary_values (*dof_handler, + dirichlet->first, + *(dirichlet->second), + boundary_value_list); MatrixTools::apply_boundary_values (boundary_value_list, system_matrix, solution, right_hand_side); diff --git a/deal.II/deal.II/source/numerics/vectors.cc b/deal.II/deal.II/source/numerics/vectors.cc index ea54637429..85d464b889 100644 --- a/deal.II/deal.II/source/numerics/vectors.cc +++ b/deal.II/deal.II/source/numerics/vectors.cc @@ -43,9 +43,9 @@ inline double sqr_point (const Tensor<1,dim> &p) { template -void VectorTools::interpolate (const DoFHandler &dof, - const Function &function, - Vector &vec) +void VectorTools::interpolate (const DoFHandler &dof, + const Function &function, + Vector &vec) { Assert (dof.get_fe().n_components() == function.n_components, ExcComponentMismatch()); @@ -276,11 +276,11 @@ void VectorTools::interpolate (const DoFHandler &dof, template void -VectorTools::interpolate(const DoFHandler &high_dof, - const DoFHandler &low_dof, - const FullMatrix &transfer, - const Vector &high, - Vector &low) +VectorTools::interpolate(const DoFHandler &high_dof, + const DoFHandler &low_dof, + const FullMatrix &transfer, + const Vector &high, + Vector &low) { Vector cell_high(high_dof.get_fe().dofs_per_cell); Vector cell_low(low_dof.get_fe().dofs_per_cell); @@ -302,14 +302,14 @@ VectorTools::interpolate(const DoFHandler &high_dof, #if deal_II_dimension == 1 template <> -void VectorTools<1>::project (const DoFHandler<1> &, - const ConstraintMatrix &, - const Quadrature<1> &, - const Function<1> &, - Vector &, - const bool , - const Quadrature<0> &, - const bool ) { +void VectorTools::project (const DoFHandler<1> &, + const ConstraintMatrix &, + const Quadrature<1> &, + const Function<1> &, + Vector &, + const bool , + const Quadrature<0> &, + const bool ) { // this function should easily be implemented // using the template below. However some // changes have to be made since faces don't @@ -325,14 +325,14 @@ void VectorTools<1>::project (const DoFHandler<1> &, template -void VectorTools::project (const DoFHandler &dof, - const ConstraintMatrix &constraints, - const Quadrature &quadrature, - const Function &function, - Vector &vec, - const bool enforce_zero_boundary, - const Quadrature &q_boundary, - const bool project_to_boundary_first) +void VectorTools::project (const DoFHandler &dof, + const ConstraintMatrix &constraints, + const Quadrature &quadrature, + const Function &function, + Vector &vec, + const bool enforce_zero_boundary, + const Quadrature &q_boundary, + const bool project_to_boundary_first) { Assert (dof.get_fe().n_components() == function.n_components, ExcInvalidFE()); @@ -373,7 +373,7 @@ void VectorTools::project (const DoFHandler &dof, // the different boundary parts. We want the // #function# to hold on all parts of the // boundary - FunctionMap boundary_functions; + map*> boundary_functions; for (unsigned char c=0; c<255; ++c) boundary_functions[c] = &function; project_boundary_values (dof, boundary_functions, q_boundary, @@ -405,7 +405,7 @@ void VectorTools::project (const DoFHandler &dof, MatrixCreator::create_mass_matrix (dof, quadrature, mass_matrix); }; - VectorTools::create_right_hand_side (dof, quadrature, function, tmp); + VectorTools::create_right_hand_side (dof, quadrature, function, tmp); constraints.condense (mass_matrix); constraints.condense (tmp); @@ -431,10 +431,10 @@ void VectorTools::project (const DoFHandler &dof, template -void VectorTools::create_right_hand_side (const DoFHandler &dof, - const Quadrature &quadrature, - const Function &rhs, - Vector &rhs_vector) +void VectorTools::create_right_hand_side (const DoFHandler &dof, + const Quadrature &quadrature, + const Function &rhs, + Vector &rhs_vector) { Assert (dof.get_fe().n_components() == rhs.n_components, ExcComponentMismatch()); @@ -466,11 +466,11 @@ void VectorTools::create_right_hand_side (const DoFHandler &dof, template <> void -VectorTools<1>::interpolate_boundary_values (const DoFHandler<1> &dof, - const unsigned char boundary_component, - const Function<1> &boundary_function, - map &boundary_values, - const vector &component_mask_) +VectorTools::interpolate_boundary_values (const DoFHandler<1> &dof, + const unsigned char boundary_component, + const Function<1> &boundary_function, + map &boundary_values, + const vector &component_mask_) { Assert (boundary_component != 255, ExcInvalidBoundaryIndicator()); @@ -549,11 +549,11 @@ VectorTools<1>::interpolate_boundary_values (const DoFHandler<1> &dof, template void -VectorTools::interpolate_boundary_values (const DoFHandler &dof, - const unsigned char boundary_component, - const Function &boundary_function, - map &boundary_values, - const vector &component_mask_) +VectorTools::interpolate_boundary_values (const DoFHandler &dof, + const unsigned char boundary_component, + const Function &boundary_function, + map &boundary_values, + const vector &component_mask_) { Assert (boundary_component != 255, ExcInvalidBoundaryIndicator()); @@ -632,10 +632,10 @@ VectorTools::interpolate_boundary_values (const DoFHandler &dof, template void -VectorTools::project_boundary_values (const DoFHandler &dof, - const FunctionMap &boundary_functions, - const Quadrature &q, - map &boundary_values) +VectorTools::project_boundary_values (const DoFHandler &dof, + const map*> &boundary_functions, + const Quadrature &q, + map &boundary_values) { Assert (dof.get_fe().n_components() == boundary_functions.begin()->second->n_components, ExcComponentMismatch()); @@ -715,13 +715,13 @@ VectorTools::project_boundary_values (const DoFHandler &dof, template void -VectorTools::integrate_difference (const DoFHandler &dof, - const Vector &fe_function, - const Function &exact_solution, - Vector &difference, - const Quadrature &q, - const NormType &norm, - const Function *weight) +VectorTools::integrate_difference (const DoFHandler &dof, + const Vector &fe_function, + const Function &exact_solution, + Vector &difference, + const Quadrature &q, + const NormType &norm, + const Function *weight) { const unsigned int n_q_points = q.n_quadrature_points; const FiniteElement &fe = dof.get_fe(); @@ -946,10 +946,9 @@ VectorTools::integrate_difference (const DoFHandler &dof, -template void -VectorTools::subtract_mean_value(Vector &v, - const vector &p_select) +VectorTools::subtract_mean_value(Vector &v, + const vector &p_select) { unsigned int n = v.size(); Assert(n == p_select.size(), ExcDimensionMismatch(n, p_select.size())); @@ -974,4 +973,46 @@ VectorTools::subtract_mean_value(Vector &v, // explicit instantiations -template VectorTools; +template +void VectorTools::integrate_difference (const DoFHandler &, + const Vector &, + const Function &, + Vector &, + const Quadrature &, + const NormType &, + const Function *); +template +void VectorTools::project_boundary_values (const DoFHandler &, + const map*>&, + const Quadrature&, + map &); +template +void VectorTools::interpolate_boundary_values (const DoFHandler &, + const unsigned char, + const Function &, + map &, + const vector &); +template +void VectorTools::create_right_hand_side (const DoFHandler &, + const Quadrature &, + const Function &, + Vector &); +template +void VectorTools::project (const DoFHandler &, + const ConstraintMatrix &, + const Quadrature &, + const Function &, + Vector &, + const bool, + const Quadrature &, + const bool); +template +void VectorTools::interpolate(const DoFHandler &, + const DoFHandler &, + const FullMatrix &, + const Vector &, + Vector &); +template +void VectorTools::interpolate (const DoFHandler &, + const Function &, + Vector &); diff --git a/tests/big-tests/convergence/convergence.cc b/tests/big-tests/convergence/convergence.cc index 3c06838402..3b09adeaed 100644 --- a/tests/big-tests/convergence/convergence.cc +++ b/tests/big-tests/convergence/convergence.cc @@ -350,7 +350,7 @@ int PoissonProblem::run (const unsigned int level) { Vector h1_seminorm_error_per_cell, h1_error_per_cell; cout << " Calculating L1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, l1_error_per_cell, *quadrature, L1_norm); @@ -358,7 +358,7 @@ int PoissonProblem::run (const unsigned int level) { l1_error.push_back (l1_error_per_cell.l1_norm()); cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, l2_error_per_cell, *quadrature, L2_norm); @@ -366,7 +366,7 @@ int PoissonProblem::run (const unsigned int level) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, linfty_error_per_cell, *quadrature, Linfty_norm); @@ -374,7 +374,7 @@ int PoissonProblem::run (const unsigned int level) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1-seminorm error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, h1_seminorm_error_per_cell, *quadrature, H1_seminorm); @@ -382,7 +382,7 @@ int PoissonProblem::run (const unsigned int level) { h1_seminorm_error.push_back (h1_seminorm_error_per_cell.l2_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, sol, h1_error_per_cell, *quadrature, H1_norm); @@ -407,12 +407,12 @@ int PoissonProblem::run (const unsigned int level) { // Vector projected_solution; // ConstraintMatrix constraints; // constraints.close (); -// VectorTools::project (*dof, constraints, *fe, +// VectorTools::project (*dof, constraints, *fe, // StraightBoundary(), *quadrature, // sol, projected_solution, false, // *boundary_quadrature); // cout << " Calculating L2 error of projected solution... "; -// VectorTools::integrate_difference (*dof_handler, +// VectorTools::integrate_difference (*dof_handler, // projected_solution, sol, // l2_error_per_cell, // *quadrature, *fe, L2_norm); diff --git a/tests/big-tests/error-estimation/error-estimation.cc b/tests/big-tests/error-estimation/error-estimation.cc index 9d6b65fdbe..2aa1b4e5da 100644 --- a/tests/big-tests/error-estimation/error-estimation.cc +++ b/tests/big-tests/error-estimation/error-estimation.cc @@ -521,7 +521,7 @@ void PoissonProblem::run (ParameterHandler &prm) { QGauss3 q; cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, l2_error_per_cell, q, L2_norm); @@ -529,7 +529,7 @@ void PoissonProblem::run (ParameterHandler &prm) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, linfty_error_per_cell, q, Linfty_norm); @@ -537,7 +537,7 @@ void PoissonProblem::run (ParameterHandler &prm) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof_handler, + VectorTools::integrate_difference (*dof_handler, solution, *solution_function, h1_error_per_cell, q, H1_norm); diff --git a/tests/big-tests/multigrid/multigrid.cc b/tests/big-tests/multigrid/multigrid.cc index a862bdda17..a4bfcc9fab 100644 --- a/tests/big-tests/multigrid/multigrid.cc +++ b/tests/big-tests/multigrid/multigrid.cc @@ -399,7 +399,7 @@ void PoissonProblem::assemble (const Equation &equation, for (FunctionMap::const_iterator bc=dirichlet_bc.begin(); bc != dirichlet_bc.end(); ++bc) - VectorTools::interpolate_boundary_values (*dof, + VectorTools::interpolate_boundary_values (*dof, bc->first, *bc->second, boundary_value_list); @@ -511,7 +511,7 @@ int PoissonProblem::run (const unsigned int level) { Vector h1_seminorm_error_per_cell, h1_error_per_cell; cout << " Calculating L1 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, l1_error_per_cell, *quadrature, L1_norm); @@ -519,7 +519,7 @@ int PoissonProblem::run (const unsigned int level) { l1_error.push_back (l1_error_per_cell.l1_norm()); cout << " Calculating L2 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, l2_error_per_cell, *quadrature, L2_norm); @@ -527,7 +527,7 @@ int PoissonProblem::run (const unsigned int level) { l2_error.push_back (l2_error_per_cell.l2_norm()); cout << " Calculating L-infinity error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, linfty_error_per_cell, *quadrature, Linfty_norm); @@ -535,7 +535,7 @@ int PoissonProblem::run (const unsigned int level) { linfty_error.push_back (linfty_error_per_cell.linfty_norm()); cout << " Calculating H1-seminorm error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, h1_seminorm_error_per_cell, *quadrature, H1_seminorm); @@ -543,7 +543,7 @@ int PoissonProblem::run (const unsigned int level) { h1_seminorm_error.push_back (h1_seminorm_error_per_cell.l2_norm()); cout << " Calculating H1 error... "; - VectorTools::integrate_difference (*dof, + VectorTools::integrate_difference (*dof, solution, sol, h1_error_per_cell, *quadrature, H1_norm); @@ -568,12 +568,12 @@ int PoissonProblem::run (const unsigned int level) { // Vector projected_solution; // ConstraintMatrix constraints; // constraints.close (); -// VectorTools::project (*dof, constraints, *fe, +// VectorTools::project (*dof, constraints, *fe, // StraightBoundary(), *quadrature, // sol, projected_solution, false, // *boundary_quadrature); // cout << " Calculating L2 error of projected solution... "; -// VectorTools::integrate_difference (*dof, +// VectorTools::integrate_difference (*dof, // projected_solution, sol, // l2_error_per_cell, // *quadrature, *fe, L2_norm); diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index a3b4da9777..272686fcd3 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -5926,7 +5926,7 @@ void TimeStep_Dual::do_timestep () { static const ZeroFunction boundary_values; - VectorTools::interpolate_boundary_values (*dof_handler, 0, boundary_values, + VectorTools::interpolate_boundary_values (*dof_handler, 0, boundary_values, boundary_value_list); MatrixTools::apply_boundary_values (boundary_value_list, system_matrix, v, @@ -8161,13 +8161,13 @@ void TimeStep_Primal::do_initial_step () // use L2-projection for u0 and v0 #if 2 == 1 - VectorTools::interpolate (*dof_handler, *parameters.initial_u, u); - VectorTools::interpolate (*dof_handler, *parameters.initial_v, v); + VectorTools::interpolate (*dof_handler, *parameters.initial_u, u); + VectorTools::interpolate (*dof_handler, *parameters.initial_v, v); #else - VectorTools::project (*dof_handler, constraints, + VectorTools::project (*dof_handler, constraints, quadrature, *parameters.initial_u, u, false, quadrature_face, (dim==2 ? true : false)); - VectorTools::project (*dof_handler, constraints, + VectorTools::project (*dof_handler, constraints, quadrature, *parameters.initial_v, v, false, quadrature_face, (dim==2 ? true : false)); #endif @@ -8255,7 +8255,7 @@ void TimeStep_Primal::do_timestep () parameters.boundary_values_v->set_time (time); map boundary_value_list; - VectorTools::interpolate_boundary_values (*dof_handler, 0, + VectorTools::interpolate_boundary_values (*dof_handler, 0, *(parameters.boundary_values_u), boundary_value_list); MatrixTools::apply_boundary_values (boundary_value_list, @@ -8281,7 +8281,7 @@ void TimeStep_Primal::do_timestep () if (dim != 1) { map boundary_value_list; - VectorTools::interpolate_boundary_values (*dof_handler, 0, + VectorTools::interpolate_boundary_values (*dof_handler, 0, *(parameters.boundary_values_v), boundary_value_list); MatrixTools::apply_boundary_values (boundary_value_list,