From: bangerth Date: Sun, 12 Apr 2009 04:23:12 +0000 (+0000) Subject: Rename interpolate() to compute_exterior_solution(). X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e093705b08387ea6ef2aace468825ccb60f099d2;p=dealii-svn.git Rename interpolate() to compute_exterior_solution(). git-svn-id: https://svn.dealii.org/trunk@18592 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/examples/step-34/step-34.cc b/deal.II/examples/step-34/step-34.cc index b4b868c452..07cc3acc76 100644 --- a/deal.II/examples/step-34/step-34.cc +++ b/deal.II/examples/step-34/step-34.cc @@ -240,7 +240,7 @@ public: // Once we obtained a solution on the codimension one domain, we // want to interpolate it to the rest of the // space. This is done by performing again the convolution of the - // solution with the kernel in the interpolate() function. + // solution with the kernel in the compute_exterior_solution() function. // // We would like to plot the velocity variable which is the // gradient of the potential solution. The potential solution is @@ -249,7 +249,7 @@ public: // dimensional continuous finite element space. The plot of the // gradient of the extrapolated solution will give us the velocity // we want. - void interpolate(); + void compute_exterior_solution(); void output_results(unsigned int cycle); @@ -847,7 +847,7 @@ void BEMProblem::compute_errors(const unsigned int cycle) { // box $[-2,2]^{\text{dim}}$, and we extrapolate the actual solution // inside this box using the convolution with the fundamental solution. template -void BEMProblem::interpolate() { +void BEMProblem::compute_exterior_solution() { // Generate the mesh, refine it and distribute dofs on it. GridGenerator::hyper_cube(external_tria, -2, 2); external_tria.refine_global(external_refinement); @@ -978,7 +978,7 @@ void BEMProblem::run() { output_results(cycle); } if(extend_solution == true) - interpolate(); + compute_exterior_solution(); } else { deallog << "Run in dimension " << dim << " explicitly disabled in parameter file. "