From: Denis Davydov Date: Sat, 19 Aug 2017 13:55:59 +0000 (+0200) Subject: replace occurances of ZeroFunction and ConstantFunction in all .cc X-Git-Tag: v9.0.0-rc1~1198^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=77270ecbb9d4d52c5d6761c33e47db5137cb8d4b;p=dealii.git replace occurances of ZeroFunction and ConstantFunction in all .cc --- diff --git a/examples/step-11/step-11.cc b/examples/step-11/step-11.cc index 5a8f8e643c..c8b90cb22a 100644 --- a/examples/step-11/step-11.cc +++ b/examples/step-11/step-11.cc @@ -279,7 +279,7 @@ namespace Step11 system_matrix); VectorTools::create_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(-2), + Functions::ConstantFunction(-2), system_rhs); // That's quite simple, right? // @@ -314,7 +314,7 @@ namespace Step11 Vector tmp (system_rhs.size()); VectorTools::create_boundary_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(1), + Functions::ConstantFunction(1), tmp); // Then add the contributions from the boundary to those from the interior // of the domain: @@ -361,7 +361,7 @@ namespace Step11 Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (mapping, dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(gauss_degree+1), VectorTools::H1_seminorm); diff --git a/examples/step-14/step-14.cc b/examples/step-14/step-14.cc index d98966313f..2dff2148d0 100644 --- a/examples/step-14/step-14.cc +++ b/examples/step-14/step-14.cc @@ -1288,15 +1288,15 @@ namespace Step14 // We need a class to denote the boundary values of the problem. In this // case, this is simple: it's the zero function, so don't even declare a // class, just a typedef: - typedef ZeroFunction BoundaryValues; + typedef Functions::ZeroFunction BoundaryValues; // Second, a class that denotes the right hand side. Since they are // constant, just subclass the corresponding class of the library and be // done: - class RightHandSide : public ConstantFunction + class RightHandSide : public Functions::ConstantFunction { public: - RightHandSide () : ConstantFunction (1.) {} + RightHandSide () : Functions::ConstantFunction (1.) {} }; // Finally a function to generate the coarse grid. This is somewhat more @@ -1756,11 +1756,11 @@ namespace Step14 const SmartPointer > dual_functional; virtual void assemble_rhs (Vector &rhs) const; - static const ZeroFunction boundary_values; + static const Functions::ZeroFunction boundary_values; }; template - const ZeroFunction DualSolver::boundary_values; + const Functions::ZeroFunction DualSolver::boundary_values; template DualSolver:: diff --git a/examples/step-15/step-15.cc b/examples/step-15/step-15.cc index 408e3a3ca1..fca0337842 100644 --- a/examples/step-15/step-15.cc +++ b/examples/step-15/step-15.cc @@ -334,7 +334,7 @@ namespace Step15 std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/examples/step-16/step-16.cc b/examples/step-16/step-16.cc index 06151f45b4..4d5a7a33b7 100644 --- a/examples/step-16/step-16.cc +++ b/examples/step-16/step-16.cc @@ -283,7 +283,7 @@ namespace Step16 std::set dirichlet_boundary_ids; typename FunctionMap::type dirichlet_boundary_functions; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary_ids.insert(0); dirichlet_boundary_functions[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (static_cast&>(dof_handler), diff --git a/examples/step-17/step-17.cc b/examples/step-17/step-17.cc index e5c5968b68..becb5ba141 100644 --- a/examples/step-17/step-17.cc +++ b/examples/step-17/step-17.cc @@ -480,7 +480,7 @@ namespace Step17 std::vector lambda_values (n_q_points); std::vector mu_values (n_q_points); - ConstantFunction lambda(1.), mu(1.); + Functions::ConstantFunction lambda(1.), mu(1.); RightHandSide right_hand_side; std::vector > rhs_values (n_q_points, @@ -616,7 +616,7 @@ namespace Step17 std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(dim), + Functions::ZeroFunction(dim), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/examples/step-18/step-18.cc b/examples/step-18/step-18.cc index f0e9af6ffe..5e0f08ff74 100644 --- a/examples/step-18/step-18.cc +++ b/examples/step-18/step-18.cc @@ -639,7 +639,7 @@ namespace Step18 // For the purposes of this program, we choose a simple form of boundary // displacement: we displace the top boundary with constant velocity // downwards. The rest of the boundary is either going to be fixed (and is - // then described using an object of type ZeroFunction) or free + // then described using an object of type Functions::ZeroFunction) or free // (Neumann-type, in which case nothing special has to be done). The // implementation of the class describing the constant downward motion // should then be obvious using the knowledge we gained through all the @@ -1139,7 +1139,7 @@ namespace Step18 VectorTools:: interpolate_boundary_values (dof_handler, 0, - ZeroFunction (dim), + Functions::ZeroFunction (dim), boundary_values); VectorTools:: interpolate_boundary_values (dof_handler, diff --git a/examples/step-21/step-21.cc b/examples/step-21/step-21.cc index 59f528886d..15e513e0fc 100644 --- a/examples/step-21/step-21.cc +++ b/examples/step-21/step-21.cc @@ -223,7 +223,7 @@ namespace Step21 // // We therefore simply create a function that returns zero in all // components. We do that by simply forward every function to the - // ZeroFunction class. Why not use that right away in the places of this + // Functions::ZeroFunction class. Why not use that right away in the places of this // program where we presently use the InitialValues class? // Because this way it is simpler to later go back and choose a different // function for initial values. @@ -247,7 +247,7 @@ namespace Step21 InitialValues::value (const Point &p, const unsigned int component) const { - return ZeroFunction(dim+2).value (p, component); + return Functions::ZeroFunction(dim+2).value (p, component); } @@ -256,7 +256,7 @@ namespace Step21 InitialValues::vector_value (const Point &p, Vector &values) const { - ZeroFunction(dim+2).vector_value (p, values); + Functions::ZeroFunction(dim+2).vector_value (p, values); } diff --git a/examples/step-26/step-26.cc b/examples/step-26/step-26.cc index 41a9d30436..ef6c9c6598 100644 --- a/examples/step-26/step-26.cc +++ b/examples/step-26/step-26.cc @@ -463,7 +463,7 @@ start_time_iteration: VectorTools::interpolate(dof_handler, - ZeroFunction(), + Functions::ZeroFunction(), old_solution); solution = old_solution; diff --git a/examples/step-27/step-27.cc b/examples/step-27/step-27.cc index 43cf9f97dc..b7204ce681 100644 --- a/examples/step-27/step-27.cc +++ b/examples/step-27/step-27.cc @@ -274,7 +274,7 @@ namespace Step27 constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/examples/step-28/step-28.cc b/examples/step-28/step-28.cc index e00ec968d9..1196de9859 100644 --- a/examples/step-28/step-28.cc +++ b/examples/step-28/step-28.cc @@ -644,7 +644,7 @@ namespace Step28 for (unsigned int i=0; i(), + Functions::ZeroFunction(), boundary_values); } @@ -1687,7 +1687,7 @@ namespace Step28 { for (unsigned int group=0; groupassemble_ingroup_rhs (ZeroFunction()); + energy_groups[group]->assemble_ingroup_rhs (Functions::ZeroFunction()); for (unsigned int bgroup=0; bgroupassemble_cross_group_rhs (*energy_groups[bgroup]); diff --git a/examples/step-3/step-3.cc b/examples/step-3/step-3.cc index 7be6aeb2a2..0537305350 100644 --- a/examples/step-3/step-3.cc +++ b/examples/step-3/step-3.cc @@ -504,7 +504,7 @@ void Step3::assemble_system () // the boundary. // // The function describing the boundary values is an object of type Function - // or of a derived class. One of the derived classes is ZeroFunction, which + // or of a derived class. One of the derived classes is Functions::ZeroFunction, which // describes (not unexpectedly) a function which is zero everywhere. We // create such an object in-place and pass it to the // VectorTools::interpolate_boundary_values() function. @@ -517,7 +517,7 @@ void Step3::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); // Now that we got the list of boundary DoFs and their respective boundary // values, let's use them to modify the system of equations diff --git a/examples/step-32/step-32.cc b/examples/step-32/step-32.cc index 0d3cf79d80..a8d6c7019b 100644 --- a/examples/step-32/step-32.cc +++ b/examples/step-32/step-32.cc @@ -2058,7 +2058,7 @@ namespace Step32 FEValuesExtractors::Vector velocity_components(0); VectorTools::interpolate_boundary_values (stokes_dof_handler, 0, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), stokes_constraints, stokes_fe.component_mask(velocity_components)); diff --git a/examples/step-35/step-35.cc b/examples/step-35/step-35.cc index e4885ca824..7599883b32 100644 --- a/examples/step-35/step-35.cc +++ b/examples/step-35/step-35.cc @@ -776,9 +776,9 @@ namespace Step35 { vel_exact.set_time (t_0); vel_exact.set_component(d); - VectorTools::interpolate (dof_handler_velocity, ZeroFunction(), u_n_minus_1[d]); + VectorTools::interpolate (dof_handler_velocity, Functions::ZeroFunction(), u_n_minus_1[d]); vel_exact.advance_time (dt); - VectorTools::interpolate (dof_handler_velocity, ZeroFunction(), u_n[d]); + VectorTools::interpolate (dof_handler_velocity, Functions::ZeroFunction(), u_n[d]); } } @@ -1047,7 +1047,7 @@ namespace Step35 VectorTools:: interpolate_boundary_values (dof_handler_velocity, *boundaries, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); break; case 2: @@ -1062,14 +1062,14 @@ namespace Step35 VectorTools:: interpolate_boundary_values (dof_handler_velocity, *boundaries, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); break; case 4: VectorTools:: interpolate_boundary_values (dof_handler_velocity, *boundaries, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); break; default: @@ -1215,7 +1215,7 @@ namespace Step35 static std::map bval; if (reinit_prec) VectorTools::interpolate_boundary_values (dof_handler_pressure, 3, - ZeroFunction(), bval); + Functions::ZeroFunction(), bval); MatrixTools::apply_boundary_values (bval, pres_iterative, phi_n, pres_tmp); diff --git a/examples/step-37/step-37.cc b/examples/step-37/step-37.cc index d0547ac1ff..6033e0f9f9 100644 --- a/examples/step-37/step-37.cc +++ b/examples/step-37/step-37.cc @@ -827,7 +827,7 @@ namespace Step37 constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close(); setup_time += time.wall_time(); diff --git a/examples/step-4/step-4.cc b/examples/step-4/step-4.cc index f50a1499ed..ba04643dd5 100644 --- a/examples/step-4/step-4.cc +++ b/examples/step-4/step-4.cc @@ -118,7 +118,7 @@ private: // simply be omitted for scalar functions. // // Function objects are used in lots of places in the library (for example, in -// step-2 we used a ZeroFunction instance as an argument to +// step-2 we used a Functions::ZeroFunction instance as an argument to // VectorTools::interpolate_boundary_values) and this is the first step where // we define a new class that inherits from Function. Since we only ever call // Function::value, we could get away with just a plain function (and this is @@ -415,7 +415,7 @@ void Step4::assemble_system () // As the final step in this function, we wanted to have non-homogeneous // boundary values in this example, unlike the one before. This is a simple - // task, we only have to replace the ZeroFunction used there by an object of + // task, we only have to replace the Functions::ZeroFunction used there by an object of // the class which describes the boundary values we would like to use // (i.e. the BoundaryValues class declared above): std::map boundary_values; diff --git a/examples/step-40/step-40.cc b/examples/step-40/step-40.cc index 6ca481b1da..d4ac20a7a4 100644 --- a/examples/step-40/step-40.cc +++ b/examples/step-40/step-40.cc @@ -297,7 +297,7 @@ namespace Step40 DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/examples/step-44/step-44.cc b/examples/step-44/step-44.cc index 83ca47c2ce..35d56be765 100644 --- a/examples/step-44/step-44.cc +++ b/examples/step-44/step-44.cc @@ -2495,13 +2495,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); } @@ -2511,13 +2511,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); } @@ -2532,7 +2532,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -2540,7 +2540,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -2552,13 +2552,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); } @@ -2569,7 +2569,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -2577,7 +2577,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -2592,13 +2592,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } @@ -2608,13 +2608,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } diff --git a/examples/step-46/step-46.cc b/examples/step-46/step-46.cc index d5f1602430..7ff42afb65 100644 --- a/examples/step-46/step-46.cc +++ b/examples/step-46/step-46.cc @@ -399,7 +399,7 @@ namespace Step46 const FEValuesExtractors::Vector displacements(dim+1); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(dim+1+dim), + Functions::ZeroFunction(dim+1+dim), constraints, fe_collection.component_mask(displacements)); } diff --git a/examples/step-47/step-47.cc b/examples/step-47/step-47.cc index 62712a3536..d86bf9085c 100644 --- a/examples/step-47/step-47.cc +++ b/examples/step-47/step-47.cc @@ -432,7 +432,7 @@ namespace Step47 std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(2), + Functions::ZeroFunction(2), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/examples/step-48/step-48.cc b/examples/step-48/step-48.cc index 433f7e7fb5..b30a9e79aa 100644 --- a/examples/step-48/step-48.cc +++ b/examples/step-48/step-48.cc @@ -462,7 +462,7 @@ namespace Step48 solution.update_ghost_values(); VectorTools::integrate_difference (dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(fe_degree+1), VectorTools::L2_norm); diff --git a/examples/step-5/step-5.cc b/examples/step-5/step-5.cc index dcb9c3a513..30c0f5164c 100644 --- a/examples/step-5/step-5.cc +++ b/examples/step-5/step-5.cc @@ -235,7 +235,7 @@ void Step5::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/examples/step-50/step-50.cc b/examples/step-50/step-50.cc index daedd3b567..f160f77841 100644 --- a/examples/step-50/step-50.cc +++ b/examples/step-50/step-50.cc @@ -287,7 +287,7 @@ namespace Step50 std::set dirichlet_boundary_ids; typename FunctionMap::type dirichlet_boundary; - ConstantFunction homogeneous_dirichlet_bc (1.0); + Functions::ConstantFunction homogeneous_dirichlet_bc (1.0); dirichlet_boundary_ids.insert(0); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, diff --git a/examples/step-52/step-52.cc b/examples/step-52/step-52.cc index 7edd1df51d..3ad784e18a 100644 --- a/examples/step-52/step-52.cc +++ b/examples/step-52/step-52.cc @@ -166,7 +166,7 @@ namespace Step52 { dof_handler.distribute_dofs(fe); - VectorTools::interpolate_boundary_values(dof_handler,1,ZeroFunction<2>(),constraint_matrix); + VectorTools::interpolate_boundary_values(dof_handler,1,Functions::ZeroFunction<2>(),constraint_matrix); constraint_matrix.close(); DynamicSparsityPattern dsp(dof_handler.n_dofs()); diff --git a/examples/step-57/step-57.cc b/examples/step-57/step-57.cc index ed130bbbd1..a1d7adfef9 100644 --- a/examples/step-57/step-57.cc +++ b/examples/step-57/step-57.cc @@ -337,7 +337,7 @@ namespace Step57 DoFTools::make_hanging_node_constraints(dof_handler, zero_constraints); VectorTools::interpolate_boundary_values(dof_handler, 0, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), zero_constraints, fe.component_mask(velocities)); } diff --git a/examples/step-6/step-6.cc b/examples/step-6/step-6.cc index db0e868c7b..81064eb73f 100644 --- a/examples/step-6/step-6.cc +++ b/examples/step-6/step-6.cc @@ -268,7 +268,7 @@ void Step6::setup_system () constraints); - // Now we are ready to interpolate the ZeroFunction to our boundary with + // Now we are ready to interpolate the Functions::ZeroFunction to our boundary with // indicator 0 (the whole boundary) and store the resulting constraints in // our constraints object. Note that we do not to apply the // boundary conditions after assembly, like we did in earlier steps. As @@ -280,7 +280,7 @@ void Step6::setup_system () // values into the ContraintMatrix after the hanging node constraints. VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); diff --git a/examples/step-8/step-8.cc b/examples/step-8/step-8.cc index f67ed3718b..526c1d60c6 100644 --- a/examples/step-8/step-8.cc +++ b/examples/step-8/step-8.cc @@ -297,7 +297,7 @@ namespace Step8 // value 1.0. Although we could omit the respective factors in the // assemblage of the matrix, we use them here for purpose of // demonstration. - ConstantFunction lambda(1.), mu(1.); + Functions::ConstantFunction lambda(1.), mu(1.); // Like the two constant functions above, we will call the function // right_hand_side just once per cell to make things simpler. @@ -434,17 +434,17 @@ namespace Step8 // The interpolation of the boundary values needs a small modification: // since the solution function is vector-valued, so need to be the - // boundary values. The ZeroFunction constructor accepts a + // boundary values. The Functions::ZeroFunction constructor accepts a // parameter that tells it that it shall represent a vector valued, // constant zero function with that many components. By default, this - // parameter is equal to one, in which case the ZeroFunction + // parameter is equal to one, in which case the Functions::ZeroFunction // object would represent a scalar function. Since the solution vector has // dim components, we need to pass dim as number // of components to the zero function as well. std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(dim), + Functions::ZeroFunction(dim), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/arpack/parpack_advection_diffusion_petsc.cc b/tests/arpack/parpack_advection_diffusion_petsc.cc index 39e7ef2b2a..4c047bac78 100644 --- a/tests/arpack/parpack_advection_diffusion_petsc.cc +++ b/tests/arpack/parpack_advection_diffusion_petsc.cc @@ -190,7 +190,7 @@ void test () dealii::DoFTools::make_hanging_node_constraints (dof_handler, constraints); dealii::VectorTools::interpolate_boundary_values (dof_handler, 0, - dealii::ZeroFunction (), + dealii::Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/parpack_advection_diffusion_trilinos.cc b/tests/arpack/parpack_advection_diffusion_trilinos.cc index 46c3ef4b45..88f603484a 100644 --- a/tests/arpack/parpack_advection_diffusion_trilinos.cc +++ b/tests/arpack/parpack_advection_diffusion_trilinos.cc @@ -168,7 +168,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/step-36_ar.cc b/tests/arpack/step-36_ar.cc index 0630a2a4d2..242db31a91 100644 --- a/tests/arpack/step-36_ar.cc +++ b/tests/arpack/step-36_ar.cc @@ -144,7 +144,7 @@ namespace Step36 std::vector local_dof_indices (dofs_per_cell); - ZeroFunction potential; + Functions::ZeroFunction potential; std::vector potential_values (n_q_points); diff --git a/tests/arpack/step-36_ar_shift.cc b/tests/arpack/step-36_ar_shift.cc index cc300622b8..bc9b92ef13 100644 --- a/tests/arpack/step-36_ar_shift.cc +++ b/tests/arpack/step-36_ar_shift.cc @@ -138,7 +138,7 @@ namespace Step36 std::vector local_dof_indices (dofs_per_cell); - ZeroFunction potential; + Functions::ZeroFunction potential; std::vector potential_values (n_q_points); diff --git a/tests/arpack/step-36_parpack.cc b/tests/arpack/step-36_parpack.cc index d0dde054db..c78e4062bf 100644 --- a/tests/arpack/step-36_parpack.cc +++ b/tests/arpack/step-36_parpack.cc @@ -192,7 +192,7 @@ void test () dealii::DoFTools::make_hanging_node_constraints (dof_handler, constraints); dealii::VectorTools::interpolate_boundary_values (dof_handler, 0, - dealii::ZeroFunction (), + dealii::Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/step-36_parpack_mf.cc b/tests/arpack/step-36_parpack_mf.cc index 9795269805..0b6a00fdad 100644 --- a/tests/arpack/step-36_parpack_mf.cc +++ b/tests/arpack/step-36_parpack_mf.cc @@ -85,7 +85,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/step-36_parpack_mf_02.cc b/tests/arpack/step-36_parpack_mf_02.cc index 0dc03f2f2c..dcc6582c56 100644 --- a/tests/arpack/step-36_parpack_mf_02.cc +++ b/tests/arpack/step-36_parpack_mf_02.cc @@ -85,7 +85,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/step-36_parpack_mf_03.cc b/tests/arpack/step-36_parpack_mf_03.cc index f0d994dd9a..5e9b4ac935 100644 --- a/tests/arpack/step-36_parpack_mf_03.cc +++ b/tests/arpack/step-36_parpack_mf_03.cc @@ -85,7 +85,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/arpack/step-36_parpack_trilinos.cc b/tests/arpack/step-36_parpack_trilinos.cc index 1860bac98e..694faf5978 100644 --- a/tests/arpack/step-36_parpack_trilinos.cc +++ b/tests/arpack/step-36_parpack_trilinos.cc @@ -170,7 +170,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/base/functions_constant_function_00.cc b/tests/base/functions_constant_function_00.cc index 536ef2c199..db1662a8b2 100644 --- a/tests/base/functions_constant_function_00.cc +++ b/tests/base/functions_constant_function_00.cc @@ -27,7 +27,7 @@ #define LOG_FILE "output" #define NUMBER double -#define TESTEE ConstantFunction +#define TESTEE Functions::ConstantFunction // Test a given TESTEE object f on n_points points template diff --git a/tests/bits/anna_4.cc b/tests/bits/anna_4.cc index 7ad5d78723..281fdba378 100644 --- a/tests/bits/anna_4.cc +++ b/tests/bits/anna_4.cc @@ -181,7 +181,7 @@ void FindBug::dirichlet_conditions () // Here comes the crucial call.... VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (2), + Functions::ZeroFunction (2), dirichlet_dofs, component_mask); diff --git a/tests/bits/apply_boundary_values_01.cc b/tests/bits/apply_boundary_values_01.cc index 7da022161b..c4d15e3e38 100644 --- a/tests/bits/apply_boundary_values_01.cc +++ b/tests/bits/apply_boundary_values_01.cc @@ -84,7 +84,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.), + Functions::ConstantFunction(1.), boundary_values); std::vector local_dofs (fe.dofs_per_cell); diff --git a/tests/bits/apply_boundary_values_02.cc b/tests/bits/apply_boundary_values_02.cc index fa4c2e8694..36dad022ee 100644 --- a/tests/bits/apply_boundary_values_02.cc +++ b/tests/bits/apply_boundary_values_02.cc @@ -84,7 +84,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.), + Functions::ConstantFunction(1.), boundary_values); std::vector local_dofs (fe.dofs_per_cell); diff --git a/tests/bits/fe_q_constraints.cc b/tests/bits/fe_q_constraints.cc index 8a149400aa..64caea69a0 100644 --- a/tests/bits/fe_q_constraints.cc +++ b/tests/bits/fe_q_constraints.cc @@ -189,7 +189,7 @@ void TestFEQConstraints::test () // First error check. Simply the interpolation error of the used FE-Space // on the given triangulation. VectorTools::integrate_difference (dof_handler, solution, - ZeroFunction(1), + Functions::ZeroFunction(1), norm_per_cell, quadrature, VectorTools::L2_norm); diff --git a/tests/bits/joa_1.cc b/tests/bits/joa_1.cc index c0dd828f8c..f923afc7ee 100644 --- a/tests/bits/joa_1.cc +++ b/tests/bits/joa_1.cc @@ -647,7 +647,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/make_boundary_constraints_01.cc b/tests/bits/make_boundary_constraints_01.cc index f295b0f457..21763d77b4 100644 --- a/tests/bits/make_boundary_constraints_01.cc +++ b/tests/bits/make_boundary_constraints_01.cc @@ -84,7 +84,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.), + Functions::ConstantFunction(1.), boundary_values); ConstraintMatrix constraints; constraints.clear(); diff --git a/tests/bits/make_boundary_constraints_02.cc b/tests/bits/make_boundary_constraints_02.cc index 8d8e5bd1a8..edb024cf9c 100644 --- a/tests/bits/make_boundary_constraints_02.cc +++ b/tests/bits/make_boundary_constraints_02.cc @@ -93,7 +93,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 1, - ConstantFunction(1.), + Functions::ConstantFunction(1.), boundary_values); ConstraintMatrix constraints; constraints.clear(); diff --git a/tests/bits/point_difference_01.cc b/tests/bits/point_difference_01.cc index 7aa937b0d5..70a061533c 100644 --- a/tests/bits/point_difference_01.cc +++ b/tests/bits/point_difference_01.cc @@ -149,7 +149,7 @@ check () deallog << difference(0) << std::endl; Assert (difference(0) < 2e-4, ExcInternalError()); - VectorTools::point_difference (dof, v, ZeroFunction(), + VectorTools::point_difference (dof, v, Functions::ZeroFunction(), difference, p[i]); deallog << difference(0) << std::endl; Assert (std::abs(-difference(0) - function.value(p[i])) < 2e-4, diff --git a/tests/bits/point_difference_02.cc b/tests/bits/point_difference_02.cc index b9284075f2..22cbfd1113 100644 --- a/tests/bits/point_difference_02.cc +++ b/tests/bits/point_difference_02.cc @@ -154,7 +154,7 @@ check () deallog << difference(0) << std::endl; Assert (difference(0) < 2e-4, ExcInternalError()); - VectorTools::point_difference (mapping, dof, v, ZeroFunction(), + VectorTools::point_difference (mapping, dof, v, Functions::ZeroFunction(), difference, p[i]); deallog << difference(0) << std::endl; Assert (std::abs(-difference(0) - function.value(p[i])) < 2e-4, diff --git a/tests/bits/step-11.cc b/tests/bits/step-11.cc index c8ec3d0e9f..09910c3980 100644 --- a/tests/bits/step-11.cc +++ b/tests/bits/step-11.cc @@ -140,12 +140,12 @@ void LaplaceProblem::assemble_and_solve () system_matrix); VectorTools::create_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(-2), + Functions::ConstantFunction(-2), system_rhs); Vector tmp (system_rhs.size()); VectorTools::create_boundary_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(1), + Functions::ConstantFunction(1), tmp); system_rhs += tmp; @@ -158,7 +158,7 @@ void LaplaceProblem::assemble_and_solve () Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (mapping, dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(gauss_degree+1), VectorTools::H1_seminorm); diff --git a/tests/bits/step-14.cc b/tests/bits/step-14.cc index d0734f00a9..998870529b 100644 --- a/tests/bits/step-14.cc +++ b/tests/bits/step-14.cc @@ -1012,12 +1012,12 @@ namespace Data template struct Exercise_2_3 { - typedef ZeroFunction BoundaryValues; + typedef Functions::ZeroFunction BoundaryValues; - class RightHandSide : public ConstantFunction + class RightHandSide : public Functions::ConstantFunction { public: - RightHandSide () : ConstantFunction (1.) {} + RightHandSide () : Functions::ConstantFunction (1.) {} }; static @@ -1291,13 +1291,13 @@ namespace LaplaceSolver const SmartPointer > dual_functional; virtual void assemble_rhs (Vector &rhs) const; - static const ZeroFunction boundary_values; + static const Functions::ZeroFunction boundary_values; friend class WeightedResidual; }; template - const ZeroFunction DualSolver::boundary_values; + const Functions::ZeroFunction DualSolver::boundary_values; template DualSolver:: diff --git a/tests/bits/step-15.cc b/tests/bits/step-15.cc index 4bc5654428..1136e85740 100644 --- a/tests/bits/step-15.cc +++ b/tests/bits/step-15.cc @@ -267,12 +267,12 @@ void MinimizationProblem::assemble_step () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); if (dim == 1) VectorTools::interpolate_boundary_values (dof_handler, 1, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); Vector dummy (residual.size()); MatrixTools::apply_boundary_values (boundary_values, diff --git a/tests/bits/step-3.cc b/tests/bits/step-3.cc index edd9f2e518..db00d0e1ba 100644 --- a/tests/bits/step-3.cc +++ b/tests/bits/step-3.cc @@ -168,7 +168,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/step-5.cc b/tests/bits/step-5.cc index a401872734..9256a783c0 100644 --- a/tests/bits/step-5.cc +++ b/tests/bits/step-5.cc @@ -225,7 +225,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/step-6-racoptimize-2.cc b/tests/bits/step-6-racoptimize-2.cc index 36cad47602..716c43968c 100644 --- a/tests/bits/step-6-racoptimize-2.cc +++ b/tests/bits/step-6-racoptimize-2.cc @@ -254,7 +254,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/step-6-racoptimize.cc b/tests/bits/step-6-racoptimize.cc index 0af5985040..41e5cb0575 100644 --- a/tests/bits/step-6-racoptimize.cc +++ b/tests/bits/step-6-racoptimize.cc @@ -254,7 +254,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/step-6.cc b/tests/bits/step-6.cc index bbbb31707e..c5b83189a8 100644 --- a/tests/bits/step-6.cc +++ b/tests/bits/step-6.cc @@ -251,7 +251,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/bits/step-8.cc b/tests/bits/step-8.cc index 1c109ecaa6..b8a1496b72 100644 --- a/tests/bits/step-8.cc +++ b/tests/bits/step-8.cc @@ -213,7 +213,7 @@ void ElasticProblem::assemble_system () std::vector lambda_values (n_q_points); std::vector mu_values (n_q_points); - ConstantFunction lambda(1.), mu(1.); + Functions::ConstantFunction lambda(1.), mu(1.); RightHandSide right_hand_side; std::vector > rhs_values (n_q_points, @@ -301,7 +301,7 @@ void ElasticProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(dim), + Functions::ZeroFunction(dim), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/codim_one/interpolation.cc b/tests/codim_one/interpolation.cc index 98334db2c6..ddc7fb2507 100644 --- a/tests/codim_one/interpolation.cc +++ b/tests/codim_one/interpolation.cc @@ -64,7 +64,7 @@ void test(std::string filename, unsigned int n) for (unsigned int i=0; i constant(1.); + Functions::ConstantFunction constant(1.); VectorTools::interpolate(dof_handler, constant, interpolated_one); real_one.add(-1, interpolated_one); diff --git a/tests/dofs/dof_tools_19.cc b/tests/dofs/dof_tools_19.cc index c9a36c2aa7..6667cc415e 100644 --- a/tests/dofs/dof_tools_19.cc +++ b/tests/dofs/dof_tools_19.cc @@ -53,7 +53,7 @@ check_this (const DoFHandler &dof_handler) std::string::npos) return; - ConstantFunction test_func (1, dof_handler.get_fe().n_components ()); + Functions::ConstantFunction test_func (1, dof_handler.get_fe().n_components ()); // don't run this test if hanging // nodes are not implemented diff --git a/tests/dofs/interpolate_based_on_material_id_01.cc b/tests/dofs/interpolate_based_on_material_id_01.cc index 5b68af0e35..ee2ea36d35 100644 --- a/tests/dofs/interpolate_based_on_material_id_01.cc +++ b/tests/dofs/interpolate_based_on_material_id_01.cc @@ -74,7 +74,7 @@ void test () cell->set_material_id(cell->index() % 128); if (functions.find(cell->index() % 128) == functions.end()) functions[cell->index() % 128] - = new ConstantFunction(cell->index() % 128); + = new Functions::ConstantFunction(cell->index() % 128); } for (unsigned int p=1; p<7-dim; ++p) diff --git a/tests/dofs/range_based_for_step-6.cc b/tests/dofs/range_based_for_step-6.cc index 56ec591d76..dfbda9431a 100644 --- a/tests/dofs/range_based_for_step-6.cc +++ b/tests/dofs/range_based_for_step-6.cc @@ -175,7 +175,7 @@ void Step6::setup_system () VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); diff --git a/tests/fail/circular_01.cc b/tests/fail/circular_01.cc index 8e0b1aee47..6a86a01fef 100644 --- a/tests/fail/circular_01.cc +++ b/tests/fail/circular_01.cc @@ -256,7 +256,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/fail/hp-step-14.cc b/tests/fail/hp-step-14.cc index 3f31773aab..961d016f60 100644 --- a/tests/fail/hp-step-14.cc +++ b/tests/fail/hp-step-14.cc @@ -1011,12 +1011,12 @@ namespace Data template struct Exercise_2_3 { - typedef ZeroFunction BoundaryValues; + typedef Functions::ZeroFunction BoundaryValues; - class RightHandSide : public ConstantFunction + class RightHandSide : public Functions::ConstantFunction { public: - RightHandSide () : ConstantFunction (1.) {} + RightHandSide () : Functions::ConstantFunction (1.) {} }; static @@ -1290,13 +1290,13 @@ namespace LaplaceSolver const SmartPointer > dual_functional; virtual void assemble_rhs (Vector &rhs) const; - static const ZeroFunction boundary_values; + static const Functions::ZeroFunction boundary_values; friend class WeightedResidual; }; template - const ZeroFunction DualSolver::boundary_values; + const Functions::ZeroFunction DualSolver::boundary_values; template DualSolver:: diff --git a/tests/fail/hp-step-15.cc b/tests/fail/hp-step-15.cc index 633a6acab8..669b2ebdff 100644 --- a/tests/fail/hp-step-15.cc +++ b/tests/fail/hp-step-15.cc @@ -269,12 +269,12 @@ void MinimizationProblem::assemble_step () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); if (dim == 1) VectorTools::interpolate_boundary_values (dof_handler, 1, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); Vector dummy (residual.size()); MatrixTools::apply_boundary_values (boundary_values, diff --git a/tests/fail/rt_crash_01.cc b/tests/fail/rt_crash_01.cc index c1fcabf97d..ec0a909264 100644 --- a/tests/fail/rt_crash_01.cc +++ b/tests/fail/rt_crash_01.cc @@ -43,7 +43,7 @@ check_this (const DoFHandler &dof_handler) std::string::npos) return; - ConstantFunction test_func (1, dof_handler.get_fe().n_components ()); + Functions::ConstantFunction test_func (1, dof_handler.get_fe().n_components ()); // don't run this test if hanging // nodes are not implemented diff --git a/tests/fe/abf_01.cc b/tests/fe/abf_01.cc index 32fb3a7f78..3f7026c71b 100644 --- a/tests/fe/abf_01.cc +++ b/tests/fe/abf_01.cc @@ -628,7 +628,7 @@ int main (int /*argc*/, char **/*argv*/) hn_constraints.close (); MappingQGeneric<2> map_default(1); project (map_default, *dof_handler, hn_constraints, - QGauss<2> (6), ConstantFunction<2>(1., 2), + QGauss<2> (6), Functions::ConstantFunction<2>(1., 2), solution); EvaluateDerivative (dof_handler, solution); diff --git a/tests/fe/abf_02.cc b/tests/fe/abf_02.cc index 51a93f5cb2..a38001f337 100644 --- a/tests/fe/abf_02.cc +++ b/tests/fe/abf_02.cc @@ -540,7 +540,7 @@ int main () hn_constraints.close (); MappingQGeneric<3> map_default(1); project (map_default, dof_handler, hn_constraints, - QGauss<3> (6), ConstantFunction<3>(1., 3), + QGauss<3> (6), Functions::ConstantFunction<3>(1., 3), solution); EvaluateDerivative (dof_handler, solution); diff --git a/tests/fe/crash_01.cc b/tests/fe/crash_01.cc index cc9f44f509..d0762f74a4 100644 --- a/tests/fe/crash_01.cc +++ b/tests/fe/crash_01.cc @@ -67,7 +67,7 @@ void test(FiniteElement &fe) DoFHandler dof_handler(tria); dof_handler.distribute_dofs (fe); ConstraintMatrix constraints; - ZeroFunction boundary_values(fe.n_components()); + Functions::ZeroFunction boundary_values(fe.n_components()); VectorTools::project_boundary_values_curl_conforming (dof_handler, 0, boundary_values, 0, constraints); } diff --git a/tests/fe/fe_enriched_step-36.cc b/tests/fe/fe_enriched_step-36.cc index 49ce06f498..997d43c2d4 100644 --- a/tests/fe/fe_enriched_step-36.cc +++ b/tests/fe/fe_enriched_step-36.cc @@ -289,7 +289,7 @@ namespace Step36 DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (1), + Functions::ZeroFunction (1), constraints); constraints.close (); diff --git a/tests/fe/fe_enriched_step-36b.cc b/tests/fe/fe_enriched_step-36b.cc index ee46dfab91..4b1e6a5289 100644 --- a/tests/fe/fe_enriched_step-36b.cc +++ b/tests/fe/fe_enriched_step-36b.cc @@ -293,7 +293,7 @@ namespace Step36 DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (2), + Functions::ZeroFunction (2), constraints); constrain_pou_dofs(); constraints.close (); diff --git a/tests/grid/build_triangulation_from_patch_04.cc b/tests/grid/build_triangulation_from_patch_04.cc index 4439f5e6c3..da8af22184 100644 --- a/tests/grid/build_triangulation_from_patch_04.cc +++ b/tests/grid/build_triangulation_from_patch_04.cc @@ -112,4 +112,4 @@ int main() deallog.push("3d"); test<3>(); deallog.pop(); -} \ No newline at end of file +} diff --git a/tests/grid/get_dof_to_support_patch_map_01.cc b/tests/grid/get_dof_to_support_patch_map_01.cc index 4fda987600..a8b9eb9bb7 100644 --- a/tests/grid/get_dof_to_support_patch_map_01.cc +++ b/tests/grid/get_dof_to_support_patch_map_01.cc @@ -185,4 +185,4 @@ int main() deallog.push("3d"); test<3>(); deallog.pop(); -} \ No newline at end of file +} diff --git a/tests/grid/grid_parallelepiped_04.cc b/tests/grid/grid_parallelepiped_04.cc index 9f182d467d..2d333a75e1 100644 --- a/tests/grid/grid_parallelepiped_04.cc +++ b/tests/grid/grid_parallelepiped_04.cc @@ -123,7 +123,7 @@ void check_parallelepiped (bool colorize, bool log, const unsigned int (&subd)[d for (unsigned int c=0; c<6; ++c) VectorTools::interpolate_boundary_values (dh, c, - ConstantFunction(c), + Functions::ConstantFunction(c), constraints); constraints.close(); constraints.distribute(vec); diff --git a/tests/hp/crash_17.cc b/tests/hp/crash_17.cc index 13a60083ef..7a88c45590 100644 --- a/tests/hp/crash_17.cc +++ b/tests/hp/crash_17.cc @@ -256,7 +256,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/crash_18.cc b/tests/hp/crash_18.cc index 502313697b..b62f4630fa 100644 --- a/tests/hp/crash_18.cc +++ b/tests/hp/crash_18.cc @@ -261,7 +261,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/create_laplace_matrix_constraints_02.cc b/tests/hp/create_laplace_matrix_constraints_02.cc index 3766dad882..f240bc4ce6 100644 --- a/tests/hp/create_laplace_matrix_constraints_02.cc +++ b/tests/hp/create_laplace_matrix_constraints_02.cc @@ -88,7 +88,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/hp/create_laplace_matrix_constraints_02b.cc b/tests/hp/create_laplace_matrix_constraints_02b.cc index be6c623e7c..0fe9ca797f 100644 --- a/tests/hp/create_laplace_matrix_constraints_02b.cc +++ b/tests/hp/create_laplace_matrix_constraints_02b.cc @@ -88,7 +88,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/hp/create_mass_matrix_constraints_02.cc b/tests/hp/create_mass_matrix_constraints_02.cc index ba6a99d3fe..e915bfc218 100644 --- a/tests/hp/create_mass_matrix_constraints_02.cc +++ b/tests/hp/create_mass_matrix_constraints_02.cc @@ -88,7 +88,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/hp/create_mass_matrix_constraints_02b.cc b/tests/hp/create_mass_matrix_constraints_02b.cc index 85598586ae..b9af36944e 100644 --- a/tests/hp/create_mass_matrix_constraints_02b.cc +++ b/tests/hp/create_mass_matrix_constraints_02b.cc @@ -88,7 +88,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/hp/create_rhs_01.cc b/tests/hp/create_rhs_01.cc index 12c2731a5f..55fccbcc96 100644 --- a/tests/hp/create_rhs_01.cc +++ b/tests/hp/create_rhs_01.cc @@ -85,7 +85,7 @@ void test () // the sum over the elements of the // resulting rhs vector, you need to get // four - ConstantFunction< 2 > rhs_function(1); + Functions::ConstantFunction< 2 > rhs_function(1); VectorTools::create_boundary_right_hand_side ( hp_dof_handler2, quadrature, diff --git a/tests/hp/fe_nothing_08.cc b/tests/hp/fe_nothing_08.cc index 9c12489e48..51b23c7f8e 100644 --- a/tests/hp/fe_nothing_08.cc +++ b/tests/hp/fe_nothing_08.cc @@ -69,7 +69,7 @@ void test () std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(1), + Functions::ZeroFunction(1), bv); for (std::map::iterator p = bv.begin(); p!=bv.end(); ++p) diff --git a/tests/hp/fe_nothing_09.cc b/tests/hp/fe_nothing_09.cc index e6387d2eaf..4b76f40ded 100644 --- a/tests/hp/fe_nothing_09.cc +++ b/tests/hp/fe_nothing_09.cc @@ -71,7 +71,7 @@ void test () std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(2), + Functions::ZeroFunction(2), bv); for (std::map::iterator p = bv.begin(); p!=bv.end(); ++p) diff --git a/tests/hp/fe_nothing_11.cc b/tests/hp/fe_nothing_11.cc index bc4da89d36..837ad8051f 100644 --- a/tests/hp/fe_nothing_11.cc +++ b/tests/hp/fe_nothing_11.cc @@ -73,7 +73,7 @@ void test () std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(4), + Functions::ZeroFunction(4), bv); for (std::map::iterator p = bv.begin(); p!=bv.end(); ++p) diff --git a/tests/hp/fe_nothing_20.cc b/tests/hp/fe_nothing_20.cc index 93f4946199..9fffdd597f 100644 --- a/tests/hp/fe_nothing_20.cc +++ b/tests/hp/fe_nothing_20.cc @@ -72,7 +72,7 @@ void test () Vector solution(dof_handler.n_dofs()); VectorTools::interpolate(dof_handler, - ZeroFunction(2*dim+1), + Functions::ZeroFunction(2*dim+1), solution); deallog << "l2_norm = " << solution.l2_norm() << std::endl; diff --git a/tests/hp/fe_nothing_21.cc b/tests/hp/fe_nothing_21.cc index 6bd4c389b2..28f6ba5f0f 100644 --- a/tests/hp/fe_nothing_21.cc +++ b/tests/hp/fe_nothing_21.cc @@ -63,7 +63,7 @@ void test () Vector solution(dof_handler.n_dofs()); VectorTools::interpolate(dof_handler, - ZeroFunction(2), + Functions::ZeroFunction(2), solution); deallog << "l2_norm = " << solution.l2_norm() << std::endl; diff --git a/tests/hp/hp_q_hierarchical_constraints.cc b/tests/hp/hp_q_hierarchical_constraints.cc index 4011a54ef8..6537e49321 100644 --- a/tests/hp/hp_q_hierarchical_constraints.cc +++ b/tests/hp/hp_q_hierarchical_constraints.cc @@ -131,4 +131,4 @@ int main (int argc, char *argv[]) test<2>(false,1); test<2>(false,2); #endif -} \ No newline at end of file +} diff --git a/tests/hp/integrate_difference_02.cc b/tests/hp/integrate_difference_02.cc index 3c19acd124..72aa3626ef 100644 --- a/tests/hp/integrate_difference_02.cc +++ b/tests/hp/integrate_difference_02.cc @@ -86,7 +86,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(), + Functions::ZeroFunction(), diff, q_collection, VectorTools::L1_norm); @@ -98,7 +98,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(), + Functions::ZeroFunction(), diff, q_collection, VectorTools::H1_seminorm); @@ -111,7 +111,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(), + Functions::ZeroFunction(), diff, q_collection, VectorTools::W1infty_seminorm); @@ -128,7 +128,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(), + Functions::ZeroFunction(), diff, q_collection, VectorTools::W1infty_norm); diff --git a/tests/hp/integrate_difference_03.cc b/tests/hp/integrate_difference_03.cc index 203827d079..2312d637d9 100644 --- a/tests/hp/integrate_difference_03.cc +++ b/tests/hp/integrate_difference_03.cc @@ -90,7 +90,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(dim), + Functions::ZeroFunction(dim), diff, q_collection, VectorTools::H1_seminorm); @@ -103,7 +103,7 @@ void test () { VectorTools::integrate_difference (dof_handler, vec, - ZeroFunction(dim), + Functions::ZeroFunction(dim), diff, q_collection, VectorTools::W1infty_seminorm); diff --git a/tests/hp/interpolate_nothing_01.cc b/tests/hp/interpolate_nothing_01.cc index 3a9703b262..b2b1854429 100644 --- a/tests/hp/interpolate_nothing_01.cc +++ b/tests/hp/interpolate_nothing_01.cc @@ -61,7 +61,7 @@ void test () // interpolate the function VectorTools::interpolate (dof_handler, - ZeroFunction(hp_fe[0].n_components()), + Functions::ZeroFunction(hp_fe[0].n_components()), interpolant); deallog << interpolant.l2_norm() << std::endl; } diff --git a/tests/hp/interpolate_nothing_02.cc b/tests/hp/interpolate_nothing_02.cc index 4648a6f705..c26d9fe217 100644 --- a/tests/hp/interpolate_nothing_02.cc +++ b/tests/hp/interpolate_nothing_02.cc @@ -221,7 +221,7 @@ void diffusionMechanics::run () //Initial conditions VectorTools::interpolate(dof_handler, InitialConditions(), Un); - // VectorTools::interpolate(dof_handler, ZeroFunction(fe_collection.n_components()), Un); + // VectorTools::interpolate(dof_handler, Functions::ZeroFunction(fe_collection.n_components()), Un); U=Un; U0=Un; diff --git a/tests/hp/interpolate_nothing_03.cc b/tests/hp/interpolate_nothing_03.cc index ad84404317..fceb6db1a4 100644 --- a/tests/hp/interpolate_nothing_03.cc +++ b/tests/hp/interpolate_nothing_03.cc @@ -72,7 +72,7 @@ void test () // interpolate the function VectorTools::interpolate(dof_handler, - ConstantFunction(3.14), + Functions::ConstantFunction(3.14), interpolant); deallog << interpolant.mean_value() << std::endl; } diff --git a/tests/hp/step-11.cc b/tests/hp/step-11.cc index a31c163db2..3b54b73e56 100644 --- a/tests/hp/step-11.cc +++ b/tests/hp/step-11.cc @@ -141,12 +141,12 @@ void LaplaceProblem::assemble_and_solve () system_matrix); VectorTools::create_right_hand_side (mapping, dof_handler, hp::QCollection(QGauss(gauss_degree)), - ConstantFunction(-2), + Functions::ConstantFunction(-2), system_rhs); Vector tmp (system_rhs.size()); VectorTools::create_boundary_right_hand_side (mapping, dof_handler, hp::QCollection(QGauss(gauss_degree)), - ConstantFunction(1), + Functions::ConstantFunction(1), tmp); system_rhs += tmp; @@ -159,7 +159,7 @@ void LaplaceProblem::assemble_and_solve () Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (mapping, dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, hp::QCollection(QGauss(gauss_degree+1)), VectorTools::H1_seminorm); diff --git a/tests/hp/step-27.cc b/tests/hp/step-27.cc index c2d02527a6..6be89653d7 100644 --- a/tests/hp/step-27.cc +++ b/tests/hp/step-27.cc @@ -179,7 +179,7 @@ namespace Step27 constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/tests/hp/step-3.cc b/tests/hp/step-3.cc index e6423d3aa7..6b123facc2 100644 --- a/tests/hp/step-3.cc +++ b/tests/hp/step-3.cc @@ -169,7 +169,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-3a.cc b/tests/hp/step-3a.cc index cbef4b5326..29a245b0ab 100644 --- a/tests/hp/step-3a.cc +++ b/tests/hp/step-3a.cc @@ -209,7 +209,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-3b.cc b/tests/hp/step-3b.cc index 7a067f3896..fc75e3f881 100644 --- a/tests/hp/step-3b.cc +++ b/tests/hp/step-3b.cc @@ -206,7 +206,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-3c.cc b/tests/hp/step-3c.cc index 0e868edf99..748016945e 100644 --- a/tests/hp/step-3c.cc +++ b/tests/hp/step-3c.cc @@ -208,7 +208,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-5.cc b/tests/hp/step-5.cc index 92019d58b8..11ea4bb1af 100644 --- a/tests/hp/step-5.cc +++ b/tests/hp/step-5.cc @@ -224,7 +224,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-6.cc b/tests/hp/step-6.cc index 7473d5ed1b..9d5f71170a 100644 --- a/tests/hp/step-6.cc +++ b/tests/hp/step-6.cc @@ -251,7 +251,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/hp/step-8.cc b/tests/hp/step-8.cc index 064e844cce..931c12f175 100644 --- a/tests/hp/step-8.cc +++ b/tests/hp/step-8.cc @@ -213,7 +213,7 @@ void ElasticProblem::assemble_system () std::vector lambda_values (n_q_points); std::vector mu_values (n_q_points); - ConstantFunction lambda(1.), mu(1.); + Functions::ConstantFunction lambda(1.), mu(1.); RightHandSide right_hand_side; std::vector > rhs_values (n_q_points, @@ -301,7 +301,7 @@ void ElasticProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(dim), + Functions::ZeroFunction(dim), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/lac/block_matrices_04.cc b/tests/lac/block_matrices_04.cc index 383b875431..f93d824d17 100644 --- a/tests/lac/block_matrices_04.cc +++ b/tests/lac/block_matrices_04.cc @@ -309,7 +309,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2,typename VectorType::value_type>(), + Functions::ZeroFunction<2,typename VectorType::value_type>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/lac/constrained_linear_operator_01.cc b/tests/lac/constrained_linear_operator_01.cc index ef7d18c223..309b38651d 100644 --- a/tests/lac/constrained_linear_operator_01.cc +++ b/tests/lac/constrained_linear_operator_01.cc @@ -108,7 +108,7 @@ void Step6::setup_system () constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.), + Functions::ConstantFunction(1.), constraints); constraints.close (); diff --git a/tests/lac/constraints_hanging_nodes_bc.cc b/tests/lac/constraints_hanging_nodes_bc.cc index 63b3bec985..c25df9ea8a 100644 --- a/tests/lac/constraints_hanging_nodes_bc.cc +++ b/tests/lac/constraints_hanging_nodes_bc.cc @@ -78,7 +78,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof, 0, - ConstantFunction(1.), + Functions::ConstantFunction(1.), boundary_values); std::map::const_iterator boundary_value = boundary_values.begin(); @@ -100,7 +100,7 @@ void test () << "Total number of constraints: " << correct_constraints.n_constraints() << std::endl; - VectorTools::interpolate_boundary_values (dof, 0, ConstantFunction(1.), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ConstantFunction(1.), library_constraints); library_constraints.close(); diff --git a/tests/lac/constraints_local_to_global.cc b/tests/lac/constraints_local_to_global.cc index 41211c8561..7fa0be7919 100644 --- a/tests/lac/constraints_local_to_global.cc +++ b/tests/lac/constraints_local_to_global.cc @@ -57,7 +57,7 @@ void test () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); - VectorTools::interpolate_boundary_values (dof, 1, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 1, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/lac/constraints_local_to_global_chunk.cc b/tests/lac/constraints_local_to_global_chunk.cc index 29ff294a6a..30cfef7906 100644 --- a/tests/lac/constraints_local_to_global_chunk.cc +++ b/tests/lac/constraints_local_to_global_chunk.cc @@ -59,7 +59,7 @@ void test (unsigned int chunk_size) ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); - VectorTools::interpolate_boundary_values (dof, 1, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 1, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/lac/diagonal_matrix_02.cc b/tests/lac/diagonal_matrix_02.cc index 811efcb31b..ec3e1ec7c4 100644 --- a/tests/lac/diagonal_matrix_02.cc +++ b/tests/lac/diagonal_matrix_02.cc @@ -66,7 +66,7 @@ void test (const bool hanging_nodes = true) ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/lac/inhomogeneous_constraints_block.cc b/tests/lac/inhomogeneous_constraints_block.cc index 9b99340855..0e73f89356 100644 --- a/tests/lac/inhomogeneous_constraints_block.cc +++ b/tests/lac/inhomogeneous_constraints_block.cc @@ -134,7 +134,7 @@ void AdvectionProblem::setup_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), boundary_values); std::map::const_iterator boundary_value = boundary_values.begin(); @@ -316,7 +316,7 @@ void AdvectionProblem::assemble_reference () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), boundary_values); MatrixTools::apply_boundary_values (boundary_values, reference_matrix, diff --git a/tests/lac/inhomogeneous_constraints_vector.cc b/tests/lac/inhomogeneous_constraints_vector.cc index 66536bd760..9a6b3d3427 100644 --- a/tests/lac/inhomogeneous_constraints_vector.cc +++ b/tests/lac/inhomogeneous_constraints_vector.cc @@ -143,7 +143,7 @@ void LaplaceProblem::setup_system () constraints.clear(); VectorTools::interpolate_boundary_values (dof_handler, 0, - ConstantFunction(1), + Functions::ConstantFunction(1), constraints); constraints.close(); sparsity_pattern.reinit (dof_handler.n_dofs(), diff --git a/tests/lac/schur_complement_05.cc b/tests/lac/schur_complement_05.cc index 5349464af4..70e6bdf0f3 100644 --- a/tests/lac/schur_complement_05.cc +++ b/tests/lac/schur_complement_05.cc @@ -345,12 +345,12 @@ namespace Step22 #endif VectorTools::interpolate_boundary_values (dof_handler, 0, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 1, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); diff --git a/tests/lac/solver_relaxation_04.cc b/tests/lac/solver_relaxation_04.cc index 7ff2a0d34b..b5285c976b 100644 --- a/tests/lac/solver_relaxation_04.cc +++ b/tests/lac/solver_relaxation_04.cc @@ -134,4 +134,4 @@ int main() } } } -} \ No newline at end of file +} diff --git a/tests/lac/utilities_02.cc b/tests/lac/utilities_02.cc index 9f4792eacf..7d6cb59cd7 100644 --- a/tests/lac/utilities_02.cc +++ b/tests/lac/utilities_02.cc @@ -97,7 +97,7 @@ void test () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction (), + Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/manifold/spherical_manifold_03.cc b/tests/manifold/spherical_manifold_03.cc index 69ad0492bb..1400be0528 100644 --- a/tests/manifold/spherical_manifold_03.cc +++ b/tests/manifold/spherical_manifold_03.cc @@ -36,4 +36,4 @@ main() Point<3>(1, 0, 0)) << std::endl << manifold.get_tangent_vector (Point<3>(0, 0, -1), Point<3>(0, 1, 0)) << std::endl; -} \ No newline at end of file +} diff --git a/tests/mappings/mapping_manifold_step-3.cc b/tests/mappings/mapping_manifold_step-3.cc index 3c74c244d0..cd29523cbe 100644 --- a/tests/mappings/mapping_manifold_step-3.cc +++ b/tests/mappings/mapping_manifold_step-3.cc @@ -171,7 +171,7 @@ void LaplaceProblem::assemble_system () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), boundary_values); MatrixTools::apply_boundary_values (boundary_values, system_matrix, diff --git a/tests/matrix_free/compress_constraints.cc b/tests/matrix_free/compress_constraints.cc index dbf99560b0..a73a388b71 100644 --- a/tests/matrix_free/compress_constraints.cc +++ b/tests/matrix_free/compress_constraints.cc @@ -70,7 +70,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/copy.cc b/tests/matrix_free/copy.cc index c111380381..1f27795c1a 100644 --- a/tests/matrix_free/copy.cc +++ b/tests/matrix_free/copy.cc @@ -68,7 +68,7 @@ void sub_test() dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/get_functions_float.cc b/tests/matrix_free/get_functions_float.cc index 626f733157..963388e78f 100644 --- a/tests/matrix_free/get_functions_float.cc +++ b/tests/matrix_free/get_functions_float.cc @@ -55,7 +55,7 @@ void test () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); - VectorTools::interpolate_boundary_values (dof, 1, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 1, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/get_values_plain.cc b/tests/matrix_free/get_values_plain.cc index 18d137a5f9..2ebdee7538 100644 --- a/tests/matrix_free/get_values_plain.cc +++ b/tests/matrix_free/get_values_plain.cc @@ -162,7 +162,7 @@ void test () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 1, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 1, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/laplace_operator_01.cc b/tests/matrix_free/laplace_operator_01.cc index c9f9c40159..086b5443d9 100644 --- a/tests/matrix_free/laplace_operator_01.cc +++ b/tests/matrix_free/laplace_operator_01.cc @@ -87,7 +87,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/laplace_operator_02.cc b/tests/matrix_free/laplace_operator_02.cc index 7a12bbb0ba..c3f54efcb5 100644 --- a/tests/matrix_free/laplace_operator_02.cc +++ b/tests/matrix_free/laplace_operator_02.cc @@ -131,7 +131,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/mass_operator_01.cc b/tests/matrix_free/mass_operator_01.cc index 1969332a3c..8c0599bd8d 100644 --- a/tests/matrix_free/mass_operator_01.cc +++ b/tests/matrix_free/mass_operator_01.cc @@ -95,7 +95,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/mass_operator_02.cc b/tests/matrix_free/mass_operator_02.cc index c97528bb57..696392a521 100644 --- a/tests/matrix_free/mass_operator_02.cc +++ b/tests/matrix_free/mass_operator_02.cc @@ -59,7 +59,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/mass_operator_04.cc b/tests/matrix_free/mass_operator_04.cc index 9faee0c460..114bd72880 100644 --- a/tests/matrix_free/mass_operator_04.cc +++ b/tests/matrix_free/mass_operator_04.cc @@ -52,7 +52,7 @@ void test () DoFTools::extract_locally_relevant_dofs (dof, relevant_set); ConstraintMatrix constraints_0 (relevant_set), constraints_1(relevant_set); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints_0); constraints_0.close(); constraints_1.close(); diff --git a/tests/matrix_free/matrix_vector_02.cc b/tests/matrix_free/matrix_vector_02.cc index 0201494631..8bacef225d 100644 --- a/tests/matrix_free/matrix_vector_02.cc +++ b/tests/matrix_free/matrix_vector_02.cc @@ -39,7 +39,7 @@ void test () DoFHandler dof (tria); dof.distribute_dofs(fe); ConstraintMatrix constraints; - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_03.cc b/tests/matrix_free/matrix_vector_03.cc index 9bf389ffa0..0e2d1ca320 100644 --- a/tests/matrix_free/matrix_vector_03.cc +++ b/tests/matrix_free/matrix_vector_03.cc @@ -67,7 +67,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_06.cc b/tests/matrix_free/matrix_vector_06.cc index be346f8ad0..208b4d4e0c 100644 --- a/tests/matrix_free/matrix_vector_06.cc +++ b/tests/matrix_free/matrix_vector_06.cc @@ -66,7 +66,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_06_notempl.cc b/tests/matrix_free/matrix_vector_06_notempl.cc index 1772e8db0b..aa6efce533 100644 --- a/tests/matrix_free/matrix_vector_06_notempl.cc +++ b/tests/matrix_free/matrix_vector_06_notempl.cc @@ -62,7 +62,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_07.cc b/tests/matrix_free/matrix_vector_07.cc index b2c39699c8..f1fd90a9e0 100644 --- a/tests/matrix_free/matrix_vector_07.cc +++ b/tests/matrix_free/matrix_vector_07.cc @@ -84,7 +84,7 @@ void test () // only interior DoFs on the elements, but try // anyway DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_08.cc b/tests/matrix_free/matrix_vector_08.cc index d597b818f2..77393333b9 100644 --- a/tests/matrix_free/matrix_vector_08.cc +++ b/tests/matrix_free/matrix_vector_08.cc @@ -65,7 +65,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_09.cc b/tests/matrix_free/matrix_vector_09.cc index 1b90a7e0a8..d4e1a018c0 100644 --- a/tests/matrix_free/matrix_vector_09.cc +++ b/tests/matrix_free/matrix_vector_09.cc @@ -64,7 +64,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_10.cc b/tests/matrix_free/matrix_vector_10.cc index 47b53b6862..704b236039 100644 --- a/tests/matrix_free/matrix_vector_10.cc +++ b/tests/matrix_free/matrix_vector_10.cc @@ -95,7 +95,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_11.cc b/tests/matrix_free/matrix_vector_11.cc index 4ee2ad4db1..101a27d724 100644 --- a/tests/matrix_free/matrix_vector_11.cc +++ b/tests/matrix_free/matrix_vector_11.cc @@ -88,7 +88,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_12.cc b/tests/matrix_free/matrix_vector_12.cc index 61b74e9537..e168f499c8 100644 --- a/tests/matrix_free/matrix_vector_12.cc +++ b/tests/matrix_free/matrix_vector_12.cc @@ -150,7 +150,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_13.cc b/tests/matrix_free/matrix_vector_13.cc index 0e8b6a2e23..108e626e6a 100644 --- a/tests/matrix_free/matrix_vector_13.cc +++ b/tests/matrix_free/matrix_vector_13.cc @@ -150,7 +150,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_15.cc b/tests/matrix_free/matrix_vector_15.cc index 97273c2172..3eeae85c25 100644 --- a/tests/matrix_free/matrix_vector_15.cc +++ b/tests/matrix_free/matrix_vector_15.cc @@ -205,7 +205,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_16.cc b/tests/matrix_free/matrix_vector_16.cc index 445cb60593..1476128691 100644 --- a/tests/matrix_free/matrix_vector_16.cc +++ b/tests/matrix_free/matrix_vector_16.cc @@ -210,7 +210,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(dim), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(dim), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_17.cc b/tests/matrix_free/matrix_vector_17.cc index 50ba2cb34e..22f8b04c9b 100644 --- a/tests/matrix_free/matrix_vector_17.cc +++ b/tests/matrix_free/matrix_vector_17.cc @@ -60,7 +60,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_18.cc b/tests/matrix_free/matrix_vector_18.cc index e5ac787b1b..aff7123e99 100644 --- a/tests/matrix_free/matrix_vector_18.cc +++ b/tests/matrix_free/matrix_vector_18.cc @@ -228,7 +228,7 @@ void test () dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_19.cc b/tests/matrix_free/matrix_vector_19.cc index 9c15bf9830..bf72ae3e85 100644 --- a/tests/matrix_free/matrix_vector_19.cc +++ b/tests/matrix_free/matrix_vector_19.cc @@ -85,7 +85,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_20.cc b/tests/matrix_free/matrix_vector_20.cc index 10cffd2cb3..7903107474 100644 --- a/tests/matrix_free/matrix_vector_20.cc +++ b/tests/matrix_free/matrix_vector_20.cc @@ -154,7 +154,7 @@ void test () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_21.cc b/tests/matrix_free/matrix_vector_21.cc index 762d330161..8d95f1fc44 100644 --- a/tests/matrix_free/matrix_vector_21.cc +++ b/tests/matrix_free/matrix_vector_21.cc @@ -145,7 +145,7 @@ void test () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_22.cc b/tests/matrix_free/matrix_vector_22.cc index b6794cfbf5..d525616d03 100644 --- a/tests/matrix_free/matrix_vector_22.cc +++ b/tests/matrix_free/matrix_vector_22.cc @@ -151,7 +151,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_23.cc b/tests/matrix_free/matrix_vector_23.cc index d19f288324..80cb8d9455 100644 --- a/tests/matrix_free/matrix_vector_23.cc +++ b/tests/matrix_free/matrix_vector_23.cc @@ -162,7 +162,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_hp.cc b/tests/matrix_free/matrix_vector_hp.cc index 32aa9e21b2..2ef2865924 100644 --- a/tests/matrix_free/matrix_vector_hp.cc +++ b/tests/matrix_free/matrix_vector_hp.cc @@ -155,7 +155,7 @@ void test () constraints); VectorTools::interpolate_boundary_values (dof, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); DynamicSparsityPattern csp (dof.n_dofs(), diff --git a/tests/matrix_free/matrix_vector_large_degree_02.cc b/tests/matrix_free/matrix_vector_large_degree_02.cc index 7f46d2a1c0..ccd4f65d7d 100644 --- a/tests/matrix_free/matrix_vector_large_degree_02.cc +++ b/tests/matrix_free/matrix_vector_large_degree_02.cc @@ -73,7 +73,7 @@ void test () ConstraintMatrix constraints (relevant_set); DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/matrix_vector_mg.cc b/tests/matrix_free/matrix_vector_mg.cc index 57341791a6..77756ec28e 100644 --- a/tests/matrix_free/matrix_vector_mg.cc +++ b/tests/matrix_free/matrix_vector_mg.cc @@ -56,7 +56,7 @@ void test () ConstraintMatrix constraints; VectorTools::interpolate_boundary_values (dof, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); @@ -91,7 +91,7 @@ void test () mg_ref_matrices.resize (0, nlevels-1); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; std::vector > boundary_indices(nlevels); MGTools::make_boundary_list (dof, dirichlet_boundary, boundary_indices); diff --git a/tests/matrix_free/parallel_multigrid.cc b/tests/matrix_free/parallel_multigrid.cc index d01c5e6e8c..728c54334d 100644 --- a/tests/matrix_free/parallel_multigrid.cc +++ b/tests/matrix_free/parallel_multigrid.cc @@ -64,7 +64,7 @@ public: // extract the constraints due to Dirichlet boundary conditions ConstraintMatrix constraints; - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type functions; for (std::set::const_iterator it=dirichlet_boundaries.begin(); it != dirichlet_boundaries.end(); ++it) diff --git a/tests/matrix_free/parallel_multigrid_02.cc b/tests/matrix_free/parallel_multigrid_02.cc index 84db5993b5..ae549cfd68 100644 --- a/tests/matrix_free/parallel_multigrid_02.cc +++ b/tests/matrix_free/parallel_multigrid_02.cc @@ -92,7 +92,7 @@ void do_test (const DoFHandler &dof) DoFTools::extract_locally_relevant_dofs(dof, locally_relevant_dofs); // Dirichlet BC - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_01.cc b/tests/matrix_free/parallel_multigrid_adaptive_01.cc index bfd6eb2d4f..06c17e8639 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_01.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_01.cc @@ -452,7 +452,7 @@ void do_test (const DoFHandler &dof) hanging_node_constraints.close(); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(dof, dirichlet_boundary); diff --git a/tests/matrix_free/parallel_multigrid_adaptive_02.cc b/tests/matrix_free/parallel_multigrid_adaptive_02.cc index f59a080187..006d586259 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_02.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_02.cc @@ -129,7 +129,7 @@ void do_test (const DoFHandler &dof) DoFTools::extract_locally_relevant_dofs(dof, locally_relevant_dofs); // Dirichlet BC - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_03.cc b/tests/matrix_free/parallel_multigrid_adaptive_03.cc index 556709b584..259e07c9b1 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_03.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_03.cc @@ -449,7 +449,7 @@ void do_test (const DoFHandler &dof, const bool threaded) hanging_node_constraints.close(); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(dof, dirichlet_boundary); diff --git a/tests/matrix_free/parallel_multigrid_adaptive_04.cc b/tests/matrix_free/parallel_multigrid_adaptive_04.cc index 155dca3805..43c2b9b0bf 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_04.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_04.cc @@ -129,7 +129,7 @@ void do_test (const DoFHandler &dof) DoFTools::extract_locally_relevant_dofs(dof, locally_relevant_dofs); // Dirichlet BC - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_05.cc b/tests/matrix_free/parallel_multigrid_adaptive_05.cc index 3c811fc2e6..bc784d3b4b 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_05.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_05.cc @@ -446,7 +446,7 @@ void do_test (const DoFHandler &dof, const bool threaded) hanging_node_constraints.close(); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(dof, dirichlet_boundary); diff --git a/tests/matrix_free/parallel_multigrid_mf.cc b/tests/matrix_free/parallel_multigrid_mf.cc index 27b8baca8b..a7a36a0193 100644 --- a/tests/matrix_free/parallel_multigrid_mf.cc +++ b/tests/matrix_free/parallel_multigrid_mf.cc @@ -63,7 +63,7 @@ public: // extract the constraints due to Dirichlet boundary conditions ConstraintMatrix constraints; - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type functions; for (std::set::const_iterator it=dirichlet_boundaries.begin(); it != dirichlet_boundaries.end(); ++it) @@ -334,7 +334,7 @@ void do_test (const DoFHandler &dof) } MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(dof, dirichlet_boundary); diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index 2a6d74eb26..ab5b236729 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -403,7 +403,7 @@ namespace Step37 constraints.clear(); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close(); @@ -416,7 +416,7 @@ namespace Step37 mg_constraints.resize (0, nlevels-1); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; std::vector > boundary_indices(triangulation.n_levels()); MGTools::make_boundary_list (dof_handler, diff --git a/tests/matrix_free/step-48.cc b/tests/matrix_free/step-48.cc index 31035a2191..78845ef363 100644 --- a/tests/matrix_free/step-48.cc +++ b/tests/matrix_free/step-48.cc @@ -316,7 +316,7 @@ namespace Step48 Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(fe_degree+1), VectorTools::L2_norm); diff --git a/tests/matrix_free/step-48b.cc b/tests/matrix_free/step-48b.cc index 71b23ca09c..6b00166c5d 100644 --- a/tests/matrix_free/step-48b.cc +++ b/tests/matrix_free/step-48b.cc @@ -282,7 +282,7 @@ namespace Step48 Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(fe_degree+1), VectorTools::L2_norm); diff --git a/tests/matrix_free/step-48c.cc b/tests/matrix_free/step-48c.cc index 0f37d312e3..c4981885c7 100644 --- a/tests/matrix_free/step-48c.cc +++ b/tests/matrix_free/step-48c.cc @@ -287,7 +287,7 @@ namespace Step48 Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(fe_degree+1), VectorTools::L2_norm); diff --git a/tests/matrix_free/thread_correctness.cc b/tests/matrix_free/thread_correctness.cc index 093550fd7d..02b1544290 100644 --- a/tests/matrix_free/thread_correctness.cc +++ b/tests/matrix_free/thread_correctness.cc @@ -71,7 +71,7 @@ void sub_test() dof.distribute_dofs(fe); ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints(dof, constraints); - VectorTools::interpolate_boundary_values (dof, 0, ZeroFunction(), + VectorTools::interpolate_boundary_values (dof, 0, Functions::ZeroFunction(), constraints); constraints.close(); diff --git a/tests/matrix_free/thread_correctness_hp.cc b/tests/matrix_free/thread_correctness_hp.cc index 35b5b80182..41a1a1412c 100644 --- a/tests/matrix_free/thread_correctness_hp.cc +++ b/tests/matrix_free/thread_correctness_hp.cc @@ -131,7 +131,7 @@ void do_test (const unsigned int parallel_option) constraints); VectorTools::interpolate_boundary_values (dof, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/tests/mpi/constraint_matrix_trilinos_bug.cc b/tests/mpi/constraint_matrix_trilinos_bug.cc index 7eea9ce2ae..a383d4a2e9 100644 --- a/tests/mpi/constraint_matrix_trilinos_bug.cc +++ b/tests/mpi/constraint_matrix_trilinos_bug.cc @@ -96,7 +96,7 @@ void test() VectorTools::interpolate_boundary_values (dofh, 0, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), cm, velocity_mask); diff --git a/tests/mpi/data_out_faces_01.cc b/tests/mpi/data_out_faces_01.cc index be8982059c..c783d64856 100644 --- a/tests/mpi/data_out_faces_01.cc +++ b/tests/mpi/data_out_faces_01.cc @@ -114,7 +114,7 @@ namespace pdd constraints.clear (); constraints.reinit (locally_relevant_dofs); DoFTools::make_hanging_node_constraints (dof_handler,constraints); - VectorTools::interpolate_boundary_values (dof_handler, 0, ConstantFunction (1.0), constraints); + VectorTools::interpolate_boundary_values (dof_handler, 0, Functions::ConstantFunction (1.0), constraints); constraints.close (); constraints.distribute(locally_relevant_solution); } diff --git a/tests/mpi/integrate_difference.cc b/tests/mpi/integrate_difference.cc index a69d37434c..bfb1bf4485 100644 --- a/tests/mpi/integrate_difference.cc +++ b/tests/mpi/integrate_difference.cc @@ -80,7 +80,7 @@ void test() // ones printed in the output are correct Vector results (tr.n_active_cells()); VectorTools::integrate_difference (dofh, x_rel, - ZeroFunction(), + Functions::ZeroFunction(), results, QGauss(3), VectorTools::L2_norm); diff --git a/tests/mpi/interpolate_01.cc b/tests/mpi/interpolate_01.cc index e4d199738b..0380648ebf 100644 --- a/tests/mpi/interpolate_01.cc +++ b/tests/mpi/interpolate_01.cc @@ -65,7 +65,7 @@ void test() x.reinit(owned_set, MPI_COMM_WORLD); VectorTools::interpolate(dofh, - ConstantFunction(1), + Functions::ConstantFunction(1), x); const double norm = x.l2_norm(); if (myid == 0) diff --git a/tests/mpi/interpolate_02.cc b/tests/mpi/interpolate_02.cc index 20fbf978c0..39847c9631 100644 --- a/tests/mpi/interpolate_02.cc +++ b/tests/mpi/interpolate_02.cc @@ -64,7 +64,7 @@ void test() PETScWrappers::MPI::Vector x (MPI_COMM_WORLD,dofh.n_dofs(),owned_set.n_elements()); VectorTools::interpolate(dofh, - ConstantFunction(1), + Functions::ConstantFunction(1), x); const double norm = x.l2_norm(); if (myid == 0) diff --git a/tests/mpi/interpolate_to_different_mesh_02.cc b/tests/mpi/interpolate_to_different_mesh_02.cc index 995676749b..f5adaee997 100644 --- a/tests/mpi/interpolate_to_different_mesh_02.cc +++ b/tests/mpi/interpolate_to_different_mesh_02.cc @@ -117,7 +117,7 @@ void SeventhProblem::setup_system () DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); DynamicSparsityPattern csp (locally_relevant_dofs); diff --git a/tests/mpi/muelu_periodicity.cc b/tests/mpi/muelu_periodicity.cc index d21c1e235c..9732119c3f 100644 --- a/tests/mpi/muelu_periodicity.cc +++ b/tests/mpi/muelu_periodicity.cc @@ -342,12 +342,12 @@ namespace Step22 #endif VectorTools::interpolate_boundary_values (dof_handler, 0, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 1, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); diff --git a/tests/mpi/multigrid_adaptive.cc b/tests/mpi/multigrid_adaptive.cc index cc9341184a..cae2f2e498 100644 --- a/tests/mpi/multigrid_adaptive.cc +++ b/tests/mpi/multigrid_adaptive.cc @@ -186,7 +186,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (static_cast&>(mg_dof_handler), dirichlet_boundary, diff --git a/tests/mpi/multigrid_uniform.cc b/tests/mpi/multigrid_uniform.cc index d30f2246b7..61c5e17eca 100644 --- a/tests/mpi/multigrid_uniform.cc +++ b/tests/mpi/multigrid_uniform.cc @@ -186,7 +186,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (static_cast&>(mg_dof_handler), dirichlet_boundary, diff --git a/tests/mpi/p4est_2d_constraintmatrix_03.cc b/tests/mpi/p4est_2d_constraintmatrix_03.cc index e2eabab948..4a95eb9c4d 100644 --- a/tests/mpi/p4est_2d_constraintmatrix_03.cc +++ b/tests/mpi/p4est_2d_constraintmatrix_03.cc @@ -155,7 +155,7 @@ void test() VectorTools::interpolate_boundary_values (dofh, 0, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), cm, velocity_mask); diff --git a/tests/mpi/p4est_2d_constraintmatrix_04.cc b/tests/mpi/p4est_2d_constraintmatrix_04.cc index c550584dc3..d3c33607d5 100644 --- a/tests/mpi/p4est_2d_constraintmatrix_04.cc +++ b/tests/mpi/p4est_2d_constraintmatrix_04.cc @@ -266,7 +266,7 @@ void test() VectorTools::interpolate_boundary_values (dofh, 0, - ZeroFunction(1), + Functions::ZeroFunction(1), cm, velocity_mask); */ diff --git a/tests/mpi/p4est_2d_constraintmatrix_05.cc b/tests/mpi/p4est_2d_constraintmatrix_05.cc index 8265aa85b3..70d49e1555 100644 --- a/tests/mpi/p4est_2d_constraintmatrix_05.cc +++ b/tests/mpi/p4est_2d_constraintmatrix_05.cc @@ -57,7 +57,7 @@ void test() TrilinosWrappers::MPI::Vector x_ref; x_ref.reinit(owned_set, MPI_COMM_WORLD); VectorTools::interpolate(dofh, - ConstantFunction (1.), + Functions::ConstantFunction (1.), x_ref); TrilinosWrappers::MPI::Vector x1 (x_ref); diff --git a/tests/mpi/p4est_3d_constraintmatrix_03.cc b/tests/mpi/p4est_3d_constraintmatrix_03.cc index ee176ba69d..ec62c77331 100644 --- a/tests/mpi/p4est_3d_constraintmatrix_03.cc +++ b/tests/mpi/p4est_3d_constraintmatrix_03.cc @@ -261,7 +261,7 @@ void test() VectorTools::interpolate_boundary_values (dofh, 0, - ZeroFunction(1), + Functions::ZeroFunction(1), cm, velocity_mask); */ diff --git a/tests/mpi/parallel_vector_back_interpolate.cc b/tests/mpi/parallel_vector_back_interpolate.cc index 3111c41eb7..062c327f10 100644 --- a/tests/mpi/parallel_vector_back_interpolate.cc +++ b/tests/mpi/parallel_vector_back_interpolate.cc @@ -62,7 +62,7 @@ void test () v2_interpolated(v2); // set first vector to 1 - VectorTools::interpolate(dof2, ConstantFunction(1.), v2); + VectorTools::interpolate(dof2, Functions::ConstantFunction(1.), v2); for (unsigned int i=0; i(1.), v1); + VectorTools::interpolate(dof1, Functions::ConstantFunction(1.), v1); for (unsigned int i=0; i(), + Functions::ZeroFunction(), constraints); DoFTools::make_hanging_node_constraints (dof_handler, constraints); constraints.close (); diff --git a/tests/mpi/periodicity_02.cc b/tests/mpi/periodicity_02.cc index 5507ffb9a1..79ec6cabb0 100644 --- a/tests/mpi/periodicity_02.cc +++ b/tests/mpi/periodicity_02.cc @@ -343,12 +343,12 @@ namespace Step22 #endif VectorTools::interpolate_boundary_values (dof_handler, 0, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 1, - BoundaryValues(),//ZeroFunction(dim+1), + BoundaryValues(),//Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); diff --git a/tests/mpi/periodicity_03.cc b/tests/mpi/periodicity_03.cc index b059784926..4f1d3c7ffc 100644 --- a/tests/mpi/periodicity_03.cc +++ b/tests/mpi/periodicity_03.cc @@ -282,25 +282,25 @@ namespace Step22 VectorTools::interpolate_boundary_values (dof_handler, 1, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 2, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 3, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); VectorTools::interpolate_boundary_values (dof_handler, 5, - ZeroFunction(dim+1), + Functions::ZeroFunction(dim+1), constraints, fe.component_mask(velocities)); } diff --git a/tests/mpi/step-40.cc b/tests/mpi/step-40.cc index 9dcf1636a8..42dfea81cc 100644 --- a/tests/mpi/step-40.cc +++ b/tests/mpi/step-40.cc @@ -144,7 +144,7 @@ namespace Step40 DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/tests/mpi/step-40_direct_solver.cc b/tests/mpi/step-40_direct_solver.cc index 15b5ce0106..f6a08b6084 100644 --- a/tests/mpi/step-40_direct_solver.cc +++ b/tests/mpi/step-40_direct_solver.cc @@ -144,7 +144,7 @@ namespace Step40 DoFTools::make_hanging_node_constraints (dof_handler, constraints); VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(), + Functions::ZeroFunction(), constraints); constraints.close (); diff --git a/tests/mpi/trilinos_distribute_04.cc b/tests/mpi/trilinos_distribute_04.cc index fa020c6741..5f0a065c92 100644 --- a/tests/mpi/trilinos_distribute_04.cc +++ b/tests/mpi/trilinos_distribute_04.cc @@ -85,7 +85,7 @@ void test() DoFTools::make_hanging_node_constraints (dofh, cm); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (dofh, dirichlet_boundary, diff --git a/tests/multigrid/boundary_01.cc b/tests/multigrid/boundary_01.cc index e1cecb887f..ff3a87fd76 100644 --- a/tests/multigrid/boundary_01.cc +++ b/tests/multigrid/boundary_01.cc @@ -57,7 +57,7 @@ void check_fe(FiniteElement &fe) Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); diff --git a/tests/multigrid/constrained_dofs_01.cc b/tests/multigrid/constrained_dofs_01.cc index 51ca1f5943..a17f4bd6ba 100644 --- a/tests/multigrid/constrained_dofs_01.cc +++ b/tests/multigrid/constrained_dofs_01.cc @@ -63,7 +63,7 @@ void check_fe(FiniteElement &fe) parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); @@ -109,7 +109,7 @@ void check_fe(FiniteElement &fe) } typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; mg_constrained_dofs_ref.initialize(dofhref, dirichlet_boundary); } @@ -119,7 +119,7 @@ void check_fe(FiniteElement &fe) MGConstrainedDoFs mg_constrained_dofs; typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; mg_constrained_dofs.initialize(dofh, dirichlet_boundary); diff --git a/tests/multigrid/constrained_dofs_02.cc b/tests/multigrid/constrained_dofs_02.cc index 05a44f2b0f..6475f40ce7 100644 --- a/tests/multigrid/constrained_dofs_02.cc +++ b/tests/multigrid/constrained_dofs_02.cc @@ -119,7 +119,7 @@ void check_fe(FiniteElement &fe) parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); @@ -165,7 +165,7 @@ void check_fe(FiniteElement &fe) } typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; mg_constrained_dofs_ref.initialize(dofhref, dirichlet_boundary); } @@ -175,7 +175,7 @@ void check_fe(FiniteElement &fe) MGConstrainedDoFs mg_constrained_dofs; typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; mg_constrained_dofs.initialize(dofh, dirichlet_boundary); diff --git a/tests/multigrid/dof_01.cc b/tests/multigrid/dof_01.cc index b1c292d037..c603ce93b5 100644 --- a/tests/multigrid/dof_01.cc +++ b/tests/multigrid/dof_01.cc @@ -69,7 +69,7 @@ void check_fe(FiniteElement &fe) Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); diff --git a/tests/multigrid/dof_02.cc b/tests/multigrid/dof_02.cc index d3e4aba505..f007185636 100644 --- a/tests/multigrid/dof_02.cc +++ b/tests/multigrid/dof_02.cc @@ -74,7 +74,7 @@ void check_fe(FiniteElement &fe) Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); diff --git a/tests/multigrid/mg_coarse_01.cc b/tests/multigrid/mg_coarse_01.cc index 8dfc8f97f7..9ef6434408 100644 --- a/tests/multigrid/mg_coarse_01.cc +++ b/tests/multigrid/mg_coarse_01.cc @@ -202,7 +202,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ConstantFunction homogeneous_dirichlet_bc (0.0); + Functions::ConstantFunction homogeneous_dirichlet_bc (0.0); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/mg_output_dirichlet.cc b/tests/multigrid/mg_output_dirichlet.cc index ebc3dfc59e..a74a9bea82 100644 --- a/tests/multigrid/mg_output_dirichlet.cc +++ b/tests/multigrid/mg_output_dirichlet.cc @@ -194,7 +194,7 @@ void check_simple(const FiniteElement &fe) Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr,-1,1); typename FunctionMap::type dirichlet_boundary_functions; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary_functions[0] = &homogeneous_dirichlet_bc; tr.refine_global (1); diff --git a/tests/multigrid/mg_renumbered_01.cc b/tests/multigrid/mg_renumbered_01.cc index d6a413b80f..e21b0c4e30 100644 --- a/tests/multigrid/mg_renumbered_01.cc +++ b/tests/multigrid/mg_renumbered_01.cc @@ -323,7 +323,7 @@ template void LaplaceProblem::test () { typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[0] = &dirichlet_bc; const unsigned int min_l = mg_matrices.min_level(); diff --git a/tests/multigrid/mg_renumbered_02.cc b/tests/multigrid/mg_renumbered_02.cc index 40006271e8..7416ecc70c 100644 --- a/tests/multigrid/mg_renumbered_02.cc +++ b/tests/multigrid/mg_renumbered_02.cc @@ -275,7 +275,7 @@ template void LaplaceProblem::test_boundary () { typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[0] = &dirichlet_bc; MGTools::make_boundary_list (mg_dof_handler_renumbered, dirichlet_boundary, boundary_indices_renumbered); diff --git a/tests/multigrid/mg_renumbered_03.cc b/tests/multigrid/mg_renumbered_03.cc index 56a047b0a9..22cb38abc2 100644 --- a/tests/multigrid/mg_renumbered_03.cc +++ b/tests/multigrid/mg_renumbered_03.cc @@ -326,7 +326,7 @@ template void LaplaceProblem::test () { typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[0] = &dirichlet_bc; MGConstrainedDoFs mg_constrained_dofs; diff --git a/tests/multigrid/step-16-02.cc b/tests/multigrid/step-16-02.cc index 45528dcbf4..0b3ff42911 100644 --- a/tests/multigrid/step-16-02.cc +++ b/tests/multigrid/step-16-02.cc @@ -237,7 +237,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-03.cc b/tests/multigrid/step-16-03.cc index c85967f26f..c0ea10ac69 100644 --- a/tests/multigrid/step-16-03.cc +++ b/tests/multigrid/step-16-03.cc @@ -167,7 +167,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-04.cc b/tests/multigrid/step-16-04.cc index ecaa89d1ef..d7a40174e7 100644 --- a/tests/multigrid/step-16-04.cc +++ b/tests/multigrid/step-16-04.cc @@ -171,7 +171,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-05.cc b/tests/multigrid/step-16-05.cc index 21ef1c1d78..a31504e11e 100644 --- a/tests/multigrid/step-16-05.cc +++ b/tests/multigrid/step-16-05.cc @@ -171,7 +171,7 @@ void LaplaceProblem::setup_system () DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); DoFTools::make_hanging_node_constraints (mg_dof_handler, hanging_node_constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-06.cc b/tests/multigrid/step-16-06.cc index 5a3b360c39..2bfd800e54 100644 --- a/tests/multigrid/step-16-06.cc +++ b/tests/multigrid/step-16-06.cc @@ -171,7 +171,7 @@ void LaplaceProblem::setup_system () DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); DoFTools::make_hanging_node_constraints (mg_dof_handler, hanging_node_constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-07.cc b/tests/multigrid/step-16-07.cc index b26ed6a945..4891a1271b 100644 --- a/tests/multigrid/step-16-07.cc +++ b/tests/multigrid/step-16-07.cc @@ -175,7 +175,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-50-mpi-linear-operator.cc b/tests/multigrid/step-16-50-mpi-linear-operator.cc index 02dd13162e..7492a89e4a 100644 --- a/tests/multigrid/step-16-50-mpi-linear-operator.cc +++ b/tests/multigrid/step-16-50-mpi-linear-operator.cc @@ -203,7 +203,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc; + Functions::ZeroFunction homogeneous_dirichlet_bc; dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/step-16-50-mpi-smoother.cc b/tests/multigrid/step-16-50-mpi-smoother.cc index b7f994097e..3301986644 100644 --- a/tests/multigrid/step-16-50-mpi-smoother.cc +++ b/tests/multigrid/step-16-50-mpi-smoother.cc @@ -203,7 +203,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc; + Functions::ZeroFunction homogeneous_dirichlet_bc; dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/step-16-50-mpi.cc b/tests/multigrid/step-16-50-mpi.cc index 12701bd476..51210ae054 100644 --- a/tests/multigrid/step-16-50-mpi.cc +++ b/tests/multigrid/step-16-50-mpi.cc @@ -203,7 +203,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc; + Functions::ZeroFunction homogeneous_dirichlet_bc; dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/step-16-50-serial.cc b/tests/multigrid/step-16-50-serial.cc index 37020dbe60..0268e24d10 100644 --- a/tests/multigrid/step-16-50-serial.cc +++ b/tests/multigrid/step-16-50-serial.cc @@ -172,7 +172,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16-bdry1.cc b/tests/multigrid/step-16-bdry1.cc index a2df4adee5..4b6e31edec 100644 --- a/tests/multigrid/step-16-bdry1.cc +++ b/tests/multigrid/step-16-bdry1.cc @@ -238,7 +238,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-16.cc b/tests/multigrid/step-16.cc index 47768a89c8..1fa794068d 100644 --- a/tests/multigrid/step-16.cc +++ b/tests/multigrid/step-16.cc @@ -175,7 +175,7 @@ void LaplaceProblem::setup_system () constraints.clear (); DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MappingQGeneric mapping(1); VectorTools::interpolate_boundary_values (mapping, diff --git a/tests/multigrid/step-50_01.cc b/tests/multigrid/step-50_01.cc index 201ef59362..58b02b58c7 100644 --- a/tests/multigrid/step-50_01.cc +++ b/tests/multigrid/step-50_01.cc @@ -200,7 +200,7 @@ namespace Step50 DoFTools::make_hanging_node_constraints (mg_dof_handler, constraints); typename FunctionMap::type dirichlet_boundary; - ConstantFunction homogeneous_dirichlet_bc (0.0); + Functions::ConstantFunction homogeneous_dirichlet_bc (0.0); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; VectorTools::interpolate_boundary_values (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/transfer_04a.cc b/tests/multigrid/transfer_04a.cc index 65ba18f9f7..5f7999222e 100644 --- a/tests/multigrid/transfer_04a.cc +++ b/tests/multigrid/transfer_04a.cc @@ -112,7 +112,7 @@ void check_fe(FiniteElement &fe) } - ZeroFunction zero; + Functions::ZeroFunction zero; typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); diff --git a/tests/multigrid/transfer_matrix_free_01.cc b/tests/multigrid/transfer_matrix_free_01.cc index c5cb662c4e..738cfb5c91 100644 --- a/tests/multigrid/transfer_matrix_free_01.cc +++ b/tests/multigrid/transfer_matrix_free_01.cc @@ -60,7 +60,7 @@ void check(const unsigned int fe_degree) mgdof.distribute_mg_dofs(fe); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(mgdof, dirichlet_boundary); diff --git a/tests/multigrid/transfer_matrix_free_02.cc b/tests/multigrid/transfer_matrix_free_02.cc index 1269246b8b..afdf4066e2 100644 --- a/tests/multigrid/transfer_matrix_free_02.cc +++ b/tests/multigrid/transfer_matrix_free_02.cc @@ -80,7 +80,7 @@ void check(const unsigned int fe_degree) mgdof.distribute_mg_dofs(fe); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(mgdof, dirichlet_boundary); diff --git a/tests/multigrid/transfer_matrix_free_03.cc b/tests/multigrid/transfer_matrix_free_03.cc index 2f984d2c5a..fd70f7b20f 100644 --- a/tests/multigrid/transfer_matrix_free_03.cc +++ b/tests/multigrid/transfer_matrix_free_03.cc @@ -57,7 +57,7 @@ void check(const unsigned int fe_degree) mgdof.distribute_mg_dofs(fe); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(mgdof, dirichlet_boundary); diff --git a/tests/multigrid/transfer_matrix_free_06.cc b/tests/multigrid/transfer_matrix_free_06.cc index 749e07e1b5..db0bb70257 100644 --- a/tests/multigrid/transfer_matrix_free_06.cc +++ b/tests/multigrid/transfer_matrix_free_06.cc @@ -82,7 +82,7 @@ void check(const unsigned int fe_degree) mgdof.distribute_mg_dofs(fe); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(mgdof, dirichlet_boundary); diff --git a/tests/multigrid/transfer_prebuilt_03.cc b/tests/multigrid/transfer_prebuilt_03.cc index b4a6b07c8b..8f057b7e77 100644 --- a/tests/multigrid/transfer_prebuilt_03.cc +++ b/tests/multigrid/transfer_prebuilt_03.cc @@ -56,7 +56,7 @@ void check_simple(const FiniteElement &fe) mgdof.distribute_mg_dofs(fe); typename FunctionMap::type dirichlet_boundary; - ZeroFunction homogeneous_dirichlet_bc (1); + Functions::ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; MGConstrainedDoFs mg_constrained_dofs; diff --git a/tests/multigrid/transfer_prebuilt_04.cc b/tests/multigrid/transfer_prebuilt_04.cc index a0e59a5d9f..f0347425f3 100644 --- a/tests/multigrid/transfer_prebuilt_04.cc +++ b/tests/multigrid/transfer_prebuilt_04.cc @@ -57,7 +57,7 @@ void check() mgdof.distribute_mg_dofs(fe); MGConstrainedDoFs mg_constrained_dofs; - ZeroFunction zero_function; + Functions::ZeroFunction zero_function; typename FunctionMap::type dirichlet_boundary; dirichlet_boundary[0] = &zero_function; mg_constrained_dofs.initialize(mgdof, dirichlet_boundary); diff --git a/tests/multigrid/transfer_system_adaptive_02.cc b/tests/multigrid/transfer_system_adaptive_02.cc index 910928c661..0a3f3f82de 100644 --- a/tests/multigrid/transfer_system_adaptive_02.cc +++ b/tests/multigrid/transfer_system_adaptive_02.cc @@ -144,7 +144,7 @@ void check (const FiniteElement &fe) std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; MGConstrainedDoFs mg_constrained_dofs; diff --git a/tests/multigrid/transfer_system_adaptive_04.cc b/tests/multigrid/transfer_system_adaptive_04.cc index 42f7b68498..3cd1786e0f 100644 --- a/tests/multigrid/transfer_system_adaptive_04.cc +++ b/tests/multigrid/transfer_system_adaptive_04.cc @@ -144,7 +144,7 @@ void check (const FiniteElement &fe) std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; MGTools::make_boundary_list (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/transfer_system_adaptive_06.cc b/tests/multigrid/transfer_system_adaptive_06.cc index e9e5c1e26a..69b7969f6c 100644 --- a/tests/multigrid/transfer_system_adaptive_06.cc +++ b/tests/multigrid/transfer_system_adaptive_06.cc @@ -144,7 +144,7 @@ void check (const FiniteElement &fe) std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; MGTools::make_boundary_list (mg_dof_handler, dirichlet_boundary, diff --git a/tests/multigrid/transfer_system_adaptive_08.cc b/tests/multigrid/transfer_system_adaptive_08.cc index 715aed5926..ac9743cff4 100644 --- a/tests/multigrid/transfer_system_adaptive_08.cc +++ b/tests/multigrid/transfer_system_adaptive_08.cc @@ -150,7 +150,7 @@ void check (const FiniteElement &fe) std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; - ZeroFunction dirichlet_bc(fe.n_components()); + Functions::ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; MGTools::make_boundary_list (mg_dof_handler, dirichlet_boundary, diff --git a/tests/numerics/create_laplace_matrix_constraints_01.cc b/tests/numerics/create_laplace_matrix_constraints_01.cc index 8af0c09db6..5a10130805 100644 --- a/tests/numerics/create_laplace_matrix_constraints_01.cc +++ b/tests/numerics/create_laplace_matrix_constraints_01.cc @@ -74,7 +74,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1,1.), + Functions::ConstantFunction(1,1.), constraints); constraints.close (); diff --git a/tests/numerics/create_laplace_matrix_constraints_02.cc b/tests/numerics/create_laplace_matrix_constraints_02.cc index a885377b03..3c18e2dea9 100644 --- a/tests/numerics/create_laplace_matrix_constraints_02.cc +++ b/tests/numerics/create_laplace_matrix_constraints_02.cc @@ -75,7 +75,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/numerics/create_laplace_matrix_constraints_02b.cc b/tests/numerics/create_laplace_matrix_constraints_02b.cc index 92489fa388..17c7fb9526 100644 --- a/tests/numerics/create_laplace_matrix_constraints_02b.cc +++ b/tests/numerics/create_laplace_matrix_constraints_02b.cc @@ -76,7 +76,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ZeroFunction(2), + Functions::ZeroFunction(2), constraints); constraints.close (); diff --git a/tests/numerics/create_laplace_matrix_constraints_03.cc b/tests/numerics/create_laplace_matrix_constraints_03.cc index 1487c09d70..a3fb657337 100644 --- a/tests/numerics/create_laplace_matrix_constraints_03.cc +++ b/tests/numerics/create_laplace_matrix_constraints_03.cc @@ -74,7 +74,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1,1.), + Functions::ConstantFunction(1,1.), constraints); constraints.close (); diff --git a/tests/numerics/create_laplace_matrix_constraints_04.cc b/tests/numerics/create_laplace_matrix_constraints_04.cc index 5a35b42c4a..947088f2a9 100644 --- a/tests/numerics/create_laplace_matrix_constraints_04.cc +++ b/tests/numerics/create_laplace_matrix_constraints_04.cc @@ -75,7 +75,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/numerics/create_mass_matrix_constraints_01.cc b/tests/numerics/create_mass_matrix_constraints_01.cc index 7aa4b0ba48..872f4e0422 100644 --- a/tests/numerics/create_mass_matrix_constraints_01.cc +++ b/tests/numerics/create_mass_matrix_constraints_01.cc @@ -74,7 +74,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1,1.), + Functions::ConstantFunction(1,1.), constraints); constraints.close (); diff --git a/tests/numerics/create_mass_matrix_constraints_02.cc b/tests/numerics/create_mass_matrix_constraints_02.cc index 70b8f0c8d5..5130c0f636 100644 --- a/tests/numerics/create_mass_matrix_constraints_02.cc +++ b/tests/numerics/create_mass_matrix_constraints_02.cc @@ -75,7 +75,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/numerics/create_mass_matrix_constraints_02b.cc b/tests/numerics/create_mass_matrix_constraints_02b.cc index fb709fa977..8e98a68fbf 100644 --- a/tests/numerics/create_mass_matrix_constraints_02b.cc +++ b/tests/numerics/create_mass_matrix_constraints_02b.cc @@ -76,7 +76,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ZeroFunction(2), + Functions::ZeroFunction(2), constraints); constraints.close (); diff --git a/tests/numerics/create_mass_matrix_constraints_03.cc b/tests/numerics/create_mass_matrix_constraints_03.cc index 446ae99ed7..aaad57b1a6 100644 --- a/tests/numerics/create_mass_matrix_constraints_03.cc +++ b/tests/numerics/create_mass_matrix_constraints_03.cc @@ -74,7 +74,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1,1.), + Functions::ConstantFunction(1,1.), constraints); constraints.close (); diff --git a/tests/numerics/create_mass_matrix_constraints_04.cc b/tests/numerics/create_mass_matrix_constraints_04.cc index 4c14bbdf40..bc4f018044 100644 --- a/tests/numerics/create_mass_matrix_constraints_04.cc +++ b/tests/numerics/create_mass_matrix_constraints_04.cc @@ -75,7 +75,7 @@ check () ConstraintMatrix constraints; DoFTools::make_hanging_node_constraints (dof, constraints); VectorTools::interpolate_boundary_values(dof, 0, - ConstantFunction(1.,2), + Functions::ConstantFunction(1.,2), constraints); constraints.close (); diff --git a/tests/numerics/normal_flux_inhom_01.cc b/tests/numerics/normal_flux_inhom_01.cc index 1e10ccee0c..d5f580cc86 100644 --- a/tests/numerics/normal_flux_inhom_01.cc +++ b/tests/numerics/normal_flux_inhom_01.cc @@ -41,7 +41,7 @@ void test (const Triangulation &tr, DoFHandler dof(tr); dof.distribute_dofs(fe); - ConstantFunction constant_function(1.,dim); + Functions::ConstantFunction constant_function(1.,dim); typename FunctionMap::type function_map; for (unsigned int j=0; j::faces_per_cell; ++j) function_map[j] = &constant_function; diff --git a/tests/numerics/tangential_flux_inhom_01.cc b/tests/numerics/tangential_flux_inhom_01.cc index 804a5a4cea..e55251c947 100644 --- a/tests/numerics/tangential_flux_inhom_01.cc +++ b/tests/numerics/tangential_flux_inhom_01.cc @@ -42,7 +42,7 @@ void test (const Triangulation &tr, DoFHandler dof(tr); dof.distribute_dofs(fe); - ConstantFunction constant_function(1.,dim); + Functions::ConstantFunction constant_function(1.,dim); typename FunctionMap::type function_map; for (unsigned int j=0; j::faces_per_cell; ++j) function_map[j] = &constant_function; diff --git a/tests/physics/step-18-rotation_matrix.cc b/tests/physics/step-18-rotation_matrix.cc index b522455867..9ee398c44d 100644 --- a/tests/physics/step-18-rotation_matrix.cc +++ b/tests/physics/step-18-rotation_matrix.cc @@ -439,7 +439,7 @@ namespace Step18 VectorTools:: interpolate_boundary_values (dof_handler, 0, - ZeroFunction (dim), + Functions::ZeroFunction (dim), boundary_values); VectorTools:: interpolate_boundary_values (dof_handler, diff --git a/tests/physics/step-18.cc b/tests/physics/step-18.cc index fd8ead766d..ecf494df57 100644 --- a/tests/physics/step-18.cc +++ b/tests/physics/step-18.cc @@ -466,7 +466,7 @@ namespace Step18 VectorTools:: interpolate_boundary_values (dof_handler, 0, - ZeroFunction (dim), + Functions::ZeroFunction (dim), boundary_values); VectorTools:: interpolate_boundary_values (dof_handler, diff --git a/tests/physics/step-44-standard_tensors-material_push_forward.cc b/tests/physics/step-44-standard_tensors-material_push_forward.cc index ed1174fac4..00c314badf 100644 --- a/tests/physics/step-44-standard_tensors-material_push_forward.cc +++ b/tests/physics/step-44-standard_tensors-material_push_forward.cc @@ -1702,13 +1702,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); } @@ -1717,13 +1717,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); } @@ -1735,7 +1735,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1743,7 +1743,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1754,13 +1754,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); } @@ -1769,7 +1769,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1777,7 +1777,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1791,13 +1791,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } @@ -1806,13 +1806,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } diff --git a/tests/physics/step-44-standard_tensors-spatial.cc b/tests/physics/step-44-standard_tensors-spatial.cc index 9ea4e0164d..f2c00743e1 100644 --- a/tests/physics/step-44-standard_tensors-spatial.cc +++ b/tests/physics/step-44-standard_tensors-spatial.cc @@ -1588,13 +1588,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); } @@ -1603,13 +1603,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); } @@ -1621,7 +1621,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1629,7 +1629,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1640,13 +1640,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); } @@ -1655,7 +1655,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1663,7 +1663,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1677,13 +1677,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } @@ -1692,13 +1692,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } diff --git a/tests/physics/step-44.cc b/tests/physics/step-44.cc index f397757ed6..5d7edaf57a 100644 --- a/tests/physics/step-44.cc +++ b/tests/physics/step-44.cc @@ -1605,13 +1605,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(x_displacement)); } @@ -1620,13 +1620,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(y_displacement)); } @@ -1638,7 +1638,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1646,7 +1646,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1657,13 +1657,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, fe.component_mask(z_displacement)); } @@ -1672,7 +1672,7 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1680,7 +1680,7 @@ namespace Step44 else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement) | @@ -1694,13 +1694,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } @@ -1709,13 +1709,13 @@ namespace Step44 if (apply_dirichlet_bc == true) VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); else VectorTools::interpolate_boundary_values(dof_handler_ref, boundary_id, - ZeroFunction(n_components), + Functions::ZeroFunction(n_components), constraints, (fe.component_mask(x_displacement))); } diff --git a/tests/quick_tests/step.cc b/tests/quick_tests/step.cc index 36ba5096c0..96e5ec7ffe 100644 --- a/tests/quick_tests/step.cc +++ b/tests/quick_tests/step.cc @@ -141,12 +141,12 @@ void LaplaceProblem::assemble_and_solve () system_matrix); VectorTools::create_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(-2), + Functions::ConstantFunction(-2), system_rhs); Vector tmp (system_rhs.size()); VectorTools::create_boundary_right_hand_side (mapping, dof_handler, QGauss(gauss_degree), - ConstantFunction(1), + Functions::ConstantFunction(1), tmp); system_rhs += tmp; @@ -159,7 +159,7 @@ void LaplaceProblem::assemble_and_solve () Vector norm_per_cell (triangulation.n_active_cells()); VectorTools::integrate_difference (mapping, dof_handler, solution, - ZeroFunction(), + Functions::ZeroFunction(), norm_per_cell, QGauss(gauss_degree+1), VectorTools::H1_seminorm); diff --git a/tests/slepc/step-36_parallel.cc b/tests/slepc/step-36_parallel.cc index 12486e2250..3a270d25b4 100644 --- a/tests/slepc/step-36_parallel.cc +++ b/tests/slepc/step-36_parallel.cc @@ -110,7 +110,7 @@ void test (std::string solver_name, dealii::DoFTools::make_hanging_node_constraints (dof_handler, constraints); dealii::VectorTools::interpolate_boundary_values (dof_handler, 0, - dealii::ZeroFunction (), + dealii::Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/slepc/step-36_parallel_02.cc b/tests/slepc/step-36_parallel_02.cc index 552c0e7e04..ff207174c3 100644 --- a/tests/slepc/step-36_parallel_02.cc +++ b/tests/slepc/step-36_parallel_02.cc @@ -110,7 +110,7 @@ void test (std::string solver_name, dealii::DoFTools::make_hanging_node_constraints (dof_handler, constraints); dealii::VectorTools::interpolate_boundary_values (dof_handler, 0, - dealii::ZeroFunction (), + dealii::Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/slepc/step-36_parallel_03.cc b/tests/slepc/step-36_parallel_03.cc index d40ba7d1a2..62e15cc8f0 100644 --- a/tests/slepc/step-36_parallel_03.cc +++ b/tests/slepc/step-36_parallel_03.cc @@ -110,7 +110,7 @@ void test (std::string solver_name, dealii::DoFTools::make_hanging_node_constraints (dof_handler, constraints); dealii::VectorTools::interpolate_boundary_values (dof_handler, 0, - dealii::ZeroFunction (), + dealii::Functions::ZeroFunction (), constraints); constraints.close (); diff --git a/tests/trilinos/solver_control_06.cc b/tests/trilinos/solver_control_06.cc index 04778bd2a1..a236ec3af9 100644 --- a/tests/trilinos/solver_control_06.cc +++ b/tests/trilinos/solver_control_06.cc @@ -200,7 +200,7 @@ void Test_Solver_Output::setup_system() DoFTools::make_hanging_node_constraints(dof_handler, constraints); VectorTools::interpolate_boundary_values(dof_handler, 0, - ZeroFunction<2>(), + Functions::ZeroFunction<2>(), constraints); constraints.close(); diff --git a/tests/umfpack/umfpack_04.cc b/tests/umfpack/umfpack_04.cc index 482b04d482..34a34b443c 100644 --- a/tests/umfpack/umfpack_04.cc +++ b/tests/umfpack/umfpack_04.cc @@ -166,7 +166,7 @@ void test () std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, - ZeroFunction(size.size()), + Functions::ZeroFunction(size.size()), boundary_values); MatrixTools::apply_boundary_values (boundary_values, Bb, bx, bb); MatrixTools::apply_boundary_values (boundary_values, B, x, b); diff --git a/tests/vector_tools/integrate_difference_01.cc b/tests/vector_tools/integrate_difference_01.cc index c88e5fa14f..3814f96155 100644 --- a/tests/vector_tools/integrate_difference_01.cc +++ b/tests/vector_tools/integrate_difference_01.cc @@ -72,7 +72,7 @@ void test(VectorTools::NormType norm, double value) Vector cellwise_errors (tria.n_active_cells()); VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, QGauss(5), norm); diff --git a/tests/vector_tools/integrate_difference_02.cc b/tests/vector_tools/integrate_difference_02.cc index 994292aaff..bec96b7b22 100644 --- a/tests/vector_tools/integrate_difference_02.cc +++ b/tests/vector_tools/integrate_difference_02.cc @@ -78,7 +78,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0) const dealii::Function *w = nullptr; VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, quadrature, norm, diff --git a/tests/vector_tools/integrate_difference_03.cc b/tests/vector_tools/integrate_difference_03.cc index 6c74729f07..7f979603de 100644 --- a/tests/vector_tools/integrate_difference_03.cc +++ b/tests/vector_tools/integrate_difference_03.cc @@ -86,7 +86,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0) const dealii::Function *w = nullptr; VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, quadrature, norm, diff --git a/tests/vector_tools/integrate_difference_04.cc b/tests/vector_tools/integrate_difference_04.cc index 9ba8a56ef8..c38ee70b9b 100644 --- a/tests/vector_tools/integrate_difference_04.cc +++ b/tests/vector_tools/integrate_difference_04.cc @@ -86,7 +86,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0) const dealii::Function *w = nullptr; VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, quadrature, norm, diff --git a/tests/vector_tools/integrate_difference_04_hp.cc b/tests/vector_tools/integrate_difference_04_hp.cc index 2cad4420dc..e998a1d301 100644 --- a/tests/vector_tools/integrate_difference_04_hp.cc +++ b/tests/vector_tools/integrate_difference_04_hp.cc @@ -93,7 +93,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0) const dealii::Function *w = nullptr; VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, quadrature, norm, diff --git a/tests/vector_tools/integrate_difference_04_hp_02.cc b/tests/vector_tools/integrate_difference_04_hp_02.cc index 4e1cf5d7b6..eb22fbcbf8 100644 --- a/tests/vector_tools/integrate_difference_04_hp_02.cc +++ b/tests/vector_tools/integrate_difference_04_hp_02.cc @@ -107,7 +107,7 @@ void test(VectorTools::NormType norm, double value, double exp = 2.0) const dealii::Function *w = nullptr; VectorTools::integrate_difference (dofh, solution, - ZeroFunction(dim), + Functions::ZeroFunction(dim), cellwise_errors, quadrature, norm,