evaluation_point_found = true;
break;
- };
+ }
AssertThrow (evaluation_point_found,
ExcEvaluationPointNotFound(evaluation_point));
// be at a following
// vertex as well:
break;
- };
+ }
// Now we have looped over all
// cells and vertices, so check
linear_system.matrix.add (local_dof_indices[i],
local_dof_indices[j],
cell_matrix(i,j));
- };
+ }
}
100*std::sin(10*p(i)+5*p(0)*p(0)) * p(0)*p(0);
t3 += 100*std::cos(10*p(i)+5*p(0)*p(0))*std::cos(10*p(i)+5*p(0)*p(0)) -
100*std::sin(10*p(i)+5*p(0)*p(0));
- };
+ }
t1 = t1*t1;
return -u*(t1+t2+t3);
++j)
cells[i].vertices[j] = cell_vertices[i][j];
cells[i].material_id = 0;
- };
+ }
// Finally pass all this
// information to the library to
// since we are finished:
rhs(cell->vertex_dof_index(vertex,0)) = 1;
return;
- };
+ }
// Finally, a sanity check: if we
// somehow got here, then we must
cell_rhs(i) += fe_values.shape_grad(i,q)[0] *
fe_values.JxW (q);
total_volume += fe_values.JxW (q);
- };
+ }
// If we have the local
// contributions,
cell->get_dof_indices (local_dof_indices);
for (unsigned int i=0; i<dofs_per_cell; ++i)
rhs(local_dof_indices[i]) += cell_rhs(i);
- };
+ }
// After we have looped over all
// cells, check whether we have
ExcInternalError());
error_indicators(present_cell)
-= 0.5*face_integrals[cell->face(face_no)];
- };
+ }
std::cout << " Estimated error="
<< std::accumulate (error_indicators.begin(),
error_indicators.end(), 0.)
{
face_integrals[cell->face(face_no)] = 0;
continue;
- };
+ }
// Next, note that since
// we want to compute the
face_data.fe_face_values_neighbor.JxW(p));
face_integrals[neighbor_child->face(neighbor_neighbor)]
= face_integral;
- };
+ }
// Once the contributions of all
// sub-faces are computed, loop
ExcInternalError());
sum += face_integrals[face->child(subface_no)];
- };
+ }
// Finally store the value with
// the parent face.
face_integrals[face] = sum;
descriptor.data->get_boundary_values(),
*descriptor.dual_functional);
break;
- };
+ }
case ProblemDescription::global_refinement:
{
descriptor.data->get_right_hand_side(),
descriptor.data->get_boundary_values());
break;
- };
+ }
case ProblemDescription::kelly_indicator:
{
descriptor.data->get_right_hand_side(),
descriptor.data->get_boundary_values());
break;
- };
+ }
case ProblemDescription::weighted_kelly_indicator:
{
descriptor.data->get_boundary_values(),
*descriptor.kelly_weight);
break;
- };
+ }
default:
AssertThrow (false, ExcInternalError());
- };
+ }
// Now that all objects are in
// place, run the main loop. The
{
(*e)->set_refinement_cycle (step);
solver->postprocess (**e);
- };
+ }
if (solver->n_dofs() < descriptor.max_degrees_of_freedom)
solver->refine_grid ();
else
break;
- };
+ }
// After the loop has run, clean up
// the screen, and delete objects
<< "----------------------------------------------------"
<< std::endl;
return 1;
- };
+ }
return 0;
}