From 8e4931f3929ee45cc20b63bb0df36adcec748f9a Mon Sep 17 00:00:00 2001 From: deal Date: Mon, 16 Dec 2002 19:58:28 +0000 Subject: [PATCH] Add some this-> for icc7 git-svn-id: https://svn.dealii.org/trunk@6831 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-14/step-14.cc | 40 ++++++++++++++--------------- 1 file changed, 20 insertions(+), 20 deletions(-) diff --git a/deal.II/examples/step-14/step-14.cc b/deal.II/examples/step-14/step-14.cc index 38e96efc4f..d6b6509427 100644 --- a/deal.II/examples/step-14/step-14.cc +++ b/deal.II/examples/step-14/step-14.cc @@ -430,7 +430,7 @@ namespace Evaluation std::ostrstream filename; #endif filename << output_name_base << "-" - << refinement_cycle + << this->refinement_cycle << ".eps" << std::ends; #ifdef HAVE_STD_STRINGSTREAM @@ -931,8 +931,8 @@ namespace LaplaceSolver PrimalSolver::output_solution () const { DataOut data_out; - data_out.attach_dof_handler (dof_handler); - data_out.add_data_vector (solution, "solution"); + data_out.attach_dof_handler (this->dof_handler); + data_out.add_data_vector (this->solution, "solution"); data_out.build_patches (); #ifdef HAVE_STD_STRINGSTREAM @@ -941,7 +941,7 @@ namespace LaplaceSolver std::ostrstream filename; #endif filename << "solution-" - << refinement_cycle + << this->refinement_cycle << ".gnuplot" << std::ends; #ifdef HAVE_STD_STRINGSTREAM @@ -960,7 +960,7 @@ namespace LaplaceSolver PrimalSolver:: assemble_rhs (Vector &rhs) const { - FEValues fe_values (*fe, *quadrature, + FEValues fe_values (*this->fe, *this->quadrature, UpdateFlags(update_values | update_q_points | update_JxW_values)); @@ -973,8 +973,8 @@ namespace LaplaceSolver std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator - cell = dof_handler.begin_active(), - endc = dof_handler.end(); + cell = this->dof_handler.begin_active(), + endc = this->dof_handler.end(); for (; cell!=endc; ++cell) { cell_rhs.clear (); @@ -1040,7 +1040,7 @@ namespace LaplaceSolver void RefinementGlobal::refine_grid () { - triangulation->refine_global (1); + this->triangulation->refine_global (1); }; @@ -1082,13 +1082,13 @@ namespace LaplaceSolver void RefinementKelly::refine_grid () { - Vector estimated_error_per_cell (triangulation->n_active_cells()); - KellyErrorEstimator::estimate (dof_handler, + Vector estimated_error_per_cell (this->triangulation->n_active_cells()); + KellyErrorEstimator::estimate (this->dof_handler, QGauss3(), typename FunctionMap::type(), - solution, + this->solution, estimated_error_per_cell); - GridRefinement::refine_and_coarsen_fixed_number (*triangulation, + GridRefinement::refine_and_coarsen_fixed_number (*this->triangulation, estimated_error_per_cell, 0.3, 0.03); triangulation->execute_coarsening_and_refinement (); @@ -1173,11 +1173,11 @@ namespace LaplaceSolver // library. What exactly is // computed can be read in the // documentation of that class. - Vector estimated_error (triangulation->n_active_cells()); - KellyErrorEstimator::estimate (dof_handler, + Vector estimated_error (this->triangulation->n_active_cells()); + KellyErrorEstimator::estimate (this->dof_handler, *face_quadrature, typename FunctionMap::type(), - solution, + this->solution, estimated_error); // Now we are going to weight @@ -1191,7 +1191,7 @@ namespace LaplaceSolver estimated_error(cell_index) *= weighting_function->value (cell->center()); - GridRefinement::refine_and_coarsen_fixed_number (*triangulation, + GridRefinement::refine_and_coarsen_fixed_number (*this->triangulation, estimated_error, 0.3, 0.03); triangulation->execute_coarsening_and_refinement (); @@ -2275,7 +2275,7 @@ namespace LaplaceSolver DualSolver:: assemble_rhs (Vector &rhs) const { - dual_functional->assemble_rhs (dof_handler, rhs); + dual_functional->assemble_rhs (this->dof_handler, rhs); }; @@ -2710,7 +2710,7 @@ namespace LaplaceSolver // First call the function that // computes the cell-wise and // global error: - Vector error_indicators (triangulation->n_active_cells()); + Vector error_indicators (this->triangulation->n_active_cells()); estimate_error (error_indicators); // Then note that marking cells @@ -2734,7 +2734,7 @@ namespace LaplaceSolver // smallest indicators that make // up for the bottom 2 per cent // of the error. - GridRefinement::refine_and_coarsen_fixed_fraction (*triangulation, + GridRefinement::refine_and_coarsen_fixed_fraction (*this->triangulation, error_indicators, 0.8, 0.02); triangulation->execute_coarsening_and_refinement (); @@ -2864,7 +2864,7 @@ namespace LaplaceSolver std::ostrstream filename; #endif filename << "solution-" - << refinement_cycle + << this->refinement_cycle << ".gnuplot" << std::ends; #ifdef HAVE_STD_STRINGSTREAM -- 2.39.5