]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new UpdateFlags
authorkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 12 Oct 2007 16:58:46 +0000 (16:58 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 12 Oct 2007 16:58:46 +0000 (16:58 +0000)
git-svn-id: https://svn.dealii.org/trunk@15304 0785d39b-7218-0410-832d-ea1e28bc413d

36 files changed:
deal.II/deal.II/include/fe/fe.h
deal.II/deal.II/include/fe/fe_update_flags.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/mapping_q1.h
deal.II/deal.II/include/numerics/vectors.templates.h
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe_dgp_nonparametric.cc
deal.II/deal.II/source/fe/fe_tools.cc
deal.II/deal.II/source/fe/fe_values.cc
deal.II/deal.II/source/fe/mapping_cartesian.cc
deal.II/deal.II/source/fe/mapping_q1.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/data_out_rotation.cc
deal.II/deal.II/source/numerics/derivative_approximation.cc
deal.II/deal.II/source/numerics/error_estimator.cc
deal.II/deal.II/source/numerics/matrices.cc
deal.II/doc/news/changes.h
deal.II/examples/step-12/step-12.cc
deal.II/examples/step-13/step-13.cc
deal.II/examples/step-14/step-14.cc
deal.II/examples/step-15/step-15.cc
deal.II/examples/step-16/step-16.cc
deal.II/examples/step-17/step-17.cc
deal.II/examples/step-18/step-18.cc
deal.II/examples/step-20/step-20.cc
deal.II/examples/step-21/step-21.cc
deal.II/examples/step-22/step-22.cc
deal.II/examples/step-25/step-25.cc
deal.II/examples/step-27/step-27.cc
deal.II/examples/step-28/step-28.cc
deal.II/examples/step-4/step-4.cc
deal.II/examples/step-5/step-5.cc
deal.II/examples/step-6/step-6.cc
deal.II/examples/step-7/step-7.cc
deal.II/examples/step-8/step-8.cc
deal.II/examples/step-9/step-9.cc

index 12dca24fcc998b4ca3e77a1135c7b71a85da5cb7..3289428d0798372a5b9272bc3dc70d24a33c271b 100644 (file)
@@ -95,7 +95,7 @@ namespace hp
  * @code
  * Quadrature<dim> dummy_quadrature (fe.get_unit_support_points());
  * FEValues<dim>   fe_values (mapping, fe, dummy_quadrature,
- *                            update_q_points);
+ *                            update_quadrature_points);
  * fe_values.reinit (cell);
  * Point<dim>& mapped_point = fe_values.quadrature_point (i);
  * @endcode
index 51be7bd88fcd36ebed21c47e3456c073b142f6ff..0d60c43819546477a109e84f4f038ae77abb1d4d 100644 (file)
@@ -127,7 +127,7 @@ enum UpdateFlags
                                        * points transformed into real
                                        * cell coordinates.
                                        */
-      update_q_points                     = 0x0010,
+      update_quadrature_points            = 0x0010,
                                       //! Transformed quadrature weights
                                       /**
                                        * Compute the quadrature
@@ -212,6 +212,29 @@ enum UpdateFlags
                                        * H_div subspaces like RT and ABF.
                                        */
       update_cell_JxW_values              = 0x2000,
+                                      /**
+                                       * Update the location of the
+                                       * mapped generalized support
+                                       * points of the element.
+                                       */
+      update_support_points               = 0x4000,
+                                      /**
+                                       * Update the Jacobian of the
+                                       * mapping in generalized
+                                       * support points.
+                                       */
+      update_support_jacobians            = 0x8000,
+                                      /**
+                                       * Update the inverse Jacobian
+                                       * of the mapping in
+                                       * generalized support points.
+                                       */
+      update_support_inverse_jacobians    = 0x10000,
+                                      /**
+                                       * @deprecated Update
+                                       * quadrature points
+                                       */
+      update_q_points = update_quadrature_points,
                                       /**
                                        * @deprecated Update second
                                        * derivatives.
index 02296098a9e302fe51bbf44bf659e69e699851d9..45d814b666f2eda3297dc99b02fd704077f56063 100644 (file)
@@ -233,6 +233,26 @@ class FEValuesData
                                      */
     std::vector<Tensor<1,dim> >  boundary_forms;
 
+                                    /**
+                                     * Array of the mapped support
+                                     * points, filled by Mapping.
+                                     */
+    std::vector<Point<dim> > support_points;
+
+                                    /**
+                                     * Array of the Jacobian of the
+                                     * mapping in the support points,
+                                     * filled by Mapping.
+                                     */
+    HessianVector support_jacobians;
+    
+                                    /**
+                                     * Array of the inverse Jacobian of the
+                                     * mapping in the support points,
+                                     * filled by Mapping.
+                                     */
+    HessianVector support_inverse_jacobians;
+    
                                     /**
                                      * Indicate the first row which a
                                      * given shape function occupies
@@ -2765,7 +2785,7 @@ inline
 const std::vector<Point<dim> > &
 FEValuesBase<dim>::get_quadrature_points () const
 {
-  Assert (this->update_flags & update_q_points, ExcAccessToUninitializedField());
+  Assert (this->update_flags & update_quadrature_points, ExcAccessToUninitializedField());
   return this->quadrature_points;
 }
 
@@ -2787,7 +2807,7 @@ inline
 const Point<dim> &
 FEValuesBase<dim>::quadrature_point (const unsigned int i) const
 {
-  Assert (this->update_flags & update_q_points, ExcAccessToUninitializedField());
+  Assert (this->update_flags & update_quadrature_points, ExcAccessToUninitializedField());
   Assert (i<this->quadrature_points.size(), ExcIndexRange(i, 0, this->quadrature_points.size()));
   
   return this->quadrature_points[i];
index 875f355a0cb740f36d736a3d1d1f2e25b9a494df..1c8dbf7cfd2e0b10279920358212ed246db34ce4 100644 (file)
@@ -125,7 +125,7 @@ class MappingQ1 : public Mapping<dim>
                                      *
                                      * Description of effects:
                                      * <ul>
-                                     * <li> if @p update_q_points
+                                     * <li> if @p update_quadrature_points
                                      * is required, the output will
                                      * contain
                                      * @p update_transformation_values. This
@@ -156,7 +156,7 @@ class MappingQ1 : public Mapping<dim>
                                      * Description of effects if
                                      * @p flags contains:
                                      * <ul>
-                                     * <li> <code>update_q_points</code> is
+                                     * <li> <code>update_quadrature_points</code> is
                                      * copied to the output to
                                      * compute the quadrature points
                                      * on the real cell.
@@ -291,7 +291,7 @@ class MappingQ1 : public Mapping<dim>
        std::vector<Tensor<2,dim> > covariant;
        
                                         /**
-                                         * Tensors of covariant
+                                         * Tensors of contravariant
                                          * transformation at each of
                                          * the quadrature points. The
                                          * contravariant matrix is
index f41a1d13b65717448be961e94d5511fe0eb407fd..804cb2d158db2976287847cc920fd29968f67865 100644 (file)
@@ -174,7 +174,7 @@ void VectorTools::interpolate (const Mapping<dim>    &mapping,
   hp::MappingCollection<dim> mapping_collection (mapping);
   
   hp::FEValues<dim> fe_values (mapping_collection,
-                              fe, support_quadrature, update_q_points);
+                              fe, support_quadrature, update_quadrature_points);
   
   for (; cell!=endc; ++cell)
     {
@@ -516,7 +516,7 @@ void VectorTools::create_right_hand_side (const Mapping<dim>    &mapping,
   rhs_vector = 0;
   
   UpdateFlags update_flags = UpdateFlags(update_values   |
-                                        update_q_points |
+                                        update_quadrature_points |
                                         update_JxW_values);
   FEValues<dim> fe_values (mapping, fe, quadrature, update_flags);
 
@@ -641,7 +641,7 @@ void VectorTools::create_right_hand_side (const hp::MappingCollection<dim>    &m
   rhs_vector = 0;
   
   UpdateFlags update_flags = UpdateFlags(update_values   |
-                                        update_q_points |
+                                        update_quadrature_points |
                                         update_JxW_values);
   hp::FEValues<dim> x_fe_values (mapping, fe, quadrature, update_flags);
 
@@ -877,7 +877,7 @@ VectorTools::create_boundary_right_hand_side (const Mapping<dim>      &mapping,
   rhs_vector = 0;
   
   UpdateFlags update_flags = UpdateFlags(update_values   |
-                                        update_q_points |
+                                        update_quadrature_points |
                                         update_JxW_values);
   FEFaceValues<dim> fe_values (mapping, fe, quadrature, update_flags);
 
@@ -1033,7 +1033,7 @@ VectorTools::create_boundary_right_hand_side (const hp::MappingCollection<dim>
   rhs_vector = 0;
   
   UpdateFlags update_flags = UpdateFlags(update_values   |
-                                        update_q_points |
+                                        update_quadrature_points |
                                         update_JxW_values);
   hp::FEFaceValues<dim> x_fe_values (mapping, fe, quadrature, update_flags);
 
@@ -1433,7 +1433,7 @@ interpolate_boundary_values (const Mapping<dim>            &mapping,
               }
 
             Quadrature<dim-1> aux_quad (unit_support_points);
-            FEFaceValues<dim> fe_values (mapping, fe, aux_quad, update_q_points);
+            FEFaceValues<dim> fe_values (mapping, fe, aux_quad, update_quadrature_points);
 //TODO[?] End of inefficient code
 
                                             // get indices, physical location and
@@ -1829,7 +1829,7 @@ namespace internal
                 break;
         }
   
-      UpdateFlags update_flags = UpdateFlags (update_q_points  |
+      UpdateFlags update_flags = UpdateFlags (update_quadrature_points  |
                                               update_JxW_values);
       switch (norm)
         {
index 7941d4a1411a67e425ef0f3e14f408c3e0b40437..93a330a8998eabcc4cf661fe36db0e9bc7029a29 100644 (file)
@@ -4845,7 +4845,7 @@ DoFTools::map_dofs_to_support_points (const Mapping<dim>       &mapping,
                                   // by the used constructor.
   Quadrature<dim> q_dummy(dof_handler.get_fe().get_unit_support_points());
   FEValues<dim> fe_values (mapping, dof_handler.get_fe(),
-                          q_dummy, update_q_points);
+                          q_dummy, update_quadrature_points);
   typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
index ce7e2266f3c3d0a352e41d7324dc14f77750ef35..f36d8ae49094c1ee7c4716ac1903805a35080431 100644 (file)
@@ -213,7 +213,7 @@ FE_DGPNonparametric<dim>::update_each (const UpdateFlags flags) const
   UpdateFlags out = flags;
 
   if (flags & (update_values | update_gradients | update_hessians))
-    out |= update_q_points ;
+    out |= update_quadrature_points ;
 
   return out;
 }
@@ -285,7 +285,7 @@ FE_DGPNonparametric<dim>::fill_fe_values (
   InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
   
   const UpdateFlags flags(fe_data.current_update_flags());
-  Assert (flags & update_q_points, ExcInternalError());
+  Assert (flags & update_quadrature_points, ExcInternalError());
   
   const unsigned int n_q_points = data.quadrature_points.size();
   
@@ -326,7 +326,7 @@ FE_DGPNonparametric<dim>::fill_fe_face_values (
   InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
 
   const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
-  Assert (flags & update_q_points, ExcInternalError());
+  Assert (flags & update_quadrature_points, ExcInternalError());
 
   const unsigned int n_q_points = data.quadrature_points.size();
   
@@ -368,7 +368,7 @@ FE_DGPNonparametric<dim>::fill_fe_subface_values (
   InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
   
   const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
-  Assert (flags & update_q_points, ExcInternalError());
+  Assert (flags & update_quadrature_points, ExcInternalError());
 
   const unsigned int n_q_points = data.quadrature_points.size();
   
index 668b0b1ed473000b879aaf1accef7761d45d5503..f3f21ea26dde9e9262c07f366809a5b400cccb7f 100644 (file)
@@ -485,7 +485,7 @@ void FETools::get_projection_matrix (const FiniteElement<dim> &fe1,
   
   QGauss<dim> quadrature(degree+1);
                                   // Set up FEValues.
-  const UpdateFlags flags = update_values | update_q_points | update_JxW_values;
+  const UpdateFlags flags = update_values | update_quadrature_points | update_JxW_values;
   FEValues<dim> val1 (fe1, quadrature, update_values);
   val1.reinit (tr.begin_active());
   FEValues<dim> val2 (fe2, quadrature, flags);
@@ -609,7 +609,7 @@ FETools::compute_embedding_matrices(const FiniteElement<dim>& fe,
   const unsigned int nq = q_fine.n_quadrature_points;
   
   FEValues<dim> fine (mapping, fe, q_fine,
-                     update_q_points | update_JxW_values | update_values);
+                     update_quadrature_points | update_JxW_values | update_values);
   
                                   // We search for the polynomial on
                                   // the small cell, being equal to
@@ -781,7 +781,7 @@ FETools::compute_face_embedding_matrices(const FiniteElement<dim>& fe,
   Assert (k == fe.dofs_per_face, ExcInternalError());
   
   FEValues<dim> fine (mapping, fe, q_fine,
-                     update_q_points | update_JxW_values | update_values);
+                     update_quadrature_points | update_JxW_values | update_values);
   
                                   // We search for the polynomial on
                                   // the small cell, being equal to
@@ -888,9 +888,9 @@ FETools::compute_projection_matrices(const FiniteElement<dim>& fe,
   const unsigned int nq = q_fine.n_quadrature_points;
   
   FEValues<dim> coarse (mapping, fe, q_fine,
-                       update_q_points | update_JxW_values | update_values);
+                       update_quadrature_points | update_JxW_values | update_values);
   FEValues<dim> fine (mapping, fe, q_fine,
-                     update_q_points | update_JxW_values | update_values);
+                     update_quadrature_points | update_JxW_values | update_values);
   
   typename Triangulation<dim>::cell_iterator coarse_cell
     = tr.begin(0);
index 20ce6c9488f69bc09ffe07348a280cec7ec47e97..ea1be93b8e04aa2c29ed8a77f33a494c9f36ea18 100644 (file)
@@ -302,7 +302,7 @@ FEValuesData<dim>::initialize (const unsigned int        n_quadrature_points,
     this->shape_hessians.resize (n_nonzero_shape_components,
                                         std::vector<Tensor<2,dim> > (n_quadrature_points));
   
-  if (flags & update_q_points)
+  if (flags & update_quadrature_points)
     this->quadrature_points.resize(n_quadrature_points);
 
   if (flags & update_JxW_values)
index 5a114c3bc571ecc81b32f5052b1cb8e3665399d7..be00a08b4436c30a4587d7585e347d49ebe57a83 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -193,7 +193,7 @@ MappingCartesian<dim>::compute_fill (const typename Triangulation<dim>::cell_ite
                                   // is obtained simply by scaling
                                   // unit coordinates with lengths in
                                   // each direction
-  if (update_flags & update_q_points)
+  if (update_flags & update_quadrature_points)
     {
       const typename QProjector<dim>::DataSetDescriptor offset
        = (face_no == invalid_face_number
index 991f94258a6e7cc344b60f27b9a98934af2d2924..180a2847d0b6efb9d97cd78507dc51c7a9931160 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -224,7 +224,7 @@ MappingQ1<dim>::update_once (const UpdateFlags in) const
                                      | update_transformation_gradients));
 
                                   // Shape function values
-  if (in & update_q_points)
+  if (in & update_quadrature_points)
     out |= update_transformation_values;
 
                                   // Shape function gradients
@@ -246,7 +246,7 @@ MappingQ1<dim>::update_each (const UpdateFlags in) const
 {
                                   // Select flags of concern for the
                                   // transformation.
-  UpdateFlags out = UpdateFlags(in & (update_q_points
+  UpdateFlags out = UpdateFlags(in & (update_quadrature_points
                                      | update_covariant_transformation
                                      | update_contravariant_transformation
                                      | update_JxW_values
@@ -465,7 +465,7 @@ MappingQ1<dim>::compute_fill (const typename Triangulation<dim>::cell_iterator &
 {
   const UpdateFlags update_flags(data.current_update_flags());
 
-  if (update_flags & update_q_points)
+  if (update_flags & update_quadrature_points)
     {
       Assert (quadrature_points.size() == n_q_points,
              ExcDimensionMismatch(quadrature_points.size(), n_q_points));
@@ -517,7 +517,7 @@ MappingQ1<dim>::compute_fill (const typename Triangulation<dim>::cell_iterator &
     }
 
                                    // first compute quadrature points
-  if (update_flags & update_q_points)
+  if (update_flags & update_quadrature_points)
     for (unsigned int point=0; point<n_q_points; ++point)
       for (unsigned int k=0; k<data.n_shape_functions; ++k)
         quadrature_points[point]
index 5291a4263060652baedc9075717e6549f33c1cc6..7d0f0a4e5095b6d492f10c76a8731453c44aff91 100644 (file)
@@ -497,7 +497,7 @@ void DataOut<dim,DH>::build_some_patches (Data &data)
   const hp::FECollection<DH::dimension>      fe_collection(this->dofs->get_fe());
   const hp::MappingCollection<DH::dimension> mapping_collection(*(data.mapping));
 
-  UpdateFlags update_flags=update_values | update_q_points;
+  UpdateFlags update_flags=update_values | update_quadrature_points;
   for (unsigned int i=0; i<this->dof_data.size(); ++i)
     if (this->dof_data[i]->postprocessor)
       update_flags |= this->dof_data[i]->postprocessor->get_needed_update_flags();
index 8522216cfaa3e3d5c2bfd8b8c70ee4c924df11b5..9c0bc192bcd6dce5fadc1892352bc7eb586a1016 100644 (file)
@@ -64,7 +64,7 @@ void DataOutRotation<dim,DH>::build_some_patches (Data &data)
   const hp::QCollection<DH::dimension>       q_collection (patch_points);
   const hp::FECollection<DH::dimension>      fe_collection(this->dofs->get_fe());
   
-  UpdateFlags update_flags=update_values | update_q_points;
+  UpdateFlags update_flags=update_values | update_quadrature_points;
   for (unsigned int i=0; i<this->dof_data.size(); ++i)
     if (this->dof_data[i]->postprocessor)
       update_flags |= this->dof_data[i]->postprocessor->get_needed_update_flags();
index b18073592f820bbe8b753ce7dbff3325d9391956..eb7ae49d6fc63f2a5539f36baa9f803a41c5db7b 100644 (file)
@@ -726,7 +726,7 @@ approximate_cell (const Mapping<dim>                            &mapping,
   hp::FEValues<dim> x_fe_midpoint_value (mapping_collection, fe_collection,
                                         q_collection,
                                         DerivativeDescription::update_flags |
-                                        update_q_points);
+                                        update_quadrature_points);
   
                                   // matrix Y=sum_i y_i y_i^T
   Tensor<2,dim> Y;
index 8db67f5a8679d303029e7b219b79a1e4df719d0c..5dec7d989a74962591d908d1d05f450d29ec5bc3 100644 (file)
@@ -680,7 +680,7 @@ estimate_some (const hp::MappingCollection<dim>                  &mapping,
                                               update_JxW_values     |
                                               ((!neumann_bc.empty() ||
                                                 (coefficients != 0))  ?
-                                               update_q_points : 0) |
+                                               update_quadrature_points : 0) |
                                               update_normal_vectors));
   hp::FEFaceValues<dim> fe_face_values_neighbor (mapping,
                                             fe,
index 8c2fc1d32f393d1dc970ee62f4fa9f21fcdad2b1..0a413667fe803603bd3e59fd4ce40c98409b8732 100644 (file)
@@ -119,7 +119,7 @@ void MatrixCreator::create_mass_matrix_1 (const Mapping<dim>       &mapping,
 {
   UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
   
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -370,10 +370,10 @@ MatrixCreator::create_mass_matrix_2 (const Mapping<dim>       &mapping,
                                     Threads::ThreadMutex     &mutex)
 {
   UpdateFlags update_flags = UpdateFlags(update_values |
-                                        update_q_points |
+                                        update_quadrature_points |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -564,7 +564,7 @@ MatrixCreator::create_mass_matrix_1 (const hp::MappingCollection<dim>       &map
   UpdateFlags update_flags = UpdateFlags(update_values |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -755,10 +755,10 @@ MatrixCreator::create_mass_matrix_2 (const hp::MappingCollection<dim>       &map
                                     Threads::ThreadMutex     &mutex)
 {
   UpdateFlags update_flags = UpdateFlags(update_values    |
-                                        update_q_points  |
+                                        update_quadrature_points  |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -1030,7 +1030,7 @@ create_boundary_mass_matrix_1 (const Mapping<dim>        &mapping,
 
   UpdateFlags update_flags = UpdateFlags (update_values     |
                                          update_JxW_values |
-                                         update_q_points);
+                                         update_quadrature_points);
   FEFaceValues<dim> fe_values (mapping, fe, q, update_flags);
 
                                   // two variables for the coefficient,
@@ -1404,7 +1404,7 @@ create_boundary_mass_matrix_1 (const hp::MappingCollection<dim>        &mapping,
 
   UpdateFlags update_flags = UpdateFlags (update_values     |
                                          update_JxW_values |
-                                         update_q_points);
+                                         update_quadrature_points);
   hp::FEFaceValues<dim> x_fe_values (mapping, fe_collection, q, update_flags);
 
                                   // two variables for the coefficient,
@@ -1802,7 +1802,7 @@ void MatrixCreator::create_laplace_matrix_1 (const Mapping<dim>       &mapping,
   UpdateFlags update_flags = UpdateFlags(update_JxW_values |
                                         update_gradients);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -1987,10 +1987,10 @@ MatrixCreator::create_laplace_matrix_2 (const Mapping<dim>       &mapping,
 {
   UpdateFlags update_flags = UpdateFlags(update_values    |
                                         update_gradients |
-                                        update_q_points  |
+                                        update_quadrature_points  |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   FEValues<dim> fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -2184,7 +2184,7 @@ MatrixCreator::create_laplace_matrix_1 (const hp::MappingCollection<dim>       &
   UpdateFlags update_flags = UpdateFlags(update_gradients |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
     
@@ -2376,10 +2376,10 @@ MatrixCreator::create_laplace_matrix_2 (const hp::MappingCollection<dim>       &
 {
   UpdateFlags update_flags = UpdateFlags(update_values    |
                                         update_gradients |
-                                        update_q_points  |
+                                        update_quadrature_points  |
                                         update_JxW_values);
   if (coefficient != 0)
-    update_flags = UpdateFlags (update_flags | update_q_points);
+    update_flags = UpdateFlags (update_flags | update_quadrature_points);
 
   hp::FEValues<dim> x_fe_values (mapping, dof.get_fe(), q, update_flags);
     
index 2f43dbb3ecf3288455252d547263b167e2533583..5d4b13d83f2e396c86c31a9c38a77b82bdf35209 100644 (file)
@@ -114,6 +114,13 @@ inconvenience this causes.
 
 <ol> 
 
+  <li> <p>Improved: UpdateFlags::update_q_points has been renamed to
+  UpdateFlags::update_quadrature_points. Additional update flags for support
+  points have been added without functionality, yet.
+  <br>
+  (GK 2007/10/12)
+  </p></li>
+
 <li> <p>Improved: The number of blocks of an FESystem was properly defined and the
 constructors changed accordingly. At least non of the test programs noticed the change.
 <br>
index b0fb0ed238e041c80641c163431c7c403130c672..d0cfed45470385efe8c1cd0dd9f56eb3ef433aaa 100644 (file)
@@ -746,14 +746,14 @@ void DGMethod<dim>::assemble_system1 ()
                                   // <code>FEFaceValues</code> objects.
   const UpdateFlags update_flags = update_values
                                    | update_gradients
-                                   | update_q_points
+                                   | update_quadrature_points
                                    | update_JxW_values;
 
                                   // Note, that on faces we do not
                                   // need gradients but we need
                                   // normal vectors.
   const UpdateFlags face_update_flags = update_values
-                                        | update_q_points
+                                        | update_quadrature_points
                                         | update_JxW_values
                                         | update_normal_vectors;
   
@@ -1213,11 +1213,11 @@ void DGMethod<dim>::assemble_system2 ()
 
   const UpdateFlags update_flags = update_values
                                    | update_gradients
-                                   | update_q_points
+                                   | update_quadrature_points
                                    | update_JxW_values;
   
   const UpdateFlags face_update_flags = update_values
-                                        | update_q_points
+                                        | update_quadrature_points
                                         | update_JxW_values
                                         | update_normal_vectors;
   
index 7a326508510334cdc6e93cfa6d00355e814adeaf..645fb3e8e1adf4571708c432f538ce194ccbdf6b 100644 (file)
@@ -1580,7 +1580,7 @@ namespace LaplaceSolver
   assemble_rhs (Vector<double> &rhs) const 
   {
     FEValues<dim> fe_values (*this->fe, *this->quadrature, 
-                            update_values | update_q_points  |
+                            update_values | update_quadrature_points  |
                              update_JxW_values);
 
     const unsigned int   dofs_per_cell = this->fe->dofs_per_cell;
index 1db22c5051acf4d200e726ce4c094dcd3cf6fd04..34ac79d8700270373fd3eca10c6959a5c1052800 100644 (file)
@@ -232,7 +232,7 @@ namespace Evaluation
     QTrapez<dim>  vertex_quadrature;
     FEValues<dim> fe_values (dof_handler.get_fe(),
                             vertex_quadrature,
-                            update_gradients | update_q_points);
+                            update_gradients | update_quadrature_points);
     std::vector<Tensor<1,dim> >
       solution_gradients (vertex_quadrature.n_quadrature_points);
     
@@ -933,7 +933,7 @@ namespace LaplaceSolver
   assemble_rhs (Vector<double> &rhs) const 
   {
     FEValues<dim> fe_values (*this->fe, *this->quadrature, 
-                            update_values  | update_q_points  |
+                            update_values  | update_quadrature_points  |
                              update_JxW_values);
 
     const unsigned int   dofs_per_cell = this->fe->dofs_per_cell;
@@ -2031,7 +2031,7 @@ namespace DualFunctional
     QGauss<dim> quadrature(4);
     FEValues<dim>  fe_values (dof_handler.get_fe(), quadrature,
                              update_gradients |
-                             update_q_points  |
+                             update_quadrature_points  |
                              update_JxW_values);
     const unsigned int n_q_points = fe_values.n_quadrature_points;
     const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
@@ -2544,7 +2544,7 @@ namespace LaplaceSolver
                  fe_values (fe, quadrature,
                             update_values             |
                             update_hessians |
-                            update_q_points           |
+                            update_quadrature_points           |
                             update_JxW_values),
                  right_hand_side (&right_hand_side)
   {  
index 374ab1229add4fe538cb94f2bbb7e4d6ce19d071..93420d8c9d786db24051d7ccc88106c21f70fd3d 100644 (file)
@@ -400,7 +400,7 @@ void MinimizationProblem<dim>::assemble_step ()
                                    // quadrature point in real space for the
                                    // $x-u^3$ terms; to get these from the
                                    // <code>FEValues</code> object, we need to pass it
-                                   // the <code>update_q_points</code> flag.
+                                   // the <code>update_quadrature_points</code> flag.
                                    //
                                    // It is a simple calculation to figure out
                                    // that for linear elements, the integrals
@@ -411,7 +411,7 @@ void MinimizationProblem<dim>::assemble_step ()
   QGauss<dim>  quadrature_formula(4);
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
                                    // Next, here are the usual two convenience
                                    // variables, followed by declarations for
@@ -879,7 +879,7 @@ void MinimizationProblem<1>::refine_grid ()
   FEValues<dim> fe_values (fe, quadrature,
                            update_values   | update_gradients |
                            update_hessians |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
                                    // The error indicator formula presented in
                                    // the introduction requires us to compute
@@ -1254,7 +1254,7 @@ MinimizationProblem<dim>::energy (const DoFHandler<dim> &dof_handler,
   QGauss<dim>  quadrature_formula(4);
   FEValues<dim> fe_values (dof_handler.get_fe(), quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
 
index 13d3f35407288a5ee88ff710b53b06714accb025..dd49e26a3a72e733f3cf7052d3b137948ee89c18 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2003, 2004, 2005, 2006 by the deal.II authors */
+/*    Copyright (C) 2003, 2004, 2005, 2006, 2007 by the deal.II authors */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -195,7 +195,7 @@ void LaplaceProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
@@ -300,7 +300,7 @@ void LaplaceProblem<dim>::assemble_multigrid ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index f4a28516051310d2ed97fc0044d245006f3ab3aa..b27ed8c262f03d17954155ca082dccd3a563e6ea 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2004, 2005, 2006 by the deal.II authors */
+/*    Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -515,7 +515,7 @@ void ElasticProblem<dim>::assemble_system ()
   QGauss<dim>  quadrature_formula(2);
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index 900b75ef3d98b6c8ffe305ed98744fa4a2d03051..803cb04065b11b580af66ca7c7ca153774030146 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2004, 2005, 2006 by the deal.II authors */
+/*    Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -1482,7 +1482,7 @@ namespace QuasiStaticElasticity
 
     FEValues<dim> fe_values (fe, quadrature_formula, 
                             update_values   | update_gradients |
-                             update_q_points | update_JxW_values);
+                             update_quadrature_points | update_JxW_values);
 
     const unsigned int   dofs_per_cell = fe.dofs_per_cell;
     const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index 4dbb7c923e499eee778af34c0238cd6bfac3c98b..68a274fd7384d1f7982e6ef39005071c45dfe572 100644 (file)
@@ -610,10 +610,10 @@ void MixedLaplaceProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values    | update_gradients |
-                           update_q_points  | update_JxW_values);
+                           update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula, 
                                    update_values    | update_normal_vectors |
-                                   update_q_points  | update_JxW_values);
+                                   update_quadrature_points  | update_JxW_values);
 
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
   const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
index a009908aa17e7a0a33015c4d2eba466a6fe651f4..46cdeca903e9d316d20333d4a0a692bee86d3521 100644 (file)
@@ -829,10 +829,10 @@ void TwoPhaseFlowProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values    | update_gradients |
-                           update_q_points  | update_JxW_values);
+                           update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula, 
                                     update_values    | update_normal_vectors |
-                                    update_q_points  | update_JxW_values);
+                                    update_quadrature_points  | update_JxW_values);
 
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
   
@@ -1000,10 +1000,10 @@ void TwoPhaseFlowProblem<dim>::assemble_rhs_S ()
   QGauss<dim-1> face_quadrature_formula(degree+2);  
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values    | update_gradients |
-                           update_q_points  | update_JxW_values);
+                           update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula, 
                                     update_values    | update_normal_vectors |
-                                    update_q_points  | update_JxW_values);
+                                    update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values_neighbor (fe, face_quadrature_formula, 
                                              update_values);
  
index ce86ff9b195e1bbbfec95ec88f89bd6bbcab3911..1490fdba2d410f0356fe7b65c7ad4de08b8d143d 100644 (file)
@@ -480,10 +480,10 @@ void BoussinesqFlowProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values    | update_gradients |
-                           update_q_points  | update_JxW_values);
+                           update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula, 
                                     update_values    | update_normal_vectors |
-                                    update_q_points  | update_JxW_values);
+                                    update_quadrature_points  | update_JxW_values);
 
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
   
@@ -614,10 +614,10 @@ void BoussinesqFlowProblem<dim>::assemble_rhs_T ()
   QGauss<dim-1> face_quadrature_formula(degree+2);  
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values    | update_gradients |
-                           update_q_points  | update_JxW_values);
+                           update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula, 
                                     update_values    | update_normal_vectors |
-                                    update_q_points  | update_JxW_values);
+                                    update_quadrature_points  | update_JxW_values);
   FEFaceValues<dim> fe_face_values_neighbor (fe, face_quadrature_formula, 
                                              update_values);
  
index a2da7cbb2a657b87053c1f28eeb07f907eb2bb8d..fc6dbe019a872b4222857d9eb615d500a7058786 100644 (file)
@@ -503,7 +503,7 @@ void SineGordonProblem<dim>::compute_nl_term (const Vector<double> &old_data,
   FEValues<dim>     fe_values (fe, quadrature_formula, 
                               update_values |
                               update_JxW_values |
-                              update_q_points);
+                              update_quadrature_points);
   
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
   const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
@@ -576,7 +576,7 @@ void SineGordonProblem<dim>::compute_nl_matrix (const Vector<double> &old_data,
 {
   QGauss<dim>   quadrature_formula (3);
   FEValues<dim> fe_values (fe, quadrature_formula, 
-                          update_values | update_JxW_values | update_q_points);
+                          update_values | update_JxW_values | update_quadrature_points);
   
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
   const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
index 6a10ae239eb0068b2c251d50e4e2329bb0e96429..40737884bfd21e45614fddf55289856834ae3def 100644 (file)
@@ -307,7 +307,7 @@ void LaplaceProblem<dim>::assemble_system ()
   hp::FEValues<dim> hp_fe_values (fe_collection,
                                  quadrature_collection, 
                                  update_values    |  update_gradients |
-                                 update_q_points  |  update_JxW_values);
+                                 update_quadrature_points  |  update_JxW_values);
 
   const RightHandSide<dim> rhs_function;
   
index fc57e23b93602dfe0b327806417a5b2b77339f5f..e633dc9037197b17883eba811d1adacf7a6c594e 100644 (file)
@@ -1018,7 +1018,7 @@ void EnergyGroup<dim>::assemble_ingroup_rhs (const Function<dim> &extraneous_sou
   const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
   
   FEValues<dim> fe_values (fe, quadrature_formula, 
-                          update_values    |  update_q_points  |
+                          update_values    |  update_quadrature_points  |
                            update_JxW_values);
   
   Vector<double>            cell_rhs (dofs_per_cell);
index 26407dac70afa20d26a6ed86cd54046c8c1ef827..ec31942f142cf0b568c08d81d6db4fdcbcf891a9 100644 (file)
@@ -414,10 +414,10 @@ void LaplaceProblem<dim>::assemble_system ()
                                   // object, as well as the quadrature
                                   // weights, <code>JxW</code>). We can tell the
                                   // <code>FEValues</code> object to do for us by also
-                                  // giving it the <code>update_q_points</code> flag:
+                                  // giving it the <code>update_quadrature_points</code> flag:
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
                                   // We then again define a few
                                   // abbreviations. The values of these
index 125c2fe335e3e8147ad3fca7ea4f554704d30608..9a1fd3530c2c62ed35f301d7383e57377c2b6357 100644 (file)
@@ -437,7 +437,7 @@ void LaplaceProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values    |  update_gradients |
-                          update_q_points  |  update_JxW_values);
+                          update_quadrature_points  |  update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index 57c0c62abfd522327a64588967863b25406407ad..e7b88c8c87c19676c9cd01592fbd4eb244db032a 100644 (file)
@@ -552,7 +552,7 @@ void LaplaceProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values    |  update_gradients |
-                          update_q_points  |  update_JxW_values);
+                          update_quadrature_points  |  update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index cd247c5913268098da8af76207be609fb1d8bea3..0fd500b68f11601753082589e7dede6657c5f9d5 100644 (file)
@@ -869,10 +869,10 @@ void HelmholtzProblem<dim>::assemble_system ()
                                   // FEFaceValues:
   FEValues<dim>  fe_values (*fe, quadrature_formula, 
                            update_values   | update_gradients |
-                            update_q_points | update_JxW_values);
+                            update_quadrature_points | update_JxW_values);
 
   FEFaceValues<dim> fe_face_values (*fe, face_quadrature_formula, 
-                                   update_values         | update_q_points  |
+                                   update_values         | update_quadrature_points  |
                                     update_normal_vectors | update_JxW_values);
 
                                   // Then we need some objects
index b117c92f7ae818bb41d759c7db47688dc15e9302..8b875fccd7813acc80536049e5760d7d1d395479 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -541,7 +541,7 @@ void ElasticProblem<dim>::assemble_system ()
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
 
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
   const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
index 09ea49099860d76aaea54ea43293cf8032a9a1a3..18060472cecf31fb97fa12eb13d3f0e736ba7f07 100644 (file)
@@ -985,9 +985,9 @@ assemble_system_interval (const typename DoFHandler<dim>::active_cell_iterator &
                                   // vectors to the cells.
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values   | update_gradients |
-                           update_q_points | update_JxW_values);
+                           update_quadrature_points | update_JxW_values);
   FEFaceValues<dim> fe_face_values (fe, face_quadrature_formula,
-                                   update_values     | update_q_points   |
+                                   update_values     | update_quadrature_points   |
                                     update_JxW_values | update_normal_vectors);
 
                                   // Then we define some
@@ -1590,7 +1590,7 @@ GradientEstimation::estimate_interval (const DoFHandler<dim> &dof_handler,
   QMidpoint<dim> midpoint_rule;
   FEValues<dim>  fe_midpoint_value (dof_handler.get_fe(),
                                    midpoint_rule,
-                                   update_values | update_q_points);
+                                   update_values | update_quadrature_points);
   
                                   // Then we need space foe the
                                   // tensor <code>Y</code>, which is the sum

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.