]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
use Quadrature::size() instead of n_quadrature_points
authorkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 17 Jan 2008 17:46:10 +0000 (17:46 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 17 Jan 2008 17:46:10 +0000 (17:46 +0000)
git-svn-id: https://svn.dealii.org/trunk@15624 0785d39b-7218-0410-832d-ea1e28bc413d

17 files changed:
deal.II/deal.II/include/fe/fe_poly.templates.h
deal.II/deal.II/include/fe/fe_tools.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/hp/q_collection.h
deal.II/deal.II/include/numerics/vectors.templates.h
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_abf.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_nedelec.cc
deal.II/deal.II/source/fe/fe_poly_tensor.cc
deal.II/deal.II/source/fe/fe_raviart_thomas.cc
deal.II/deal.II/source/fe/fe_raviart_thomas_nodal.cc
deal.II/deal.II/source/fe/fe_system.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_q.cc
deal.II/deal.II/source/fe/mapping_q1.cc

index 00373c32bef736f753158d5721d9bd580ad8ca7a..91353175ef3bdbf3126bccf1a1ca7e069fb5e105 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2007 by the deal.II authors
+//    Copyright (C) 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -168,7 +168,7 @@ FE_Poly<POLY,dim>::get_data (const UpdateFlags      update_flags,
   data->update_flags = data->update_once | data->update_each;
 
   const UpdateFlags flags(data->update_flags);
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
 
                                   // some scratch arrays
   std::vector<double> values(0);
@@ -250,7 +250,7 @@ FE_Poly<POLY,dim>::fill_fe_values (const Mapping<dim>                   &mapping
   for (unsigned int k=0; k<this->dofs_per_cell; ++k)
     {
       if (flags & update_values)
-       for (unsigned int i=0; i<quadrature.n_quadrature_points; ++i)
+       for (unsigned int i=0; i<quadrature.size(); ++i)
          data.shape_values(k,i) = fe_data.shape_values[k][i];
       
       if (flags & update_gradients)
@@ -298,14 +298,14 @@ FE_Poly<POLY,dim>::fill_fe_face_values (const Mapping<dim>                   &ma
                cell->face_orientation(face),
                cell->face_flip(face),
                cell->face_rotation(face),
-               quadrature.n_quadrature_points);
+               quadrature.size());
   
   const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
 
   for (unsigned int k=0; k<this->dofs_per_cell; ++k)
     {
       if (flags & update_values)
-        for (unsigned int i=0; i<quadrature.n_quadrature_points; ++i)
+        for (unsigned int i=0; i<quadrature.size(); ++i)
          data.shape_values(k,i) = fe_data.shape_values[k][i+offset];
       
       if (flags & update_gradients)
@@ -352,14 +352,14 @@ FE_Poly<POLY,dim>::fill_fe_subface_values (const Mapping<dim>
                   cell->face_orientation(face),
                   cell->face_flip(face),
                   cell->face_rotation(face),
-                  quadrature.n_quadrature_points);
+                  quadrature.size());
 
   const UpdateFlags flags(fe_data.update_once | fe_data.update_each);
 
   for (unsigned int k=0; k<this->dofs_per_cell; ++k)
     {
       if (flags & update_values)
-        for (unsigned int i=0; i<quadrature.n_quadrature_points; ++i)
+        for (unsigned int i=0; i<quadrature.size(); ++i)
          data.shape_values(k,i) = fe_data.shape_values[k][i+offset];
       
       if (flags & update_gradients)
index 88ee8312329df7fa122137fa8e64113b9f34dc55..e636a0d4d1af9c259b837fc7afe094eefbee0489 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -406,7 +406,7 @@ class FETools
                                       * What this function does is the
                                       * following: assume that there is scalar
                                       * data <tt>u<sub>q</sub>, 0 <= q <
-                                      * Q:=quadrature.n_quadrature_points</tt>
+                                      * Q:=quadrature.size()</tt>
                                       * defined at the quadrature points of a
                                       * cell, with the points defined by the
                                       * given <tt>rhs_quadrature</tt>
index b465618baac0986159a1b224fac4f5be8613c379..b675d6e4d62df57761c5fbad153965e80421e810 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name:  $
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -341,7 +341,7 @@ class FEValuesData
  *      ++cell)
  *   {
  *     values.reinit(cell);
- *     for (unsigned int q=0; q<quadrature.n_quadrature_points; ++q)
+ *     for (unsigned int q=0; q<quadrature.size(); ++q)
  *       for (unsigned int i=0; i<finite_element.dofs_per_cell; ++i)
  *         for (unsigned int j=0; j<finite_element.dofs_per_cell; ++j)
  *         A(i,j) += fe_values.shape_value(i,q) *
index 51dd2bc99f04de9f06cf5a74e752187483ce80f1..55d97d51059b1103bc84fd64ccd4da2947f394ed 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -173,8 +173,8 @@ namespace hp
     
     unsigned int m = 0;
     for (unsigned int i=0; i<quadratures.size(); ++i)
-      if (quadratures[i]->n_quadrature_points > m)
-        m = quadratures[i]->n_quadrature_points;
+      if (quadratures[i]->size() > m)
+        m = quadratures[i]->size();
     
     return m;
   }
index 2a1c3167141743445312f21f0130f965f7a06bd7..773d2b0d76bfe7fa7ebf7a4b8fae79e7463c3df2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name:  $
 //
-//    Copyright (C) 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -2438,7 +2438,7 @@ VectorTools::compute_mean_value (const Mapping<dim>    &mapping,
                               | update_values));
 
   typename DoFHandler<dim>::active_cell_iterator c;
-  std::vector<Vector<double> > values(quadrature.n_quadrature_points,
+  std::vector<Vector<double> > values(quadrature.size(),
                                      Vector<double> (dof.get_fe().n_components()));
   
   double mean = 0.;
@@ -2448,7 +2448,7 @@ VectorTools::compute_mean_value (const Mapping<dim>    &mapping,
     {
       fe.reinit (c);
       fe.get_function_values(v, values);
-      for (unsigned int k=0; k< quadrature.n_quadrature_points; ++k)
+      for (unsigned int k=0; k< quadrature.size(); ++k)
        {
          mean += fe.JxW(k) * values[k](component);
          area += fe.JxW(k);
index 6b521a831af3cefa7f57c4a447f14fa2fb4c15a0..2b7e92b6db97a3c209dce97c1a7c4672507b59c2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -58,7 +58,7 @@ InternalDataBase::initialize_2nd (const FiniteElement<dim> *element,
                                   // number of evaluation points)
                                   // FEValues objects with slightly
                                   // shifted positions
-  std::vector<Point<dim> > diff_points (quadrature.n_quadrature_points);
+  std::vector<Point<dim> > diff_points (quadrature.size());
   
   differences.resize(2*dim);
   for (unsigned int d=0; d<dim; ++d)
index 9c04e55b9dbb5c223f2a74a3aa927c533dd88a51..ad07723a6c8f128d1621b5c47c840cefa5089246 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -158,7 +158,7 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
   
   QGauss<dim> cell_quadrature(deg+1);
   const unsigned int n_interior_points
-    = (deg>0) ? cell_quadrature.n_quadrature_points : 0;
+    = (deg>0) ? cell_quadrature.size() : 0;
   
   this->generalized_support_points.resize (2 + n_interior_points);
   
@@ -170,7 +170,7 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
 
   interior_weights.reinit(TableIndices<3>(2+n_interior_points, 0, dim));
   
-  for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<cell_quadrature.size();++k)
     this->generalized_support_points[current++] = cell_quadrature.point(k);
   
   Assert (current == this->generalized_support_points.size(),
@@ -185,7 +185,7 @@ void
 FE_ABF<dim>::initialize_support_points (const unsigned int deg)
 {
   QGauss<dim> cell_quadrature(deg+2);
-  const unsigned int n_interior_points = cell_quadrature.n_quadrature_points;
+  const unsigned int n_interior_points = cell_quadrature.size();
 
   unsigned int n_face_points = (dim>1) ? 1 : 0;
                                   // compute (deg+1)^(dim-1)
@@ -223,7 +223,7 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
 
       boundary_weights.reinit(n_face_points, legendre.n());
       
-//       Assert (face_points.n_quadrature_points == this->dofs_per_face,
+//       Assert (face_points.size() == this->dofs_per_face,
 //           ExcInternalError());
       
       for (unsigned int k=0;k<n_face_points;++k)
@@ -255,8 +255,8 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
       // stem from applying the Gauss theorem to the nodal values, which
       // was necessary to cast the ABF elements into the deal.II framework
       // for vector valued elements.
-      boundary_weights_abf.reinit(faces.n_quadrature_points, polynomials_abf[0]->n() * dim);
-      for (unsigned int k=0;k < faces.n_quadrature_points;++k)
+      boundary_weights_abf.reinit(faces.size(), polynomials_abf[0]->n() * dim);
+      for (unsigned int k=0;k < faces.size();++k)
        {
          for (unsigned int i=0;i<polynomials_abf[0]->n() * dim;++i)
            {
@@ -284,7 +284,7 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
       
       interior_weights.reinit(TableIndices<3>(n_interior_points, polynomials[0]->n(), dim));
       
-      for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+      for (unsigned int k=0;k<cell_quadrature.size();++k)
        {
          for (unsigned int i=0;i<polynomials[0]->n();++i)
            for (unsigned int d=0;d<dim;++d)
@@ -299,18 +299,18 @@ FE_ABF<dim>::initialize_support_points (const unsigned int deg)
 
   // Decouple the creation of the generalized support points 
   // from computation of interior weights.
-  for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<cell_quadrature.size();++k)
     this->generalized_support_points[current++] = cell_quadrature.point(k);
 
   // Additional functionality for the ABF elements
   // TODO: Here the canonical extension of the principle
   // behind the ABF elements is implemented. It is unclear,
   // if this really leads to the ABF spaces in 3D!
-  interior_weights_abf.reinit(TableIndices<3>(cell_quadrature.n_quadrature_points
+  interior_weights_abf.reinit(TableIndices<3>(cell_quadrature.size()
                                              polynomials_abf[0]->n() * dim, dim));
   Tensor<1, dim> poly_grad;
 
-  for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<cell_quadrature.size();++k)
     {
       for (unsigned int i=0;i<polynomials_abf[0]->n() * dim;++i)
        {
@@ -359,7 +359,7 @@ void
 FE_ABF<dim>::initialize_restriction()
 {
   QGauss<dim-1> q_base (rt_order+1);
-  const unsigned int n_face_points = q_base.n_quadrature_points;
+  const unsigned int n_face_points = q_base.size();
                                   // First, compute interpolation on
                                   // subfaces
   for (unsigned int face=0;face<GeometryInfo<dim>::faces_per_cell;++face)
@@ -373,8 +373,8 @@ FE_ABF<dim>::initialize_restriction()
                                       // Store shape values, since the
                                       // evaluation suffers if not
                                       // ordered by point
-      Table<2,double> cached_values(this->dofs_per_cell, q_face.n_quadrature_points);
-      for (unsigned int k=0;k<q_face.n_quadrature_points;++k)
+      Table<2,double> cached_values(this->dofs_per_cell, q_face.size());
+      for (unsigned int k=0;k<q_face.size();++k)
        for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
          cached_values(i,k)
            = this->shape_value_component(i, q_face.point(k),
@@ -446,8 +446,8 @@ FE_ABF<dim>::initialize_restriction()
                                   // Store shape values, since the
                                   // evaluation suffers if not
                                   // ordered by point
-  Table<3,double> cached_values(this->dofs_per_cell, q_cell.n_quadrature_points, dim);
-  for (unsigned int k=0;k<q_cell.n_quadrature_points;++k)
+  Table<3,double> cached_values(this->dofs_per_cell, q_cell.size(), dim);
+  for (unsigned int k=0;k<q_cell.size();++k)
     for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
       for (unsigned int d=0;d<dim;++d)
        cached_values(i,k,d) = this->shape_value_component(i, q_cell.point(k), d);
@@ -456,7 +456,7 @@ FE_ABF<dim>::initialize_restriction()
     {
       Quadrature<dim> q_sub = QProjector<dim>::project_to_child(q_cell, child);
       
-      for (unsigned int k=0;k<q_sub.n_quadrature_points;++k)
+      for (unsigned int k=0;k<q_sub.size();++k)
        for (unsigned int i_child = 0; i_child < this->dofs_per_cell; ++i_child)
          for (unsigned int d=0;d<dim;++d)
            for (unsigned int i_weight=0;i_weight<polynomials[d]->n();++i_weight)
index 3b492aa9a0c9c544aadbb7077ffb05e767c84a7e..3e7326db4f132930c5dce061bacf850717186c00 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -196,10 +196,10 @@ FE_DGQ<dim>::FE_DGQ (const Quadrature<1>& points)
                :
                FE_Poly<TensorProductPolynomials<dim>, dim> (
                  TensorProductPolynomials<dim>(Polynomials::Lagrange::generate_complete_basis(points.get_points())),
-                 FiniteElementData<dim>(get_dpo_vector(points.n_quadrature_points-1), 1, points.n_quadrature_points-1, FiniteElementData<dim>::L2),
-                 std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(points.n_quadrature_points-1),1, points.n_quadrature_points-1).dofs_per_cell, true),
+                 FiniteElementData<dim>(get_dpo_vector(points.size()-1), 1, points.size()-1, FiniteElementData<dim>::L2),
+                 std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(points.size()-1),1, points.size()-1).dofs_per_cell, true),
                  std::vector<std::vector<bool> >(FiniteElementData<dim>(
-                   get_dpo_vector(points.n_quadrature_points-1),1, points.n_quadrature_points-1).dofs_per_cell, std::vector<bool>(1,true)))
+                   get_dpo_vector(points.size()-1),1, points.size()-1).dofs_per_cell, std::vector<bool>(1,true)))
 {
   for (unsigned int i=0; i<GeometryInfo<dim>::children_per_cell; ++i)
     this->prolongation[i].reinit (this->dofs_per_cell,
index 28b0b5cadf35a152665c21d94f2534af530c5a27..34df091c8a5f6dc9fb29d6de08565e4dcc1bc2f7 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -935,7 +935,7 @@ FE_Nedelec<dim>::get_data (const UpdateFlags      update_flags,
    data->update_flags = data->update_once | data->update_each;
 
    const UpdateFlags flags(data->update_flags);
-   const unsigned int n_q_points = quadrature.n_quadrature_points;
+   const unsigned int n_q_points = quadrature.size();
 
                                   // initialize fields only if really
                                   // necessary. otherwise, don't
@@ -1005,7 +1005,7 @@ FE_Nedelec<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
                                   // fields that have to be filled
   const UpdateFlags flags(fe_data.current_update_flags());
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
                                  
                                   // fill shape function
                                   // values. these are vector-valued,
@@ -1136,13 +1136,13 @@ FE_Nedelec<dim>::fill_fe_face_values (const Mapping<dim>                   &mapp
             cell->face_orientation(face),
             cell->face_flip(face),
             cell->face_rotation(face),
-             quadrature.n_quadrature_points));
+             quadrature.size()));
 
                                   // get the flags indicating the
                                   // fields that have to be filled
   const UpdateFlags flags(fe_data.current_update_flags());
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
                                  
                                   // fill shape function
                                   // values. these are vector-valued,
@@ -1285,13 +1285,13 @@ FE_Nedelec<dim>::fill_fe_subface_values (const Mapping<dim>                   &m
                cell->face_orientation(face),
                cell->face_flip(face),
                cell->face_rotation(face),
-               quadrature.n_quadrature_points));
+               quadrature.size()));
 
                                   // get the flags indicating the
                                   // fields that have to be filled
   const UpdateFlags flags(fe_data.current_update_flags());
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
                                  
                                   // fill shape function
                                   // values. these are vector-valued,
index 96cfb3563da7bacabb82a8ce501da084fc67d30b..5a2d82d7a4e262c63e1f01a2e19a5dafde9a6a78 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -262,7 +262,7 @@ FE_PolyTensor<POLY,dim>::get_data (const UpdateFlags      update_flags,
   data->update_flags = data->update_once | data->update_each;
 
   const UpdateFlags flags(data->update_flags);
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
   
                                   // some scratch arrays
   std::vector<Tensor<1,dim> > values(0);
@@ -364,7 +364,7 @@ FE_PolyTensor<POLY,dim>::fill_fe_values (
 //           && dynamic_cast<const MappingCartesian<dim>*>(&mapping) != 0),
 //      ExcNotImplemented());
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
   const UpdateFlags flags(fe_data.current_update_flags());
   
   Assert(!(flags & update_values) || fe_data.shape_values.size() == this->dofs_per_cell,
@@ -529,7 +529,7 @@ FE_PolyTensor<POLY,dim>::fill_fe_face_values (
                                   // possible
   InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
                                   // offset determines which data set
                                   // to take (all data sets for all
                                   // faces are stored contiguously)
@@ -713,7 +713,7 @@ FE_PolyTensor<POLY,dim>::fill_fe_subface_values (
                                   // possible
   InternalData &fe_data = dynamic_cast<InternalData &> (fedata);
 
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
                                   // offset determines which data set
                                   // to take (all data sets for all
                                 // sub-faces are stored contiguously)
index f1a157a08e97a84210f441bc54b3060e8ad1ba29..31f1456e8913710f58fbe5a35971e14df5093967 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -141,7 +141,7 @@ FE_RaviartThomas<dim>::initialize_support_points (const unsigned int deg)
   
   QGauss<dim> cell_quadrature(deg+1);
   const unsigned int n_interior_points
-    = (deg>0) ? cell_quadrature.n_quadrature_points : 0;
+    = (deg>0) ? cell_quadrature.size() : 0;
   
   this->generalized_support_points.resize (2 + n_interior_points);
   
@@ -153,7 +153,7 @@ FE_RaviartThomas<dim>::initialize_support_points (const unsigned int deg)
 
   interior_weights.reinit(TableIndices<3>(2+n_interior_points, 0, dim));
   
-  for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<cell_quadrature.size();++k)
     this->generalized_support_points[current++] = cell_quadrature.point(k);
   
   Assert (current == this->generalized_support_points.size(),
@@ -169,7 +169,7 @@ FE_RaviartThomas<dim>::initialize_support_points (const unsigned int deg)
 {
   QGauss<dim> cell_quadrature(deg+1);
   const unsigned int n_interior_points
-    = (deg>0) ? cell_quadrature.n_quadrature_points : 0;
+    = (deg>0) ? cell_quadrature.size() : 0;
   
   unsigned int n_face_points = (dim>1) ? 1 : 0;
                                   // compute (deg+1)^(dim-1)
@@ -192,7 +192,7 @@ FE_RaviartThomas<dim>::initialize_support_points (const unsigned int deg)
 
       boundary_weights.reinit(n_face_points, legendre.n());
       
-//       Assert (face_points.n_quadrature_points == this->dofs_per_face,
+//       Assert (face_points.size() == this->dofs_per_face,
 //           ExcInternalError());
       
       for (unsigned int k=0;k<n_face_points;++k)
@@ -236,7 +236,7 @@ FE_RaviartThomas<dim>::initialize_support_points (const unsigned int deg)
   
   interior_weights.reinit(TableIndices<3>(n_interior_points, polynomials[0]->n(), dim));
   
-  for (unsigned int k=0;k<cell_quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<cell_quadrature.size();++k)
     {
       this->generalized_support_points[current++] = cell_quadrature.point(k);
       for (unsigned int i=0;i<polynomials[0]->n();++i)
@@ -282,7 +282,7 @@ void
 FE_RaviartThomas<dim>::initialize_restriction()
 {
   QGauss<dim-1> q_base (rt_order+1);
-  const unsigned int n_face_points = q_base.n_quadrature_points;
+  const unsigned int n_face_points = q_base.size();
                                   // First, compute interpolation on
                                   // subfaces
   for (unsigned int face=0;face<GeometryInfo<dim>::faces_per_cell;++face)
@@ -296,8 +296,8 @@ FE_RaviartThomas<dim>::initialize_restriction()
                                       // Store shape values, since the
                                       // evaluation suffers if not
                                       // ordered by point
-      Table<2,double> cached_values(this->dofs_per_cell, q_face.n_quadrature_points);
-      for (unsigned int k=0;k<q_face.n_quadrature_points;++k)
+      Table<2,double> cached_values(this->dofs_per_cell, q_face.size());
+      for (unsigned int k=0;k<q_face.size();++k)
        for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
          cached_values(i,k)
            = this->shape_value_component(i, q_face.point(k),
@@ -369,8 +369,8 @@ FE_RaviartThomas<dim>::initialize_restriction()
                                   // Store shape values, since the
                                   // evaluation suffers if not
                                   // ordered by point
-  Table<3,double> cached_values(this->dofs_per_cell, q_cell.n_quadrature_points, dim);
-  for (unsigned int k=0;k<q_cell.n_quadrature_points;++k)
+  Table<3,double> cached_values(this->dofs_per_cell, q_cell.size(), dim);
+  for (unsigned int k=0;k<q_cell.size();++k)
     for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
       for (unsigned int d=0;d<dim;++d)
        cached_values(i,k,d) = this->shape_value_component(i, q_cell.point(k), d);
@@ -379,7 +379,7 @@ FE_RaviartThomas<dim>::initialize_restriction()
     {
       Quadrature<dim> q_sub = QProjector<dim>::project_to_child(q_cell, child);
       
-      for (unsigned int k=0;k<q_sub.n_quadrature_points;++k)
+      for (unsigned int k=0;k<q_sub.size();++k)
        for (unsigned int i_child = 0; i_child < this->dofs_per_cell; ++i_child)
          for (unsigned int d=0;d<dim;++d)
            for (unsigned int i_weight=0;i_weight<polynomials[d]->n();++i_weight)
index 6d3c488574da743c50f4866f57fa9255cb99e0fa..58efbaade19a3eb3781aafcca9b7e95810ca342c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -321,7 +321,7 @@ FE_RaviartThomasNodal<dim>::initialize_support_points (const unsigned int deg)
   if (dim>1)
     {
       QGauss<dim-1> face_points (deg+1);
-      Assert (face_points.n_quadrature_points == this->dofs_per_face,
+      Assert (face_points.size() == this->dofs_per_face,
              ExcInternalError());
       for (unsigned int k=0;k<this->dofs_per_face;++k)
        this->generalized_face_support_points[k] = face_points.point(k);
@@ -357,7 +357,7 @@ FE_RaviartThomasNodal<dim>::initialize_support_points (const unsigned int deg)
                                                       ((d==2) ? low : high));
       Assert(dim<=3, ExcNotImplemented());
       
-      for (unsigned int k=0;k<quadrature->n_quadrature_points;++k)
+      for (unsigned int k=0;k<quadrature->size();++k)
        this->generalized_support_points[current++] = quadrature->point(k);
       delete quadrature;
     }
index 3e21d7dc18be656435b616761dbd3b31466d3fe6..de5ed06659bf6adc4fde6b8b8929213df6ae688f 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -724,7 +724,7 @@ compute_fill (const Mapping<dim>                   &mapping,
               typename Mapping<dim>::InternalDataBase &fedata,
               FEValuesData<dim>                    &data) const
 {       
-  const unsigned int n_q_points = quadrature.n_quadrature_points;
+  const unsigned int n_q_points = quadrature.size();
   
                                   // convert data object to internal
                                   // data for this class. fails with
index f56f75ca493dfba25bb6a5b729bbbf917cd8b90f..ca84a9f80d92794d136718ee6bf6c35c8217859a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -495,7 +495,7 @@ void FETools::get_projection_matrix (const FiniteElement<dim> &fe1,
                                   // This happens in the target space
   FullMatrix<double> mass (n2, n2);
 
-  for (unsigned int k=0;k<quadrature.n_quadrature_points;++k)
+  for (unsigned int k=0;k<quadrature.size();++k)
     {
       const double w = val2.JxW(k);
       for (unsigned int i=0;i<n2;++i)
@@ -522,7 +522,7 @@ void FETools::get_projection_matrix (const FiniteElement<dim> &fe1,
     {
       b = 0.;
       for (unsigned int i=0;i<n2;++i)
-        for (unsigned int k=0;k<quadrature.n_quadrature_points;++k)
+        for (unsigned int k=0;k<quadrature.size();++k)
           {
             const double w = val2.JxW(k);
             const double u = val1.shape_value(j,k);
@@ -606,7 +606,7 @@ FETools::compute_embedding_matrices(const FiniteElement<dim>& fe,
 
   MappingCartesian<dim> mapping;
   QGauss<dim> q_fine(degree+1);
-  const unsigned int nq = q_fine.n_quadrature_points;
+  const unsigned int nq = q_fine.size();
   
   FEValues<dim> fine (mapping, fe, q_fine,
                      update_quadrature_points | update_JxW_values | update_values);
@@ -725,7 +725,7 @@ FETools::compute_face_embedding_matrices(const FiniteElement<dim>& fe,
   QGauss<dim-1> q_gauss(degree+1);
   const Quadrature<dim> q_fine = QProjector<dim>::project_to_face(q_gauss, face_fine);
   
-  const unsigned int nq = q_fine.n_quadrature_points;
+  const unsigned int nq = q_fine.size();
 
                                   // In order to make the loops below
                                   // simpler, we introduce vectors
@@ -885,7 +885,7 @@ FETools::compute_projection_matrices(const FiniteElement<dim>& fe,
   
   MappingCartesian<dim> mapping;
   QGauss<dim> q_fine(degree+1);
-  const unsigned int nq = q_fine.n_quadrature_points;
+  const unsigned int nq = q_fine.size();
   
   FEValues<dim> coarse (mapping, fe, q_fine,
                        update_quadrature_points | update_JxW_values | update_values);
@@ -1795,17 +1795,17 @@ compute_projection_from_quadrature_points_matrix (const FiniteElement<dim> &fe,
                                    // first build the matrices M and Q
                                    // described in the documentation
   FullMatrix<double> M (fe.dofs_per_cell, fe.dofs_per_cell);
-  FullMatrix<double> Q (fe.dofs_per_cell, rhs_quadrature.n_quadrature_points);
+  FullMatrix<double> Q (fe.dofs_per_cell, rhs_quadrature.size());
 
   for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
     for (unsigned int j=0; j<fe.dofs_per_cell; ++j)
-      for (unsigned int q=0; q<lhs_quadrature.n_quadrature_points; ++q)
+      for (unsigned int q=0; q<lhs_quadrature.size(); ++q)
         M(i,j) += fe.shape_value (i, lhs_quadrature.point(q)) *
                   fe.shape_value (j, lhs_quadrature.point(q)) *
                   lhs_quadrature.weight(q);
 
   for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
-    for (unsigned int q=0; q<rhs_quadrature.n_quadrature_points; ++q)
+    for (unsigned int q=0; q<rhs_quadrature.size(); ++q)
       Q(i,q) += fe.shape_value (i, rhs_quadrature.point(q)) *
                 rhs_quadrature.weight(q);
 
@@ -1814,11 +1814,11 @@ compute_projection_from_quadrature_points_matrix (const FiniteElement<dim> &fe,
   M_inverse.invert (M);
 
                                    // finally compute the result
-  X.reinit (fe.dofs_per_cell, rhs_quadrature.n_quadrature_points);
+  X.reinit (fe.dofs_per_cell, rhs_quadrature.size());
   M_inverse.mmult (X, Q);
 
   Assert (X.m() == fe.dofs_per_cell, ExcInternalError());
-  Assert (X.n() == rhs_quadrature.n_quadrature_points, ExcInternalError());
+  Assert (X.n() == rhs_quadrature.size(), ExcInternalError());
 }
 
 
@@ -1831,11 +1831,11 @@ compute_interpolation_to_quadrature_points_matrix (const FiniteElement<dim> &fe,
                                                    FullMatrix<double>       &I_q)
 {
   Assert (fe.n_components() == 1, ExcNotImplemented());
-  Assert (I_q.m() == quadrature.n_quadrature_points,
+  Assert (I_q.m() == quadrature.size(),
           ExcMessage ("Wrong matrix size"));
   Assert (I_q.n() == fe.dofs_per_cell, ExcMessage ("Wrong matrix size"));
 
-  for (unsigned int q=0; q<quadrature.n_quadrature_points; ++q)
+  for (unsigned int q=0; q<quadrature.size(); ++q)
     for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
       I_q(q,i) = fe.shape_value (i, quadrature.point(q));
 }
index ea1be93b8e04aa2c29ed8a77f33a494c9f36ea18..8408e3574c881648912bf0af4f38df40e7d3e165 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1198,7 +1198,7 @@ FEValues<dim>::FEValues (const Mapping<dim>       &mapping,
                         const Quadrature<dim>    &q,
                         const UpdateFlags         update_flags)
                :
-               FEValuesBase<dim> (q.n_quadrature_points,
+               FEValuesBase<dim> (q.size(),
                                   fe.dofs_per_cell,
                                   update_default,
                                   mapping,
@@ -1215,7 +1215,7 @@ FEValues<dim>::FEValues (const FiniteElement<dim> &fe,
                         const Quadrature<dim>    &q,
                         const UpdateFlags         update_flags)
                :
-               FEValuesBase<dim> (q.n_quadrature_points,
+               FEValuesBase<dim> (q.size(),
                                   fe.dofs_per_cell,
                                   update_default,
                                   StaticMappingQ1<dim>::mapping,
@@ -1469,7 +1469,7 @@ FEFaceValues<dim>::FEFaceValues (const Mapping<dim>       &mapping,
                                 const Quadrature<dim-1>  &quadrature,
                                 const UpdateFlags         update_flags)
                :
-               FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
+               FEFaceValuesBase<dim> (quadrature.size(),
                                       fe.dofs_per_cell,
                                       update_flags,
                                       mapping,
@@ -1485,7 +1485,7 @@ FEFaceValues<dim>::FEFaceValues (const FiniteElement<dim> &fe,
                                 const Quadrature<dim-1>  &quadrature,
                                 const UpdateFlags         update_flags)
                :
-               FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
+               FEFaceValuesBase<dim> (quadrature.size(),
                                       fe.dofs_per_cell,
                                       update_flags,
                                       StaticMappingQ1<dim>::mapping,
@@ -1683,7 +1683,7 @@ FESubfaceValues<dim>::FESubfaceValues (const Mapping<dim>       &mapping,
                                       const Quadrature<dim-1>  &quadrature,
                                       const UpdateFlags         update_flags)
                :
-               FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
+               FEFaceValuesBase<dim> (quadrature.size(),
                                       fe.dofs_per_cell,
                                       update_flags,
                                       mapping,
@@ -1699,7 +1699,7 @@ FESubfaceValues<dim>::FESubfaceValues (const FiniteElement<dim> &fe,
                                       const Quadrature<dim-1>  &quadrature,
                                       const UpdateFlags         update_flags)
                :
-               FEFaceValuesBase<dim> (quadrature.n_quadrature_points,
+               FEFaceValuesBase<dim> (quadrature.size(),
                                       fe.dofs_per_cell,
                                       update_flags,
                                       StaticMappingQ1<dim>::mapping,
index 7b027cd1fc1e365be18114cbb17d74fed56fbb34..1c5a3f210d1f5ce3fe82312726b1adf1fdd5daba 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -236,10 +236,10 @@ MappingQ<dim>::get_data (const UpdateFlags update_flags,
 {
   InternalData *data = new InternalData(n_shape_functions);
   this->compute_data (update_flags, quadrature,
-                      quadrature.n_quadrature_points, *data);
+                      quadrature.size(), *data);
   if (!use_mapping_q_on_all_cells)
     this->compute_data (update_flags, quadrature,
-                        quadrature.n_quadrature_points, data->mapping_q1_data);
+                        quadrature.size(), data->mapping_q1_data);
   return data;
 }
 
@@ -253,10 +253,10 @@ MappingQ<dim>::get_face_data (const UpdateFlags update_flags,
   InternalData *data = new InternalData(n_shape_functions);
   const Quadrature<dim> q (QProjector<dim>::project_to_all_faces(quadrature));
   this->compute_face_data (update_flags, q,
-                           quadrature.n_quadrature_points, *data);
+                           quadrature.size(), *data);
   if (!use_mapping_q_on_all_cells)
     this->compute_face_data (update_flags, q,
-                             quadrature.n_quadrature_points,
+                             quadrature.size(),
                              data->mapping_q1_data);
   return data;
 }
@@ -271,10 +271,10 @@ MappingQ<dim>::get_subface_data (const UpdateFlags update_flags,
   InternalData *data = new InternalData(n_shape_functions);
   const Quadrature<dim> q (QProjector<dim>::project_to_all_subfaces(quadrature));
   this->compute_face_data (update_flags, q,
-                           quadrature.n_quadrature_points, *data);
+                           quadrature.size(), *data);
   if (!use_mapping_q_on_all_cells)
     this->compute_face_data (update_flags, q,
-                             quadrature.n_quadrature_points,
+                             quadrature.size(),
                              data->mapping_q1_data);
   return data;
 }
@@ -362,7 +362,7 @@ MappingQ<dim>::fill_fe_face_values (const typename Triangulation<dim>::cell_iter
   else
     p_data=&data;
 
-  const unsigned int n_q_points=q.n_quadrature_points;
+  const unsigned int n_q_points=q.size();
   this->compute_fill_face (cell, face_no, false,
                            n_q_points,
                            QProjector<dim>::DataSetDescriptor::
@@ -426,7 +426,7 @@ MappingQ<dim>::fill_fe_subface_values (const typename Triangulation<dim>::cell_i
   else
     p_data=&data;
 
-  const unsigned int n_q_points=q.n_quadrature_points;
+  const unsigned int n_q_points=q.size();
   this->compute_fill_face (cell, face_no, true,
                            n_q_points,
                            QProjector<dim>::DataSetDescriptor::
@@ -749,7 +749,7 @@ MappingQ<dim>::compute_laplace_vector(Table<2,double> &lvs) const
                                   // gradients at the quadrature
                                   // points on the unit cell
   const QGauss<dim> quadrature(degree+1);
-  const unsigned int n_q_points=quadrature.n_quadrature_points;
+  const unsigned int n_q_points=quadrature.size();
   
   InternalData quadrature_data(n_shape_functions);
   quadrature_data.shape_derivatives.resize(n_shape_functions * n_q_points);
index 49d1c05311fdcb57704bc03be359b4e7d314021d..1393441f8978bb792f8324c51f2b1a8bf30f87f7 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -305,7 +305,7 @@ MappingQ1<dim>::compute_data (const UpdateFlags      update_flags,
                              const unsigned int     n_original_q_points,
                              InternalData          &data) const
 {
-  const unsigned int n_q_points = q.n_quadrature_points;
+  const unsigned int n_q_points = q.size();
 
   data.update_once = update_once(update_flags);
   data.update_each = update_each(update_flags);
@@ -336,7 +336,7 @@ MappingQ1<dim>::get_data (const UpdateFlags update_flags,
                          const Quadrature<dim>& q) const
 {
   InternalData* data = new InternalData(n_shape_functions);
-  compute_data (update_flags, q, q.n_quadrature_points, *data);
+  compute_data (update_flags, q, q.size(), *data);
   return data;
 }
 
@@ -430,7 +430,7 @@ MappingQ1<dim>::get_face_data (const UpdateFlags        update_flags,
   InternalData* data = new InternalData(n_shape_functions);
   compute_face_data (update_flags,
                     QProjector<dim>::project_to_all_faces(quadrature),
-                    quadrature.n_quadrature_points,
+                    quadrature.size(),
                     *data);
 
   return data;
@@ -446,7 +446,7 @@ MappingQ1<dim>::get_subface_data (const UpdateFlags update_flags,
   InternalData* data = new InternalData(n_shape_functions);
   compute_face_data (update_flags,
                     QProjector<dim>::project_to_all_subfaces(quadrature),
-                    quadrature.n_quadrature_points,
+                    quadrature.size(),
                     *data);
 
   return data;
@@ -570,7 +570,7 @@ MappingQ1<dim>::fill_fe_values (const typename Triangulation<dim>::cell_iterator
   Assert(data_ptr!=0, ExcInternalError());
   InternalData &data=*data_ptr;
 
-  const unsigned int n_q_points=q.n_quadrature_points;
+  const unsigned int n_q_points=q.size();
   
   compute_fill (cell, n_q_points, DataSetDescriptor::cell (),
                 data, quadrature_points);
@@ -718,7 +718,7 @@ MappingQ1<dim>::fill_fe_face_values (const typename Triangulation<dim>::cell_ite
   Assert(data_ptr!=0, ExcInternalError());
   InternalData &data=*data_ptr;
 
-  const unsigned int n_q_points = q.n_quadrature_points;
+  const unsigned int n_q_points = q.size();
   
   compute_fill_face (cell, face_no, false,
                     n_q_points,
@@ -754,7 +754,7 @@ MappingQ1<dim>::fill_fe_subface_values (const typename Triangulation<dim>::cell_
   Assert(data_ptr!=0, ExcInternalError());
   InternalData &data=*data_ptr;
 
-  const unsigned int n_q_points = q.n_quadrature_points;
+  const unsigned int n_q_points = q.size();
   
   compute_fill_face (cell, face_no, true,
                     n_q_points,

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.