]> 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 20:15:58 +0000 (20:15 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 17 Jan 2008 20:15:58 +0000 (20:15 +0000)
git-svn-id: https://svn.dealii.org/trunk@15625 0785d39b-7218-0410-832d-ea1e28bc413d

21 files changed:
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-24/step-24.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-29/step-29.cc
deal.II/examples/step-3/step-3.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 645fb3e8e1adf4571708c432f538ce194ccbdf6b..6779c7d52e0eb31175cbf377e2024c2a0c6f8350 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2001, 2002, 2003, 2004, 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     */
@@ -1254,7 +1254,7 @@ namespace LaplaceSolver
                             update_gradients | update_JxW_values);
 
     const unsigned int   dofs_per_cell = fe->dofs_per_cell;
-    const unsigned int   n_q_points    = quadrature->n_quadrature_points;
+    const unsigned int   n_q_points    = quadrature->size();
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
@@ -1584,7 +1584,7 @@ namespace LaplaceSolver
                              update_JxW_values);
 
     const unsigned int   dofs_per_cell = this->fe->dofs_per_cell;
-    const unsigned int   n_q_points    = this->quadrature->n_quadrature_points;
+    const unsigned int   n_q_points    = this->quadrature->size();
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
index 34ac79d8700270373fd3eca10c6959a5c1052800..a364483e1a6022fcfbfc418fb49320c167436856 100644 (file)
@@ -4,7 +4,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     */
@@ -234,7 +234,7 @@ namespace Evaluation
                             vertex_quadrature,
                             update_gradients | update_quadrature_points);
     std::vector<Tensor<1,dim> >
-      solution_gradients (vertex_quadrature.n_quadrature_points);
+      solution_gradients (vertex_quadrature.size());
     
                                     // ...and next loop over all cells
                                     // and their vertices, and count
@@ -684,7 +684,7 @@ namespace LaplaceSolver
                             update_gradients | update_JxW_values);
 
     const unsigned int   dofs_per_cell = fe->dofs_per_cell;
-    const unsigned int   n_q_points    = quadrature->n_quadrature_points;
+    const unsigned int   n_q_points    = quadrature->size();
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
@@ -937,7 +937,7 @@ namespace LaplaceSolver
                              update_JxW_values);
 
     const unsigned int   dofs_per_cell = this->fe->dofs_per_cell;
-    const unsigned int   n_q_points    = this->quadrature->n_quadrature_points;
+    const unsigned int   n_q_points    = this->quadrature->size();
 
     Vector<double>       cell_rhs (dofs_per_cell);
     std::vector<double>  rhs_values (n_q_points);
@@ -2549,7 +2549,7 @@ namespace LaplaceSolver
                  right_hand_side (&right_hand_side)
   {  
     const unsigned int n_q_points
-      = quadrature.n_quadrature_points;
+      = quadrature.size();
   
     cell_residual.resize(n_q_points);
     rhs_values.resize(n_q_points);    
@@ -2578,7 +2578,7 @@ namespace LaplaceSolver
                                          update_gradients)
   {  
     const unsigned int n_face_q_points
-      = face_quadrature.n_quadrature_points;
+      = face_quadrature.size();
   
     jump_residual.resize(n_face_q_points);
     dual_weights.resize(n_face_q_points);    
index 93420d8c9d786db24051d7ccc88106c21f70fd3d..076e1a26e2339706dfbd83466993859e8b9daa9a 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2002, 2003, 2004, 2006, 2007 by the deal.II authors                   */
+/*    Copyright (C) 2002, 2003, 2004, 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     */
@@ -420,7 +420,7 @@ void MinimizationProblem<dim>::assemble_step ()
                                    // hold the indices of the local degrees of
                                    // freedom on each cell:
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
@@ -903,9 +903,9 @@ void MinimizationProblem<1>::refine_grid ()
                                    // at quadrature points. Here, we also need
                                    // second derivatives, which is simple,
                                    // however:
-  std::vector<double> local_values (quadrature.n_quadrature_points);
-  std::vector<Tensor<1,dim> > local_gradients (quadrature.n_quadrature_points);
-  std::vector<Tensor<2,dim> > local_2nd_derivs (quadrature.n_quadrature_points);
+  std::vector<double> local_values (quadrature.size());
+  std::vector<Tensor<1,dim> > local_gradients (quadrature.size());
+  std::vector<Tensor<2,dim> > local_2nd_derivs (quadrature.size());
 
                                    // With all this, we can start the loop
                                    // over all cells. Since we need to write
@@ -942,7 +942,7 @@ void MinimizationProblem<1>::refine_grid ()
                                        // since we extract the gradient as a
                                        // scalar value.
       double cell_residual_norm = 0;
-      for (unsigned int q=0; q<quadrature.n_quadrature_points; ++q)
+      for (unsigned int q=0; q<quadrature.size(); ++q)
         {
           const double x             = fe_values.quadrature_point(q)[0];
           const double u             = local_values[q];
@@ -1256,7 +1256,7 @@ MinimizationProblem<dim>::energy (const DoFHandler<dim> &dof_handler,
                           update_values   | update_gradients |
                            update_quadrature_points | update_JxW_values);
 
-  const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
                                    // Then, just as when we integrated the
                                    // linear system, we need two variables
index dd49e26a3a72e733f3cf7052d3b137948ee89c18..3b5ff0c249b1a70efbf17e61f41e51d5e194900d 100644 (file)
@@ -4,7 +4,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     */
@@ -198,7 +198,7 @@ void LaplaceProblem<dim>::assemble_system ()
                            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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
@@ -303,7 +303,7 @@ void LaplaceProblem<dim>::assemble_multigrid ()
                            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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
index b27ed8c262f03d17954155ca082dccd3a563e6ea..d34b682d31446f16c7ed9570e16353d019e1e002 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 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     */
@@ -518,7 +518,7 @@ void ElasticProblem<dim>::assemble_system ()
                            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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
index 803cb04065b11b580af66ca7c7ca153774030146..5a7f423831c0095e69090f356107cd0f890eefab 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2004, 2005, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 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     */
@@ -1485,7 +1485,7 @@ namespace QuasiStaticElasticity
                              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;
+    const unsigned int   n_q_points    = quadrature_formula.size();
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
@@ -1998,7 +1998,7 @@ namespace QuasiStaticElasticity
                                              // points...
             SymmetricTensor<2,dim> accumulated_stress;
             for (unsigned int q=0;
-                 q<quadrature_formula.n_quadrature_points;
+                 q<quadrature_formula.size();
                  ++q)
               accumulated_stress +=
                 reinterpret_cast<PointHistory<dim>*>(cell->user_pointer())[q]
@@ -2008,7 +2008,7 @@ namespace QuasiStaticElasticity
                                              // average to their destination:
             norm_of_stress(index)
               = (accumulated_stress /
-                 quadrature_formula.n_quadrature_points).norm();
+                 quadrature_formula.size()).norm();
           }
                                        // And on the cells that we are not
                                        // interested in, set the respective
@@ -2543,7 +2543,7 @@ namespace QuasiStaticElasticity
       tmp.swap (quadrature_point_history);
     }
     quadrature_point_history.resize (our_cells *
-                                    quadrature_formula.n_quadrature_points);
+                                    quadrature_formula.size());
 
                                     // Finally loop over all cells again and
                                     // set the user pointers from the cells
@@ -2558,7 +2558,7 @@ namespace QuasiStaticElasticity
       if (cell->subdomain_id() == this_mpi_process)
        {
          cell->set_user_pointer (&quadrature_point_history[history_index]);
-         history_index += quadrature_formula.n_quadrature_points;
+         history_index += quadrature_formula.size();
        }
 
                                      // At the end, for good measure make sure
@@ -2687,7 +2687,7 @@ namespace QuasiStaticElasticity
     FEValues<dim> fe_values (fe, quadrature_formula, 
                             update_values | update_gradients);
     std::vector<std::vector<Tensor<1,dim> > >
-      displacement_increment_grads (quadrature_formula.n_quadrature_points,
+      displacement_increment_grads (quadrature_formula.size(),
                                    std::vector<Tensor<1,dim> >(dim));
   
                                     // Then loop over all cells and do the
@@ -2725,7 +2725,7 @@ namespace QuasiStaticElasticity
 
                                           // Then loop over the quadrature
                                           // points of this cell:
-         for (unsigned int q=0; q<quadrature_formula.n_quadrature_points; ++q)
+         for (unsigned int q=0; q<quadrature_formula.size(); ++q)
            {
                                                // On each quadrature point,
                                                // compute the strain increment
index fccd4a2d4f853be01d6a191d653a26aafa86c146..76552ff4fea8c2e35198e92bf040e113e6933bac 100644 (file)
@@ -4,7 +4,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     */
@@ -616,8 +616,8 @@ void MixedLaplaceProblem<dim>::assemble_system ()
                                    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;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
 
   FullMatrix<double>   local_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       local_rhs (dofs_per_cell);
index 46cdeca903e9d316d20333d4a0a692bee86d3521..b81f519fcab5a492f4881bd7c2a63ee92ba9efa3 100644 (file)
@@ -4,7 +4,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     */
@@ -836,8 +836,8 @@ void TwoPhaseFlowProblem<dim>::assemble_system ()
 
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
   
-  const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
 
   FullMatrix<double>   local_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       local_rhs (dofs_per_cell);
@@ -1008,8 +1008,8 @@ void TwoPhaseFlowProblem<dim>::assemble_rhs_S ()
                                              update_values);
  
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
-  const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
   
   Vector<double>       local_rhs (dofs_per_cell);
 
@@ -1354,7 +1354,7 @@ TwoPhaseFlowProblem<dim>::get_maximal_velocity () const
 {
   QGauss<dim>   quadrature_formula(degree+2); 
   const unsigned int   n_q_points
-    = quadrature_formula.n_quadrature_points;
+    = quadrature_formula.size();
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values);
index 245db29a1f14f3d158af15f8d21643b178906197..cfd44f6b53c915d13d590bb4615785b3d4bf30f9 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2007 by the deal.II authors */
+/*    Copyright (C) 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     */
@@ -872,8 +872,8 @@ void BoussinesqFlowProblem<dim>::assemble_system ()
 
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
   
-  const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
 
   FullMatrix<double>   local_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       local_rhs (dofs_per_cell);
@@ -1069,8 +1069,8 @@ void BoussinesqFlowProblem<dim>::assemble_rhs_T ()
                                                   update_values);
  
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
-  const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
   
   Vector<double>       local_rhs (dofs_per_cell);
 
@@ -1504,7 +1504,7 @@ BoussinesqFlowProblem<dim>::get_maximal_velocity () const
 {
   QGauss<dim>   quadrature_formula(degree+2); 
   const unsigned int   n_q_points
-    = quadrature_formula.n_quadrature_points;
+    = quadrature_formula.size();
 
   FEValues<dim> fe_values (fe, quadrature_formula, 
                            update_values);
index 7c6f8597a309f05bfa4b2a64c7991fbadd0817b8..cdeab1c4a24c2641a76fef1428d80b8c276925c5 100644 (file)
@@ -1,7 +1,7 @@
 /* $Id$ */
 /*    Version: $Name:  $                                          */
 /*                                                                */
-/*    Copyright (C) 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2006, 2007, 2008 by the deal.II authors */
 /*    Author: Xing Jin, Wolfgang Bangerth, Texas A&M University, 2006 */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
@@ -438,7 +438,7 @@ void TATForwardProblem<dim>::setup_system ()
                                 update_values  |  update_JxW_values);
 
     const unsigned int   dofs_per_cell = fe.dofs_per_cell;
-    const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
+    const unsigned int   n_q_points    = quadrature_formula.size();
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
index 221b8442f928a619e0fbff5abb1a00088280c388..c596e2d531e2a8dcd1cd36a25c6ac8cc7e0a17d8 100644 (file)
@@ -1,5 +1,5 @@
 /* $Id$ */
-/*    Copyright (C) 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2006, 2007, 2008 by the deal.II authors */
 /*    Author: Ivan Christov, Wolfgang Bangerth, Texas A&M University, 2006 */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
@@ -506,7 +506,7 @@ void SineGordonProblem<dim>::compute_nl_term (const Vector<double> &old_data,
                               update_quadrature_points);
   
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points    = quadrature_formula.size();
   
   Vector<double> local_nl_term (dofs_per_cell);      
   std::vector<unsigned int> local_dof_indices (dofs_per_cell); 
@@ -579,7 +579,7 @@ void SineGordonProblem<dim>::compute_nl_matrix (const Vector<double> &old_data,
                           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;
+  const unsigned int n_q_points    = quadrature_formula.size();
   
   FullMatrix<double> local_nl_matrix (dofs_per_cell, dofs_per_cell);
   std::vector<unsigned int> local_dof_indices (dofs_per_cell); 
index e5603b57654d3e3c2eedd5f2843f352ab8fc0726..80211e7884771158b4938de0bf152916b8196983 100644 (file)
@@ -4,7 +4,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     */
@@ -903,7 +903,7 @@ estimate_smoothness (Vector<float> &smoothness_indicators) const
        for (unsigned int j=0; j<fe_collection[fe].dofs_per_cell; ++j)
          {
            std::complex<double> sum = 0;
-           for (unsigned int q=0; q<quadrature.n_quadrature_points; ++q)
+           for (unsigned int q=0; q<quadrature.size(); ++q)
              {
                const Point<dim> x_q = quadrature.point(q);
                sum += std::exp(std::complex<double>(0,1) *
index e633dc9037197b17883eba811d1adacf7a6c594e..af63ba5f362c123ef995a9994fd57ef0b2c36ba9 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name:  $                                          */
 /*                                                                */
-/*    Copyright (C) 2006, 2007 by the deal.II authors and Yaqi Wang     */
+/*    Copyright (C) 2006, 2007, 2008 by the deal.II authors and Yaqi Wang     */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -929,7 +929,7 @@ EnergyGroup<dim>::assemble_system_matrix ()
                            update_JxW_values);
       
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points    = quadrature_formula.size();
       
   FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>     cell_rhs (dofs_per_cell);
@@ -1015,7 +1015,7 @@ void EnergyGroup<dim>::assemble_ingroup_rhs (const Function<dim> &extraneous_sou
   const QGauss<dim>  quadrature_formula (fe.degree + 1);
 
   const unsigned int dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points = quadrature_formula.size();
   
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values    |  update_quadrature_points  |
@@ -1194,7 +1194,7 @@ assemble_cross_group_rhs_recursive (const EnergyGroup<dim>
   if (!cell_g->has_children() && !cell_g_prime->has_children())
     {
       const QGauss<dim>  quadrature_formula (fe.degree+1);
-      const unsigned int n_q_points = quadrature_formula.n_quadrature_points;
+      const unsigned int n_q_points = quadrature_formula.size();
     
       FEValues<dim> fe_values (fe, quadrature_formula, 
                                update_values  |  update_JxW_values);
@@ -1341,7 +1341,7 @@ template <int dim>
 double EnergyGroup<dim>::get_fission_source () const
 {
   const QGauss<dim>  quadrature_formula (fe.degree + 1);
-  const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points    = quadrature_formula.size();
       
   FEValues<dim> fe_values (fe, quadrature_formula, 
                           update_values  |  update_JxW_values);
index 47c7598e38eaf39552a965d0cb77f4b272aa2319..576ffda74103709dac04eecb01e1c4744ec27a40 100644 (file)
@@ -2,7 +2,7 @@
 /* Author: Moritz Allmaras, Texas A&M University, 2007 */
 
 /*                                                                */
-/*    Copyright (C) 2007 by the deal.II authors and M. Allmaras   */
+/*    Copyright (C) 2007, 2008 by the deal.II authors and M. Allmaras   */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
 /*    without copyright and license information. Please refer     */
@@ -824,8 +824,8 @@ void UltrasoundProblem<dim>::assemble_system ()
   QGauss<dim>    quadrature_formula(2);
   QGauss<dim-1>  face_quadrature_formula(2);
 
-  const unsigned int n_q_points              = quadrature_formula.n_quadrature_points,
-                    n_face_q_points  = face_quadrature_formula.n_quadrature_points,
+  const unsigned int n_q_points              = quadrature_formula.size(),
+                    n_face_q_points  = face_quadrature_formula.size(),
                     dofs_per_cell    = fe.dofs_per_cell;
 
                                   // The FEValues objects will
index 19f6e2673fa571de4210ea1a56471a87743a2970..b08d544078dd31a6d8bfd5a140dfbddeda52a101 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2006 by the deal.II authors */
+/*    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 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     */
@@ -474,7 +474,7 @@ void LaplaceProblem::assemble_system ()
                                   // more or less by convention the standard
                                   // names for these purposes:
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
                                   // Now, we said that we wanted to assemble
                                   // the global matrix and vector
index ec31942f142cf0b568c08d81d6db4fdcbcf891a9..9e7327d64c60a4d9dd960acb446065c6ca604e4b 100644 (file)
@@ -4,7 +4,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     */
@@ -428,7 +428,7 @@ void LaplaceProblem<dim>::assemble_system ()
                                   // you and you don't have to care about the
                                   // dimension dependent parts:
   const unsigned int   dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int   n_q_points    = quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
index 9a1fd3530c2c62ed35f301d7383e57377c2b6357..fe89bb22d4d3a1d9bbbd105ff5e06e7cbe95e2ec 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 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     */
@@ -440,7 +440,7 @@ void LaplaceProblem<dim>::assemble_system ()
                           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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
index e7b88c8c87c19676c9cd01592fbd4eb244db032a..6706b9e6cb31992beeeaaa21c51debb79a589ce9 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 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     */
@@ -555,7 +555,7 @@ void LaplaceProblem<dim>::assemble_system ()
                           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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
index 0fd500b68f11601753082589e7dede6657c5f9d5..599622b797f4ced2316efea2b52cfc882198a6e3 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 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     */
@@ -811,8 +811,8 @@ void HelmholtzProblem<dim>::assemble_system ()
   QGauss<dim>   quadrature_formula(3);
   QGauss<dim-1> face_quadrature_formula(3);
 
-  const unsigned int n_q_points    = quadrature_formula.n_quadrature_points;
-  const unsigned int n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int n_q_points    = quadrature_formula.size();
+  const unsigned int n_face_q_points = face_quadrature_formula.size();
 
   const unsigned int dofs_per_cell = fe->dofs_per_cell;
 
index 8b875fccd7813acc80536049e5760d7d1d395479..ab7ebc6c04a27ef8aab6c45042ac38bcca357875 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 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     */
@@ -544,7 +544,7 @@ void ElasticProblem<dim>::assemble_system ()
                            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;
+  const unsigned int   n_q_points    = quadrature_formula.size();
 
   FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
   Vector<double>       cell_rhs (dofs_per_cell);
index 9b2c4fe8ce6e4623f39154742c589b6e1b940273..2c0cfd67ab3474a03ca657f33f22d8bf8b08112d 100644 (file)
@@ -4,7 +4,7 @@
 /*    $Id$       */
 /*    Version: $Name$                                          */
 /*                                                                */
-/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2006, 2007 by the deal.II authors */
+/*    Copyright (C) 2000, 2001, 2002, 2003, 2004, 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     */
@@ -994,8 +994,8 @@ assemble_system_interval (const typename DoFHandler<dim>::active_cell_iterator &
                                   // abbreviations to avoid
                                   // unnecessarily long lines:
   const unsigned int   dofs_per_cell   = fe.dofs_per_cell;
-  const unsigned int   n_q_points      = quadrature_formula.n_quadrature_points;
-  const unsigned int   n_face_q_points = face_quadrature_formula.n_quadrature_points;
+  const unsigned int   n_q_points      = quadrature_formula.size();
+  const unsigned int   n_face_q_points = face_quadrature_formula.size();
 
                                   // We declare cell matrix and cell
                                   // right hand side...

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.