From: wolf Date: Thu, 13 Jan 2000 21:18:34 +0000 (+0000) Subject: Various updates. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8a5bf4e924538f355bacc13cc905317375f6ab17;p=dealii-svn.git Various updates. git-svn-id: https://svn.dealii.org/trunk@2223 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/Attic/examples/step-by-step/step-6/step-6.cc b/deal.II/deal.II/Attic/examples/step-by-step/step-6/step-6.cc index fe4ed33a89..b26124a9af 100644 --- a/deal.II/deal.II/Attic/examples/step-by-step/step-6/step-6.cc +++ b/deal.II/deal.II/Attic/examples/step-by-step/step-6/step-6.cc @@ -991,7 +991,8 @@ int main () cerr << endl << endl << "----------------------------------------------------" << endl; - cerr << "Exception on processing: " << exc.what() << endl + cerr << "Exception on processing: " << endl + << exc.what() << endl << "Aborting!" << endl << "----------------------------------------------------" << endl; diff --git a/deal.II/deal.II/Attic/examples/step-by-step/step-8/step-8.cc b/deal.II/deal.II/Attic/examples/step-by-step/step-8/step-8.cc index 75a1b9bd2d..93d6d2c47f 100644 --- a/deal.II/deal.II/Attic/examples/step-by-step/step-8/step-8.cc +++ b/deal.II/deal.II/Attic/examples/step-by-step/step-8/step-8.cc @@ -30,7 +30,7 @@ // In this example, we need // vector-valued finite elements. The - // suuport for these can be found in + // support for these can be found in // the following include file: #include // We will compose the vector-valued @@ -513,6 +513,11 @@ void ElasticProblem::assemble_system () fe_values.reinit (cell); + // As in previous examples, we + // define some abbreviations + // for the various data that + // the ``FEValues'' class + // offers: const FullMatrix & shape_values = fe_values.get_shape_values(); const vector > > @@ -522,28 +527,135 @@ void ElasticProblem::assemble_system () const vector > & q_points = fe_values.get_quadrature_points(); + // Next we get the values of + // the coefficients at the + // quadrature points: lambda.value_list (q_points, lambda_values); mu.value_list (q_points, mu_values); + // Then assemble the entries of + // the local stiffness matrix + // and right hand side + // vector. This follows almost + // one-to-one the pattern + // described in the + // introduction of this example + // and will not comment much on + // this. for (unsigned int i=0; i'', of + // which the first element + // is ``comp(i)'' and the + // second is the value + // ``base(i)'' also noted + // in the text. You will + // rather seldom need to + // access this second + // value, but the first is + // important when using + // vector valued elements. for (unsigned int j=0; j::assemble_system () }; }; - + // Assembling the right hand + // side is also just as + // discussed in the + // introduction. We will + // therefore not discuss it + // further. right_hand_side.vector_value_list (q_points, rhs_values); for (unsigned int i=0; i // We will compose the vector-valued @@ -513,6 +513,11 @@ void ElasticProblem::assemble_system () fe_values.reinit (cell); + // As in previous examples, we + // define some abbreviations + // for the various data that + // the ``FEValues'' class + // offers: const FullMatrix & shape_values = fe_values.get_shape_values(); const vector > > @@ -522,28 +527,135 @@ void ElasticProblem::assemble_system () const vector > & q_points = fe_values.get_quadrature_points(); + // Next we get the values of + // the coefficients at the + // quadrature points: lambda.value_list (q_points, lambda_values); mu.value_list (q_points, mu_values); + // Then assemble the entries of + // the local stiffness matrix + // and right hand side + // vector. This follows almost + // one-to-one the pattern + // described in the + // introduction of this example + // and will not comment much on + // this. for (unsigned int i=0; i'', of + // which the first element + // is ``comp(i)'' and the + // second is the value + // ``base(i)'' also noted + // in the text. You will + // rather seldom need to + // access this second + // value, but the first is + // important when using + // vector valued elements. for (unsigned int j=0; j::assemble_system () }; }; - + // Assembling the right hand + // side is also just as + // discussed in the + // introduction. We will + // therefore not discuss it + // further. right_hand_side.vector_value_list (q_points, rhs_values); for (unsigned int i=0; i