]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new heads
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Feb 2000 17:50:57 +0000 (17:50 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Feb 2000 17:50:57 +0000 (17:50 +0000)
git-svn-id: https://svn.dealii.org/trunk@2469 0785d39b-7218-0410-832d-ea1e28bc413d

18 files changed:
deal.II/base/source/convergence_table.cc
deal.II/base/source/data_out_base.all_dimensions.cc
deal.II/base/source/data_out_base.cc
deal.II/base/source/exceptions.cc
deal.II/base/source/function.cc
deal.II/base/source/function_lib.cc
deal.II/base/source/function_time.cc
deal.II/base/source/job_identifier.cc
deal.II/base/source/log.cc
deal.II/base/source/parameter_handler.cc
deal.II/base/source/programid.cc
deal.II/base/source/quadrature.cc
deal.II/base/source/quadrature_lib.cc
deal.II/base/source/subscriptor.cc
deal.II/base/source/table_handler.cc
deal.II/base/source/tensor.cc
deal.II/base/source/tensor_function.cc
deal.II/base/source/timer.cc

index f8c46cce34d9f3f7e5068fc891de0eda116612dd..bf4d181cfdf16a986c6821ae0273b1daef48fb33 100644 (file)
@@ -1,8 +1,17 @@
-/*----------------------------   convergence_table.cc     ---------------------------*/
-/*      $Id$                 */
+//----------------------------  convergence_table.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  convergence_table.cc  ---------------------------
 
 
-#include <base/convergence_table.h>
 #include <math.h>
 
 
@@ -144,7 +153,6 @@ void ConvergenceTable::omit_column_from_convergence_rate_evaluation(const string
 }
 
 
-
 void ConvergenceTable::evaluate_all_convergence_rates(const string &reference_column_key,
                                                      const RateMode rate_mode)
 {
@@ -164,4 +172,3 @@ void ConvergenceTable::evaluate_all_convergence_rates(const RateMode rate_mode)
 }
 
 
-/*----------------------------   convergence_table.cc     ---------------------------*/
index fb1549c2f8b60a880a260e6150efab1f0c59d551..6a0a13b029ccc29b47ffe287ea84af94bc78a202 100644 (file)
@@ -1,7 +1,17 @@
-/* $Id$ */
+//----------------------------  data_out_base.all_dimensions.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  data_out_base.all_dimensions.cc  ---------------------------
 
 
-#include <base/data_out_base.h>
 #include <base/parameter_handler.h>
 
 
@@ -10,7 +20,6 @@ DataOutBase::UcdFlags::UcdFlags (const bool write_preamble) :
 {};
 
 
-
 DataOutBase::PovrayFlags::PovrayFlags (const bool smooth,
                                       const bool bicubic_patch,
                                       const bool external_data) :
@@ -20,33 +29,28 @@ DataOutBase::PovrayFlags::PovrayFlags (const bool smooth,
 {};
 
 
-
 void DataOutBase::UcdFlags::declare_parameters (ParameterHandler &prm)
 {
   prm.declare_entry ("Write preamble", "true", Patterns::Bool());
 };
 
 
-
 void DataOutBase::UcdFlags::parse_parameters (ParameterHandler &prm)
 {
   write_preamble = prm.get_bool ("Write preamble");
 };
 
 
-
 void DataOutBase::GnuplotFlags::declare_parameters (ParameterHandler &/*prm*/)
 {
 };
 
 
-
 void DataOutBase::GnuplotFlags::parse_parameters (ParameterHandler &/*prm*/)
 {
 };
 
 
-
 void DataOutBase::PovrayFlags::declare_parameters (ParameterHandler &prm)
 {
   prm.declare_entry ("Use smooth triangles", "false",
@@ -58,7 +62,6 @@ void DataOutBase::PovrayFlags::declare_parameters (ParameterHandler &prm)
 };
 
 
-
 void DataOutBase::PovrayFlags::parse_parameters (ParameterHandler &prm)
 {
   smooth        = prm.get_bool ("Use smooth triangles");
@@ -67,7 +70,6 @@ void DataOutBase::PovrayFlags::parse_parameters (ParameterHandler &prm)
 };
 
 
-
 DataOutBase::EpsFlags::EpsFlags (const unsigned int  height_vector,
                                 const unsigned int  color_vector,
                                 const SizeType      size_type,
@@ -95,7 +97,6 @@ DataOutBase::EpsFlags::EpsFlags (const unsigned int  height_vector,
 {};
 
 
-
 DataOutBase::EpsFlags::RgbValues
 DataOutBase::EpsFlags::default_color_function (const double x,
                                               const double xmin,
@@ -182,7 +183,6 @@ DataOutBase::EpsFlags::default_color_function (const double x,
 };
 
 
-
 DataOutBase::EpsFlags::RgbValues
 DataOutBase::EpsFlags::grey_scale_color_function (const double x,
                                                  const double xmin,
@@ -195,7 +195,6 @@ DataOutBase::EpsFlags::grey_scale_color_function (const double x,
 };
 
 
-
 bool DataOutBase::EpsCell2d::operator < (const EpsCell2d &e) const
 {
                                   // note the "wrong" order in
@@ -204,7 +203,6 @@ bool DataOutBase::EpsCell2d::operator < (const EpsCell2d &e) const
 };
 
 
-
 void DataOutBase::EpsFlags::declare_parameters (ParameterHandler &prm)
 {
   prm.declare_entry ("Index of vector for height", "0",
@@ -234,7 +232,6 @@ void DataOutBase::EpsFlags::declare_parameters (ParameterHandler &prm)
 };
 
 
-
 void DataOutBase::EpsFlags::parse_parameters (ParameterHandler &prm)
 {
   height_vector = prm.get_integer ("Index of vector for height");
@@ -258,13 +255,11 @@ void DataOutBase::EpsFlags::parse_parameters (ParameterHandler &prm)
 };
 
 
-
 void DataOutBase::GmvFlags::declare_parameters (ParameterHandler &/*prm*/)
 {
 };
 
 
-
 void DataOutBase::GmvFlags::parse_parameters (ParameterHandler &/*prm*/)
 {
 };
index 58922cc1daf1ee5c7748ea5345888071e94519a7..707e3c7dd638d297bcbebc34716341eeb19bdfd0 100644 (file)
-/* $Id$ */
-
-
-#include <base/data_out_base.h>
-#include <base/parameter_handler.h>
-#include <iomanip>
-#include <ctime>
-#include <cmath>
-#include <set>
-
-
-// egcs does not understand this at present.
+//----------------------------  data_out_base.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
 //
-// template <int dim>
-// DataOut::Patch<dim>::Patch () :
-//             n_subdivisions (1)
-//                              // all the rest has a constructor of its own
-// {};
-
-
-
-template <int dim>
-void DataOutBase::write_ucd (const vector<Patch<dim> > &patches,
-                            const vector<string>      &data_names,
-                            const UcdFlags            &flags,
-                            ostream                   &out) 
-{
-  AssertThrow (out, ExcIO());
-
-  Assert (patches.size() > 0, ExcNoPatches());
-  
-  const unsigned int n_data_sets = data_names.size();
-  
-                                  // first count the number of cells
-                                  // and cells for later use
-  unsigned int n_cells = 0,
-              n_nodes = 0;
-  for (vector<Patch<dim> >::const_iterator patch=patches.begin();
-       patch!=patches.end(); ++patch)
-    switch (dim)
-      {
-       case 1:
-             n_cells += patch->n_subdivisions;
-             n_nodes += patch->n_subdivisions+1;
-             break;
-       case 2:
-             n_cells += patch->n_subdivisions *
-                        patch->n_subdivisions;
-             n_nodes += (patch->n_subdivisions+1) *
-                        (patch->n_subdivisions+1);
-             break;
-       case 3:
-             n_cells += patch->n_subdivisions *
-                        patch->n_subdivisions *
-                        patch->n_subdivisions;
-             n_nodes += (patch->n_subdivisions+1) *
-                        (patch->n_subdivisions+1) *
-                        (patch->n_subdivisions+1);
-             break;
-       default:
-             Assert (false, ExcNotImplemented());
-      };
-
-                                  ///////////////////////
-                                  // preamble
-  if (flags.write_preamble)
-    {
-      time_t  time1= time (0);
-      tm     *time = localtime(&time1); 
-      out << "# This file was generated by the deal.II library." << endl
-         << "# Date =  "
-         << time->tm_year+1900 << "/"
-         << time->tm_mon+1 << "/"
-         << time->tm_mday << endl
-         << "# Time =  "
-         << time->tm_hour << ":"
-         << setw(2) << time->tm_min << ":"
-         << setw(2) << time->tm_sec << endl
-         << "#" << endl
-         << "# For a description of the UCD format see the AVS Developer's guide."
-         << endl
-         << "#" << endl;
-    };
-
-                                  // start with ucd data
-  out << n_nodes << ' '
-      << n_cells << ' '
-      << n_data_sets << ' '
-      << 0 << ' '                  // no cell data at present
-      << 0                         // no model data
-      << endl;
-
-                                  ///////////////////////////////
-                                  // first make up the list of used
-                                  // nodes along with their
-                                  // coordinates. number them
-                                  // consecutively starting with 1
-                                  //
-                                  // note that we have to print
-                                  // d=1..3 dimensions
-  if (true)
-    {
-      unsigned int present_node = 1;
-      
-      for (vector<Patch<dim> >::const_iterator patch=patches.begin();
-          patch!=patches.end(); ++patch)
-       {
-         const unsigned int n_subdivisions = patch->n_subdivisions;
-         
-                                          // if we have nonzero values for
-                                          // this coordinate
-         switch (dim)
-           {
-             case 1:
-             {
-               for (unsigned int i=0; i<n_subdivisions+1; ++i, ++present_node)
-                 out << present_node
-                     << "   "
-                     << ((patch->vertices[1](0) * i / n_subdivisions) +
-                         (patch->vertices[0](0) * (n_subdivisions-i) / n_subdivisions))
-                     << " 0 0\n";                        // fill with zeroes
-               break;
-             };
-              
-             case 2:
-             {
-               for (unsigned int i=0; i<n_subdivisions+1; ++i)
-                 for (unsigned int j=0; j<n_subdivisions+1; ++j)
-                   {
-                     const double x_frac = i * 1./n_subdivisions,
-                                  y_frac = j * 1./n_subdivisions;
-                     
-                                                      // compute coordinates for
-                                                      // this patch point
-                     out << present_node
-                         << "  "
-                         << (((patch->vertices[1] * x_frac) +
-                              (patch->vertices[0] * (1-x_frac))) * (1-y_frac) +
-                             ((patch->vertices[2] * x_frac) +
-                              (patch->vertices[3] * (1-x_frac))) * y_frac)
-                         << " 0\n";                   // fill with zeroes
-
-                     ++present_node;
-                   };
-             
-               break;
-             };
-              
-             case 3:
-             {
-               for (unsigned int i=0; i<n_subdivisions+1; ++i)
-                 for (unsigned int j=0; j<n_subdivisions+1; ++j)
-                   for (unsigned int k=0; k<n_subdivisions+1; ++k)
-                     {
-                                                        // note the broken
-                                                        // design of hexahedra
-                                                        // in deal.II, where
-                                                        // first the z-component
-                                                        // is counted up, before
-                                                        // increasing the y-
-                                                        // coordinate
-                       const double x_frac = i * 1./n_subdivisions,
-                                    y_frac = k * 1./n_subdivisions,
-                                    z_frac = j * 1./n_subdivisions;
-                       
-                                                        // compute coordinates for
-                                                        // this patch point
-                       out << present_node
-                           << "  "
-                           << ((((patch->vertices[1] * x_frac) +
-                                 (patch->vertices[0] * (1-x_frac))) * (1-y_frac) +
-                                ((patch->vertices[2] * x_frac) +
-                                 (patch->vertices[3] * (1-x_frac))) * y_frac)   * (1-z_frac) +
-                               (((patch->vertices[5] * x_frac) +
-                                 (patch->vertices[4] * (1-x_frac))) * (1-y_frac) +
-                                ((patch->vertices[6] * x_frac) +
-                                 (patch->vertices[7] * (1-x_frac))) * y_frac)   * z_frac)
-                           << endl;
-                       
-                       ++present_node;
-                     };
-             
-               break;
-             };
-              
-             default:
-                   Assert (false, ExcNotImplemented());
-           };
-       };
-
-                                      // note that we number starting with 1!
-      Assert (present_node == n_nodes+1,
-             ExcInternalError());
-    };
-
-                                  /////////////////////////////////////////
-                                  // write cell. number them consecutively,
-                                  // starting with 1
-  if (true)
-    {
-      unsigned int present_cell = 1;      
-      unsigned int first_vertex_of_patch = 0;
-      
-      for (vector<Patch<dim> >::const_iterator patch=patches.begin();
-          patch!=patches.end(); ++patch)
-       {
-         const unsigned int n_subdivisions = patch->n_subdivisions;
-         
-                                          // write out the cells making
-                                          // up this patch
-         switch (dim)
-           {
-             case 1:
-             {
-               for (unsigned int i=0; i<n_subdivisions; ++i, ++present_cell)
-                 out << present_cell
-                     << " 0  line  "        // set material id to 0
-                     << first_vertex_of_patch+i+1 << ' '
-                     << first_vertex_of_patch+i+1+1 << endl;
-               break;
-             };
-              
-             case 2:
-             {
-               for (unsigned int i=0; i<n_subdivisions; ++i)
-                 for (unsigned int j=0; j<n_subdivisions; ++j)
-                   {
-                     out << present_cell
-                         << " 0  quad  "    // set material id to 0
-                         << first_vertex_of_patch+i*(n_subdivisions+1)+j+1 << ' '
-                         << first_vertex_of_patch+(i+1)*(n_subdivisions+1)+j+1 << ' '
-                         << first_vertex_of_patch+(i+1)*(n_subdivisions+1)+j+1+1 << ' '
-                         << first_vertex_of_patch+i*(n_subdivisions+1)+j+1+1
-                         << endl;
-                     ++present_cell;
-                   };
-               break;
-             };
-              
-             case 3:
-             {
-               for (unsigned int i=0; i<n_subdivisions; ++i)
-                 for (unsigned int j=0; j<n_subdivisions; ++j)
-                   for (unsigned int k=0; k<n_subdivisions; ++k)
-                     {
-                       out << present_cell
-                           << " 0  hex  "    // set material id to 0
-                                                          // note: vertex indices start with 1!
-                           << first_vertex_of_patch+(i*(n_subdivisions+1)+j      )*(n_subdivisions+1)+k  +1 << ' '
-                           << first_vertex_of_patch+((i+1)*(n_subdivisions+1)+j  )*(n_subdivisions+1)+k  +1 << ' '
-                           << first_vertex_of_patch+((i+1)*(n_subdivisions+1)+j+1)*(n_subdivisions+1)+k  +1 << ' '
-                           << first_vertex_of_patch+(i*(n_subdivisions+1)+j+1    )*(n_subdivisions+1)+k  +1 << ' '
-                           << first_vertex_of_patch+(i*(n_subdivisions+1)+j      )*(n_subdivisions+1)+k+1+1 << ' '
-                           << first_vertex_of_patch+((i+1)*(n_subdivisions+1)+j  )*(n_subdivisions+1)+k+1+1 << ' '
-                           << first_vertex_of_patch+((i+1)*(n_subdivisions+1)+j+1)*(n_subdivisions+1)+k+1+1 << ' '
-                           << first_vertex_of_patch+(i*(n_subdivisions+1)+j+1    )*(n_subdivisions+1)+k+1+1 << ' '
-                           << endl;
-                       ++present_cell;
-                     };
-               break;
-             };
-
-             default:
-                   Assert (false, ExcNotImplemented());
-           };
-         
-         
-                                          // finally update the number
-                                          // of the first vertex of this patch
-         switch (dim)
-           {
-             case 1:
-                   first_vertex_of_patch += n_subdivisions+1;
-                   break;
-             case 2:
-                   first_vertex_of_patch += (n_subdivisions+1) *
-                                            (n_subdivisions+1);
-                   break;
-             case 3:
-                   first_vertex_of_patch += (n_subdivisions+1) *
-                                            (n_subdivisions+1) *
-                                            (n_subdivisions+1);
-                   break;
-             default:
-                   Assert (false, ExcNotImplemented());
-           };
-       };
-      out << endl;
-
-                                      // note that we number starting with 1!
-      Assert (present_cell == n_cells+1,
-             ExcInternalError());
-    };
-
-
-                                  /////////////////////////////
-                                  // now write data
-  if (n_data_sets != 0)
-    {      
-      out << n_data_sets << "    ";    // number of vectors
-      for (unsigned int i=0; i<n_data_sets; ++i)
-       out << 1 << ' ';               // number of components;
-                                      // only 1 supported presently
-      out << endl;
-
-      for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-       out << data_names[data_set]
-           << ",dimensionless"      // no units supported at present
-           << endl;
-      
-      
-                                      // loop over all patches
-      unsigned int present_node = 1;
-      for (typename vector<Patch<dim> >::const_iterator patch=patches.begin();
-          patch != patches.end(); ++patch)
-       {
-         const unsigned int n_subdivisions = patch->n_subdivisions;
-      
-         Assert (patch->data.m() == n_data_sets,
-                 ExcUnexpectedNumberOfDatasets (patch->data.m(), n_data_sets));
-         Assert (patch->data.n() == (dim==1 ?
-                                     n_subdivisions+1 :
-                                     (dim==2 ?
-                                      (n_subdivisions+1)*(n_subdivisions+1) :
-                                      (dim==3 ?
-                                       (n_subdivisions+1)*(n_subdivisions+1)*(n_subdivisions+1) :
-                                       0))),
-                 ExcInvalidDatasetSize (patch->data.n(), n_subdivisions+1));
-
-         switch (dim)
-           {
-             case 1:
-             {      
-               for (unsigned int i=0; i<n_subdivisions+1; ++i, ++present_node) 
-                 {
-                   out << present_node
-                       << "  ";
-                   for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                     out << patch->data(data_set,i) << ' ';
-
-                   out << endl;
-                 };
-           
-               break;
-             };
-          
-             case 2:
-             {
-               for (unsigned int i=0; i<n_subdivisions+1; ++i)
-                 for (unsigned int j=0; j<n_subdivisions+1; ++j)
-                   {
-                     out << present_node
-                         << "  ";
-                     for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                       out << patch->data(data_set,i*(n_subdivisions+1) + j) << ' ';
-
-                     out << endl;
-
-                     ++present_node;
-                   };
-
-               break;
-             };
-
-             case 3:
-             {
-               for (unsigned int i=0; i<n_subdivisions+1; ++i)
-                 for (unsigned int j=0; j<n_subdivisions+1; ++j)
-                   for (unsigned int k=0; k<n_subdivisions+1; ++k)
-                     {
-                       out << present_node
-                           << "  ";
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out << patch->data(data_set,
-                                            (i*(n_subdivisions+1)+j)*(n_subdivisions+1)+k)
-                             << ' ';
-                       
-                       out << endl;
-                       
-                       ++present_node;
-                     };
-
-               break;
-             };
-
-             default:
-                   Assert (false, ExcNotImplemented());
-           };
-       };  
-    };
-
-                                  // no model data
-
-                                  // assert the stream is still ok
-  AssertThrow (out, ExcIO());
-};
-
-
-
-template <int dim>
-void DataOutBase::write_gnuplot (const vector<Patch<dim> > &patches,
-                                const vector<string>      &data_names,
-                                const GnuplotFlags        &/*flags*/,
-                                ostream                   &out) 
-{
-  AssertThrow (out, ExcIO());
-  
-  Assert (patches.size() > 0, ExcNoPatches());
-
-  const unsigned int n_data_sets = data_names.size();
-  
-                                  // write preamble
-  if (true) 
-    {
-                                      // block this to have local
-                                      // variables destroyed after
-                                      // use
-      const time_t  time1= time (0);
-      const tm     *time = localtime(&time1); 
-      out << "# This file was generated by the deal.II library." << endl
-         << "# Date =  "
-         << time->tm_year+1900 << "/"
-         << time->tm_mon+1 << "/"
-         << time->tm_mday << endl
-         << "# Time =  "
-         << time->tm_hour << ":"
-         << setw(2) << time->tm_min << ":"
-         << setw(2) << time->tm_sec << endl
-         << "#" << endl
-         << "# For a description of the GNUPLOT format see the GNUPLOT manual."
-         << endl
-         << "#" << endl
-         << "# ";
-      
-      switch (dim) 
-       {
-         case 1:
-               out << "<x> ";
-               break;
-         case 2:
-               out << "<x> <y> ";
-               break;
-         case 3:
-               out << "<x> <y> <z> ";
-               break;
-               
-         default:
-               Assert (false, ExcNotImplemented());
-       };
-
-      for (unsigned int i=0; i<data_names.size(); ++i)
-       out << '<'
-           << data_names[i]
-           << "> ";
-      out << endl;      
-    };
-
-
-                                  // loop over all patches
-  for (typename vector<Patch<dim> >::const_iterator patch=patches.begin();
-       patch != patches.end(); ++patch)
-    {
-      const unsigned int n_subdivisions = patch->n_subdivisions;
-      
-      Assert (patch->data.m() == n_data_sets,
-             ExcUnexpectedNumberOfDatasets (patch->data.m(), n_data_sets));
-      Assert (patch->data.n() == (dim==1 ?
-                                 n_subdivisions+1 :
-                                 (dim==2 ?
-                                  (n_subdivisions+1)*(n_subdivisions+1) :
-                                  (dim==3 ?
-                                   (n_subdivisions+1)*(n_subdivisions+1)*(n_subdivisions+1) :
-                                   0))),
-             ExcInvalidDatasetSize (patch->data.n(), n_subdivisions+1));
-
-      switch (dim)
-       {
-         case 1:
-         {      
-           for (unsigned int i=0; i<n_subdivisions+1; ++i) 
-             {
-                                                // compute coordinates for
-                                                // this patch point
-               out << ((patch->vertices[1] * i / n_subdivisions) +
-                       (patch->vertices[0] * (n_subdivisions-i) / n_subdivisions))
-                   << ' ';
-
-               for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                 out << patch->data(data_set,i) << ' ';
-
-               out << endl;
-             };
-
-                                            // end of patch
-           out << endl
-               << endl;
-           
-           break;
-         };
-          
-         case 2:
-         {
-           for (unsigned int i=0; i<n_subdivisions+1; ++i)
-             {
-               for (unsigned int j=0; j<n_subdivisions+1; ++j)
-                 {
-                   const double x_frac = i * 1./n_subdivisions,
-                                y_frac = j * 1./n_subdivisions;
-                   
-                                                    // compute coordinates for
-                                                    // this patch point
-                   out << (((patch->vertices[1] * x_frac) +
-                            (patch->vertices[0] * (1-x_frac))) * (1-y_frac) +
-                           ((patch->vertices[2] * x_frac) +
-                            (patch->vertices[3] * (1-x_frac))) * y_frac)
-                       << ' ';
-                   
-                   for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                     out << patch->data(data_set,i*(n_subdivisions+1) + j) << ' ';
-
-                   out << endl;
-                 };
-
-                                                // end of row in patch
-               out << endl;
-             };
-
-                                            // end of patch
-           out << endl;
-
-           break;
-         };
-
-         case 3:
-         {
-                                            // for all grid points: draw
-                                            // lines into all positive
-                                            // coordinate directions if
-                                            // there is another grid point
-                                            // there
-           for (unsigned int i=0; i<n_subdivisions+1; ++i)
-             for (unsigned int j=0; j<n_subdivisions+1; ++j)
-               for (unsigned int k=0; k<n_subdivisions+1; ++k)
-                 {
-                                                    // note the broken
-                                                    // design of hexahedra
-                                                    // in deal.II, where
-                                                    // first the z-component
-                                                    // is counted up, before
-                                                    // increasing the y-
-                                                    // coordinate
-                   const double x_frac = i * 1./n_subdivisions,
-                                y_frac = k * 1./n_subdivisions,
-                                z_frac = j * 1./n_subdivisions;
-
-                                                    // compute coordinates for
-                                                    // this patch point
-                   const Point<dim> this_point
-                     = ((((patch->vertices[1] * x_frac) +
-                          (patch->vertices[0] * (1-x_frac))) * (1-y_frac) +
-                         ((patch->vertices[2] * x_frac) +
-                          (patch->vertices[3] * (1-x_frac))) * y_frac)   * (1-z_frac) +
-                        (((patch->vertices[5] * x_frac) +
-                          (patch->vertices[4] * (1-x_frac))) * (1-y_frac) +
-                         ((patch->vertices[6] * x_frac) +
-                          (patch->vertices[7] * (1-x_frac))) * y_frac)   * z_frac);
-
-                                                    // line into positive x-direction
-                                                    // if possible
-                   if (i < n_subdivisions)
-                     {
-                                                        // write point here
-                                                        // and its data
-                       out << this_point;
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             (i*(n_subdivisions+1) + j)*(n_subdivisions+1)+k);
-                       out << endl;
-                       
-                                                        // write point there
-                                                        // and its data
-                       const double x_frac_new = x_frac + 1./n_subdivisions;
-                       out << ((((patch->vertices[1] * x_frac_new) +
-                                 (patch->vertices[0] * (1-x_frac_new))) * (1-y_frac) +
-                                ((patch->vertices[2] * x_frac_new) +
-                                 (patch->vertices[3] * (1-x_frac_new))) * y_frac)   * (1-z_frac) +
-                               (((patch->vertices[5] * x_frac_new) +
-                                 (patch->vertices[4] * (1-x_frac_new))) * (1-y_frac) +
-                                ((patch->vertices[6] * x_frac_new) +
-                                 (patch->vertices[7] * (1-x_frac_new))) * y_frac)   * z_frac);
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             ((i+1)*(n_subdivisions+1) + j)*(n_subdivisions+1)+k);
-                       out << endl;
-
-                                                        // end of line
-                       out << endl
-                           << endl;
-                     };
-                   
-                                                    // line into positive y-direction
-                                                    // if possible
-                   if (j < n_subdivisions)
-                     {
-                                                        // write point here
-                                                        // and its data
-                       out << this_point;
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             (i*(n_subdivisions+1) + j)*(n_subdivisions+1)+k);
-                       out << endl;
-                       
-                                                        // write point there
-                                                        // and its data
-                       const double z_frac_new = z_frac + 1./n_subdivisions;
-                       out << ((((patch->vertices[1] * x_frac) +
-                                 (patch->vertices[0] * (1-x_frac))) * (1-y_frac) +
-                                ((patch->vertices[2] * x_frac) +
-                                 (patch->vertices[3] * (1-x_frac))) * y_frac)   * (1-z_frac_new) +
-                               (((patch->vertices[5] * x_frac) +
-                                 (patch->vertices[4] * (1-x_frac))) * (1-y_frac) +
-                                ((patch->vertices[6] * x_frac) +
-                                 (patch->vertices[7] * (1-x_frac))) * y_frac)   * z_frac_new);
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             (i*(n_subdivisions+1) + (j+1))*(n_subdivisions+1)+k);
-                       out << endl;
-
-                                                        // end of line
-                       out << endl
-                           << endl;
-                     };
-
-                                                    // line into positive z-direction
-                                                    // if possible
-                   if (k < n_subdivisions)
-                     {
-                                                        // write point here
-                                                        // and its data
-                       out << this_point;
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             (i*(n_subdivisions+1) + j)*(n_subdivisions+1)+k);
-                       out << endl;
-                       
-                                                        // write point there
-                                                        // and its data
-                       const double y_frac_new = y_frac + 1./n_subdivisions;
-                       out << ((((patch->vertices[1] * x_frac) +
-                                 (patch->vertices[0] * (1-x_frac))) * (1-y_frac_new) +
-                                ((patch->vertices[2] * x_frac) +
-                                 (patch->vertices[3] * (1-x_frac))) * y_frac_new)   * (1-z_frac) +
-                               (((patch->vertices[5] * x_frac) +
-                                 (patch->vertices[4] * (1-x_frac))) * (1-y_frac_new) +
-                                ((patch->vertices[6] * x_frac) +
-                                 (patch->vertices[7] * (1-x_frac))) * y_frac_new)   * z_frac);
-                       for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
-                         out  << ' '
-                              << patch->data(data_set,
-                                             (i*(n_subdivisions+1) + j)*(n_subdivisions+1)+k+1);
-                       out << endl;
-
-                                                        // end of line
-                       out << endl
-                           << endl;
-                     };                    
-                       
-                 };
-
-           break;
-         };
-
-         default:
-               Assert (false, ExcNotImplemented());
-       };
-    };
-
-  AssertThrow (out, ExcIO());
-};
-
-
-
-template <int dim>
-void DataOutBase::write_povray (const vector<Patch<dim> > &patches,
-                               const vector<string>      &data_names,
-                               const PovrayFlags         &flags,
-                               ostream                   &out) 
-{
-  AssertThrow (out, ExcIO());
-  
-  Assert (patches.size() > 0, ExcNoPatches());
-  Assert (dim==2, ExcNotImplemented());        // only for 2-D  
-
-  const unsigned int n_data_sets = data_names.size();
-  
-                                    // write preamble
-  if (true) 
-    {
-                                    // block this to have local
-                                    // variables destroyed after use
-      const time_t  time1= time (0);
-      const tm     *time = localtime(&time1); 
-      out << "/* This file was generated by the deal.II library." << endl
-         << "   Date =  "
-         << time->tm_year+1900 << "/"
-         << time->tm_mon+1 << "/"
-         << time->tm_mday << endl
-         << "   Time =  "
-         << time->tm_hour << ":"
-         << setw(2) << time->tm_min << ":"
-         << setw(2) << time->tm_sec << endl
-         << endl
-         << "   For a description of the POVRAY format see the POVRAY manual."
-         << endl
-         << "*/ " << endl;
-      
-                                    // include files
-      out << "#include \"colors.inc\" " << endl
-         << "#include \"textures.inc\" " << endl;
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  data_out_base.cc  ---------------------------
 
 
-                                    // use external include file for textures,
-                                    // camera and light
-      if (flags.external_data)
-       out << "#include \"data.inc\" " << endl;
+#include \"data.inc\" " << endl;
       else                          // all definitions in data file
        {  
                                     // camera
@@ -751,9 +36,9 @@ void DataOutBase::write_povray (const vector<Patch<dim> > &patches,
              << "}"                   << endl;
        }
     };
 
-  double hmin=0,hmax=0;                             // max. and min. heigth of solution 
+
+double hmin=0,hmax=0;                             // max. and min. heigth of solution 
 
   for (typename vector<Patch<dim> >::const_iterator patch=patches.begin();
        patch != patches.end(); ++patch)
@@ -820,9 +105,9 @@ void DataOutBase::write_povray (const vector<Patch<dim> > &patches,
                                    (n_subdivisions+1)*(n_subdivisions+1)*(n_subdivisions+1) :
                                    0))),
              ExcInvalidDatasetSize (patch->data.n(), n_subdivisions+1));
-      
-      
-      Point<dim> ver[16];                          // value for all points in this patch
+
+
+Point<dim> ver[16];                        // value for all points in this patch
       
       for (unsigned int i=0; i<n_subdivisions+1; ++i)
        {
@@ -985,8 +270,6 @@ void DataOutBase::write_povray (const vector<Patch<dim> > &patches,
 };
 
 
-
-
 template <int dim>
 void DataOutBase::write_eps (const vector<Patch<dim> > &patches,
                             const vector<string>      &/*data_names*/,
@@ -1079,9 +362,9 @@ void DataOutBase::write_eps (const vector<Patch<dim> > &patches,
                        
                        patch->data.m() != 0 ?
                        patch->data(flags.height_vector,i*(n_subdivisions+1) + j+1)     * flags.z_scaling : 0};
-                 
 
-                                                  // now compute the projection of
+
+// now compute the projection of
                                                   // the bilinear cell given by the
                                                   // four vertices and their heights
                                                   // and write them to a proper
@@ -1219,8 +502,8 @@ void DataOutBase::write_eps (const vector<Patch<dim> > &patches,
        
        const Point<2> offset(x_min, y_min);
 
-       
-                                        // now write preamble
+
+// now write preamble
        if (true) 
          {
                                             // block this to have local
@@ -1324,7 +607,6 @@ void DataOutBase::write_eps (const vector<Patch<dim> > &patches,
 };
 
 
-
 template <int dim>
 void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
                             const vector<string>      &data_names,
@@ -1374,7 +656,7 @@ void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
       };
 
 
-                                  ///////////////////////////////
+///////////////////////////////
                                   // first make up a list of used
                                   // vertices along with their
                                   // coordinates
@@ -1480,9 +762,9 @@ void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
   if (true)
     {
       out << "cells " << n_cells << endl;
-      
-       
-      unsigned int first_vertex_of_patch = 0;
+
+
+unsigned int first_vertex_of_patch = 0;
       
       for (vector<Patch<dim> >::const_iterator patch=patches.begin();
           patch!=patches.end(); ++patch)
@@ -1539,9 +821,9 @@ void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
              default:
                    Assert (false, ExcNotImplemented());
            };
-         
-         
-                                          // finally update the number
+
+
+// finally update the number
                                           // of the first vertex of this patch
          switch (dim)
            {
@@ -1661,9 +943,9 @@ void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
              << endl;
        };
     };
-  
-  
-                                  // end of variable section
+
+
+// end of variable section
   out << "endvars" << endl;
   
                                   // end of output
@@ -1675,9 +957,6 @@ void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
 };
 
 
-
-
-
 /* --------------------------- class DataOutInterface ---------------------- */
 
 
@@ -1689,7 +968,6 @@ void DataOutInterface<dim>::write_ucd (ostream &out) const
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::write_gnuplot (ostream &out) const 
 {
@@ -1698,7 +976,6 @@ void DataOutInterface<dim>::write_gnuplot (ostream &out) const
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::write_povray (ostream &out) const 
 {
@@ -1707,7 +984,6 @@ void DataOutInterface<dim>::write_povray (ostream &out) const
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::write_eps (ostream &out) const 
 {
@@ -1716,7 +992,6 @@ void DataOutInterface<dim>::write_eps (ostream &out) const
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::write_gmv (ostream &out) const 
 {
@@ -1725,7 +1000,6 @@ void DataOutInterface<dim>::write_gmv (ostream &out) const
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::write (ostream &out,
                                   OutputFormat output_format) const
@@ -1761,7 +1035,6 @@ void DataOutInterface<dim>::write (ostream &out,
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_default_format(OutputFormat fmt)
 {
@@ -1770,7 +1043,6 @@ void DataOutInterface<dim>::set_default_format(OutputFormat fmt)
 }
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_flags (const UcdFlags &flags) 
 {
@@ -1778,7 +1050,6 @@ void DataOutInterface<dim>::set_flags (const UcdFlags &flags)
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_flags (const GnuplotFlags &flags) 
 {
@@ -1786,7 +1057,6 @@ void DataOutInterface<dim>::set_flags (const GnuplotFlags &flags)
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_flags (const PovrayFlags &flags) 
 {
@@ -1794,7 +1064,6 @@ void DataOutInterface<dim>::set_flags (const PovrayFlags &flags)
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_flags (const EpsFlags &flags) 
 {
@@ -1802,7 +1071,6 @@ void DataOutInterface<dim>::set_flags (const EpsFlags &flags)
 };
 
 
-
 template <int dim>
 void DataOutInterface<dim>::set_flags (const GmvFlags &flags) 
 {
@@ -1810,7 +1078,6 @@ void DataOutInterface<dim>::set_flags (const GmvFlags &flags)
 };
 
 
-
 template <int dim>
 string DataOutInterface<dim>::default_suffix (OutputFormat output_format) 
 {
@@ -1839,7 +1106,6 @@ string DataOutInterface<dim>::default_suffix (OutputFormat output_format)
            return "";
     };
 };
-  
 
 
 template <int dim>
@@ -1868,7 +1134,6 @@ DataOutInterface<dim>::parse_output_format (const string &format_name)
 };
 
 
-
 template <int dim>
 string DataOutInterface<dim>::get_output_format_names ()
 {
@@ -1876,7 +1141,6 @@ string DataOutInterface<dim>::get_output_format_names ()
 }
 
 
-
 template <int dim>
 void DataOutInterface<dim>::declare_parameters (ParameterHandler &prm) 
 {
@@ -1905,7 +1169,6 @@ void DataOutInterface<dim>::declare_parameters (ParameterHandler &prm)
 }
 
 
-
 template <int dim>
 void DataOutInterface<dim>::parse_parameters (ParameterHandler &prm) 
 {
@@ -1934,7 +1197,6 @@ void DataOutInterface<dim>::parse_parameters (ParameterHandler &prm)
 }
 
 
-  
 // explicit instantiations. functions in DataOutBase are instantiated by
 // the respective functions in DataOut_Interface
 template class DataOutInterface<data_out_dimension>;
index 4d3ac406b36fb10b024703564805b189087dc9ab..e5109b1a3903221a400907ae8b9cfd332bbe4f05 100644 (file)
@@ -1,25 +1,31 @@
-/*      $Id$                 */
+//----------------------------  exceptions.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  exceptions.cc  ---------------------------
 
 
-#include <base/exceptions.h>
-#include <string>
 #include <strstream>
 
 
-
 ExceptionBase::ExceptionBase () :
                file(""), line(0), function(""), cond(""), exc("")
 {};
 
 
-
 ExceptionBase::ExceptionBase (const char* f, const int l, const char *func,
                              const char* c, const char *e) :
                file(f), line(l), function(func), cond(c), exc(e)
 {};
 
 
-
 void ExceptionBase::SetFields (const char* f,
                               const int l,
                               const char *func,
@@ -33,7 +39,6 @@ void ExceptionBase::SetFields (const char* f,
 };
 
 
-
 void ExceptionBase::PrintExcData (ostream &out) const {
   out << "An error occurred in line <" << line
       << "> of file <" << file
@@ -47,14 +52,11 @@ void ExceptionBase::PrintExcData (ostream &out) const {
 };
 
 
-
-
 void ExceptionBase::PrintInfo (ostream &out) const {
   out << "(none)" << endl;
 };
 
 
-
 const char * ExceptionBase::what () const {
                                   // have a place where to store the
                                   // description of the exception as a char *
index c689a7248c95210d72163b24526b1409dfaf75a5..794d994b6ac6eaa5a65c3ddac13e64c3b251ea09 100644 (file)
@@ -1,9 +1,17 @@
-/*      $Id$                 */
+//----------------------------  function.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  function.cc  ---------------------------
 
 
-#include <base/function.h>
-#include <base/point.h>
-#include <lac/vector.h>
 #include <vector>
 
 
@@ -15,13 +23,11 @@ Function<dim>::Function (const unsigned int n_components,
 {};
 
 
-
 template <int dim>
 Function<dim>::~Function ()
 {};
 
 
-
 template <int dim>
 double Function<dim>::value (const Point<dim> &,
                             const unsigned int) const
@@ -31,7 +37,6 @@ double Function<dim>::value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void Function<dim>::vector_value (const Point<dim> &,
                                  Vector<double>   &) const
@@ -40,7 +45,6 @@ void Function<dim>::vector_value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void Function<dim>::value_list (const vector<Point<dim> > &points,
                                vector<double>            &values,
@@ -57,7 +61,6 @@ void Function<dim>::value_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 void Function<dim>::vector_value_list (const vector<Point<dim> > &points,
                                       vector<Vector<double> >   &values) const
@@ -73,8 +76,6 @@ void Function<dim>::vector_value_list (const vector<Point<dim> > &points,
 };
 
 
-
-
 template <int dim>
 Tensor<1,dim> Function<dim>::gradient (const Point<dim> &,
                                       const unsigned int) const
@@ -84,7 +85,6 @@ Tensor<1,dim> Function<dim>::gradient (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void Function<dim>::vector_gradient (const Point<dim>       &,
                                     vector<Tensor<1,dim> > &) const
@@ -93,7 +93,6 @@ void Function<dim>::vector_gradient (const Point<dim>       &,
 };
 
 
-
 template <int dim>
 void Function<dim>::gradient_list (const vector<Point<dim> > &points,
                                   vector<Tensor<1,dim> >    &gradients,
@@ -107,7 +106,6 @@ void Function<dim>::gradient_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 void Function<dim>::vector_gradient_list (const vector<Point<dim> >       &points,
                                          vector<vector<Tensor<1,dim> > > &gradients) const
@@ -125,21 +123,16 @@ void Function<dim>::vector_gradient_list (const vector<Point<dim> >       &point
 };
 
 
-
-
-
 template <int dim>
 ZeroFunction<dim>::ZeroFunction (const unsigned int n_components) :
                Function<dim> (n_components)
 {};
 
 
-
 template <int dim>
 ZeroFunction<dim>::~ZeroFunction () {};
 
 
-
 template <int dim>
 double ZeroFunction<dim>::value (const Point<dim> &,
                                       const unsigned int) const
@@ -148,7 +141,6 @@ double ZeroFunction<dim>::value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::vector_value (const Point<dim> &,
                                      Vector<double>   &return_value) const
@@ -160,7 +152,6 @@ void ZeroFunction<dim>::vector_value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::value_list (const vector<Point<dim> > &points,
                                    vector<double>            &values,
@@ -172,7 +163,6 @@ void ZeroFunction<dim>::value_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::vector_value_list (const vector<Point<dim> > &points,
                                           vector<Vector<double> >   &values) const
@@ -189,7 +179,6 @@ void ZeroFunction<dim>::vector_value_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 Tensor<1,dim> ZeroFunction<dim>::gradient (const Point<dim> &,
                                           const unsigned int) const
@@ -198,7 +187,6 @@ Tensor<1,dim> ZeroFunction<dim>::gradient (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::vector_gradient (const Point<dim>       &,
                                         vector<Tensor<1,dim> > &gradients) const
@@ -211,7 +199,6 @@ void ZeroFunction<dim>::vector_gradient (const Point<dim>       &,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::gradient_list (const vector<Point<dim> > &points,
                                       vector<Tensor<1,dim> >    &gradients,
@@ -225,7 +212,6 @@ void ZeroFunction<dim>::gradient_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 void ZeroFunction<dim>::vector_gradient_list (const vector<Point<dim> >       &points,
                                              vector<vector<Tensor<1,dim> > > &gradients) const
@@ -242,9 +228,6 @@ void ZeroFunction<dim>::vector_gradient_list (const vector<Point<dim> >       &p
 };
 
 
-
-
-
 template <int dim>
 ConstantFunction<dim>::ConstantFunction (const double value,
                                         const unsigned int n_components) :
@@ -256,7 +239,6 @@ template <int dim>
 ConstantFunction<dim>::~ConstantFunction () {};
 
 
-
 template <int dim>
 double ConstantFunction<dim>::value (const Point<dim> &,
                                           const unsigned int) const
@@ -265,7 +247,6 @@ double ConstantFunction<dim>::value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void ConstantFunction<dim>::vector_value (const Point<dim> &,
                                          Vector<double>   &return_value) const
@@ -277,7 +258,6 @@ void ConstantFunction<dim>::vector_value (const Point<dim> &,
 };
 
 
-
 template <int dim>
 void ConstantFunction<dim>::value_list (const vector<Point<dim> > &points,
                                        vector<double>            &values,
@@ -289,7 +269,6 @@ void ConstantFunction<dim>::value_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int dim>
 void ConstantFunction<dim>::vector_value_list (const vector<Point<dim> > &points,
                                               vector<Vector<double> >   &values) const
@@ -315,7 +294,6 @@ double Function<dim>::laplacian (const Point<dim> &,
 }
 
 
-
 template <int dim>
 void Function<dim>::vector_laplacian (const Point<dim> &,
                                  Vector<double>   &) const
@@ -324,7 +302,6 @@ void Function<dim>::vector_laplacian (const Point<dim> &,
 }
 
 
-
 template <int dim>
 void Function<dim>::laplacian_list (const vector<Point<dim> > &points,
                                vector<double>            &laplacians,
@@ -341,7 +318,6 @@ void Function<dim>::laplacian_list (const vector<Point<dim> > &points,
 }
 
 
-
 template <int dim>
 void Function<dim>::vector_laplacian_list (const vector<Point<dim> > &points,
                                       vector<Vector<double> >   &laplacians) const
index e5c57b153ed8eace7955e935557f9feead28de7a..9a5a142db8f35ac92cf5c96e15dfe7fe6fb20322 100644 (file)
@@ -1,8 +1,16 @@
-// $Id$
-// (c) Guido Kanschat, 1999
+//----------------------------  function_lib.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  function_lib.cc  ---------------------------
 
-#include <base/point.h>
-#include <base/function_lib.h>
 
 #include <cmath>
 
index 1701c855880827ba1b16b3281260e90c72051acd..8f307dc3d7210134055cf8dfba8b5b1543876e7c 100644 (file)
@@ -1,4 +1,16 @@
-// $Id$
+//----------------------------  function_time.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  function_time.cc  ---------------------------
+
 
 #include <base/function_time.h>
 
@@ -24,4 +36,3 @@ FunctionTime::advance_time (const double delta_t)
 };
 
 
-
index f475d14ea9dad63087e7ea5973e71b915d22058d..4fe1a813695caac312935d7430a3557523a7a86d 100644 (file)
@@ -1,6 +1,17 @@
-// $Id$
+//----------------------------  job_identifier.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  job_identifier.cc  ---------------------------
+
 
-#include <base/job_identifier.h>
 #include <ctime>
 
 
index 2ce43286823b290cd0fa83be933399fe4c16cb3c..dfc27ff29ac30b04e20d3f6672fa7b5232b8c7b7 100644 (file)
@@ -1,15 +1,22 @@
-// $Id$
+//----------------------------  log.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  log.cc  ---------------------------
 
-#include <base/logstream.h>
-#include <base/job_identifier.h>
 
-#include <sys/resource.h>
 #include <iomanip>
 
 LogStream deallog;
 
 
-
 LogStream::LogStream()
                : std_out(&cerr), file(0), was_endl(true),
                  std_depth(10000), file_depth(10000),
@@ -20,8 +27,6 @@ LogStream::LogStream()
 }
 
 
-
-
 void
 LogStream::attach(ostream& o)
 {
@@ -31,14 +36,12 @@ LogStream::attach(ostream& o)
 }
 
 
-
 void LogStream::detach ()
 {
   file = 0;
 };
 
 
-
 ostream&
 LogStream::get_console()
 {
@@ -46,7 +49,6 @@ LogStream::get_console()
 }
 
 
-
 ostream&
 LogStream::get_file_stream()
 {
@@ -55,7 +57,6 @@ LogStream::get_file_stream()
 }
 
 
-
 void
 LogStream::push (const string& text)
 {
@@ -66,14 +67,12 @@ LogStream::push (const string& text)
 };
 
 
-
 void LogStream::pop ()
 {
   prefixes.pop();
 };
 
 
-
 void
 LogStream::depth_console(unsigned n)
 {
@@ -81,7 +80,6 @@ LogStream::depth_console(unsigned n)
 };
 
 
-
 void
 LogStream::depth_file(unsigned n)
 {
@@ -89,7 +87,6 @@ LogStream::depth_file(unsigned n)
 };
 
 
-
 void
 LogStream::log_execution_time(bool flag)
 {
@@ -97,7 +94,6 @@ LogStream::log_execution_time(bool flag)
 }
 
 
-
 void
 LogStream::print_line_head()
 {
@@ -133,7 +129,6 @@ LogStream::print_line_head()
 }
 
 
-
 LogStream&
 LogStream::operator << (void (f)(LogStream &))
 {
@@ -142,4 +137,3 @@ LogStream::operator << (void (f)(LogStream &))
 }
 
 
-
index e695759f684d69cc7685f23e2676b25deed727fe..c602aab557a47b8e69133728dfd3ae6b38ef0a86 100644 (file)
@@ -1,13 +1,17 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  parameter_handler.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  parameter_handler.cc  ---------------------------
 
 
-#include <base/parameter_handler.h>
-#include <fstream>
-#include <iomanip>
-#include <strstream>
-#include <cstdlib>
-#include <algorithm>
 #include <list>
 
 
@@ -49,7 +53,6 @@ Patterns::Double::clone () const {
 };
 
 
-
 Patterns::Selection::Selection (const string &seq) {
   sequence = seq;
 
@@ -91,7 +94,6 @@ Patterns::Selection::clone () const {
 };
 
 
-
 Patterns::MultipleSelection::MultipleSelection (const string &seq) {
   Assert (seq.find (",") == string::npos, ExcCommasNotAllowed(seq.find(",")));
   
@@ -129,9 +131,9 @@ bool Patterns::MultipleSelection::match (const string &test_string_list) const {
 
       split_list.push_back (name);
     };
-  
 
-                                  // check the different possibilities
+
+// check the different possibilities
   for (list<string>::const_iterator test_string = split_list.begin();
        test_string != split_list.end(); ++test_string) 
     {
@@ -176,7 +178,6 @@ Patterns::MultipleSelection::clone () const {
 };
 
 
-
 Patterns::Bool::Bool () :
                Selection ("true|false")
 {};
@@ -188,12 +189,10 @@ Patterns::Bool::clone () const {
 };
 
 
-
 Patterns::Anything::Anything ()
 {};
 
 
-
 bool Patterns::Anything::match (const string &) const {
   return true;
 };
@@ -210,10 +209,6 @@ Patterns::Anything::clone () const {
 };
 
 
-
-
-
-
 ParameterHandler::ParameterHandler () :
                status(true) {};
 
@@ -221,7 +216,6 @@ ParameterHandler::ParameterHandler () :
 ParameterHandler::~ParameterHandler () {};
 
 
-
 bool ParameterHandler::read_input (istream &input) {
   AssertThrow (input, ExcIO());
 
@@ -262,7 +256,6 @@ bool ParameterHandler::read_input (const string &filename)
 }
 
 
-
 bool ParameterHandler::read_input_from_string (const char *s) {
                                   // if empty string then exit
                                   // with success
@@ -294,8 +287,6 @@ bool ParameterHandler::read_input_from_string (const char *s) {
 };
 
 
-
-
 void ParameterHandler::clear () {
   status = true;
 
@@ -319,7 +310,6 @@ void ParameterHandler::clear () {
 };
 
 
-
 bool ParameterHandler::declare_entry (const string &entry,
                                      const string &default_value,
                                      const Patterns::PatternBase &pattern) {
@@ -346,8 +336,6 @@ bool ParameterHandler::declare_entry (const string &entry,
 
   return true;
 };
-  
-  
 
 
 void ParameterHandler::enter_subsection (const string &subsection) {
@@ -369,7 +357,6 @@ void ParameterHandler::enter_subsection (const string &subsection) {
   subsection_path.push_back (subsection);
 };
 
-    
 
 bool ParameterHandler::leave_subsection () {
                                   // assert there is a subsection that
@@ -388,7 +375,6 @@ bool ParameterHandler::leave_subsection () {
 };
 
 
-
 const string & ParameterHandler::get (const string &entry_string) const {
   const Section* pd = get_present_defaults_subsection ();
   const Section* pc = get_present_changed_subsection ();
@@ -405,7 +391,7 @@ const string & ParameterHandler::get (const string &entry_string) const {
     };
 
 
-                                  // entry exists; now find out whether
+// entry exists; now find out whether
                                   // it was changed:
   Section::EntryType::const_iterator ptr;
   ptr = pc->entries.find (entry_string);
@@ -418,7 +404,6 @@ const string & ParameterHandler::get (const string &entry_string) const {
 };
 
 
-
 long int ParameterHandler::get_integer (const string &entry_string) const {
   string s = get (entry_string);
   char *endptr;
@@ -431,7 +416,6 @@ long int ParameterHandler::get_integer (const string &entry_string) const {
 };
 
 
-
 double ParameterHandler::get_double (const string &entry_string) const {
   string s = get (entry_string);
   char *endptr;
@@ -444,7 +428,6 @@ double ParameterHandler::get_double (const string &entry_string) const {
 };
 
 
-
 bool ParameterHandler::get_bool (const string &entry_string) const {
   string s = get(entry_string);
 
@@ -456,7 +439,6 @@ bool ParameterHandler::get_bool (const string &entry_string) const {
 };
 
 
-
 ostream & ParameterHandler::print_parameters (ostream &out, OutputStyle style) {
                                   // assert that only known formats are
                                   // given as "style"
@@ -498,7 +480,6 @@ ostream & ParameterHandler::print_parameters (ostream &out, OutputStyle style) {
 };
 
 
-
 void ParameterHandler::print_parameters_section (ostream           &out,
                                                 const OutputStyle  style,
                                                 const unsigned int indent_level) {
@@ -571,9 +552,9 @@ void ParameterHandler::print_parameters_section (ostream           &out,
                  Assert (false, ExcNotImplemented());
          };
     };
-  
 
-                                  // now transverse subsections tree
+
+// now transverse subsections tree
   map<string, Section*>::const_iterator ptrss;
   for (ptrss = pd->subsections.begin(); ptrss != pd->subsections.end(); ++ptrss)
     {
@@ -624,8 +605,6 @@ void ParameterHandler::print_parameters_section (ostream           &out,
 };
 
 
-  
-
 bool ParameterHandler::scan_line (string line, const unsigned int lineno) {
                                   // if there is a comment, delete it
   if (line.find('#') != string::npos)
@@ -756,7 +735,6 @@ bool ParameterHandler::scan_line (string line, const unsigned int lineno) {
 };
 
 
-
 ParameterHandler::Section* ParameterHandler::get_present_defaults_subsection () {
   Section* sec = &defaults;
   vector<string>::const_iterator SecName = subsection_path.begin();
@@ -771,7 +749,6 @@ ParameterHandler::Section* ParameterHandler::get_present_defaults_subsection ()
 };
 
 
-
 const ParameterHandler::Section* ParameterHandler::get_present_defaults_subsection () const {
   Section* sec = const_cast<Section*>(&defaults); // not nice, but needs to be and
                                   // after all: we do not change #sec#
@@ -787,7 +764,6 @@ const ParameterHandler::Section* ParameterHandler::get_present_defaults_subsecti
 };
 
 
-
 ParameterHandler::Section* ParameterHandler::get_present_changed_subsection () {
   Section* sec = &changed_entries;
   vector<string>::iterator SecName = subsection_path.begin();
@@ -802,7 +778,6 @@ ParameterHandler::Section* ParameterHandler::get_present_changed_subsection () {
 };
 
 
-
 const ParameterHandler::Section* ParameterHandler::get_present_changed_subsection () const {
   Section* sec = const_cast<Section*>(&changed_entries); // same as in get_present_default_s...
   vector<string>::const_iterator SecName = subsection_path.begin();
@@ -817,7 +792,6 @@ const ParameterHandler::Section* ParameterHandler::get_present_changed_subsectio
 };
 
 
-
 ParameterHandler::Section::~Section () {
   entries.clear ();
 
@@ -827,13 +801,10 @@ ParameterHandler::Section::~Section () {
     delete p->second;
 
 
-  subsections.clear ();
+subsections.clear ();
 };
 
 
-
-
-
 MultipleParameterLoop::MultipleParameterLoop() :
                n_branches(0) {};
 
@@ -851,7 +822,6 @@ bool MultipleParameterLoop::read_input (istream &input) {
 };
 
 
-
 bool MultipleParameterLoop::read_input (const string &filename)
 {
   return ParameterHandler::read_input (filename);
@@ -862,7 +832,6 @@ bool MultipleParameterLoop::read_input (const string &filename)
 };
 
 
-
 bool MultipleParameterLoop::read_input_from_string (const char *s) {
   bool x = ParameterHandler::read_input (s);
   init_branches ();
@@ -870,9 +839,6 @@ bool MultipleParameterLoop::read_input_from_string (const char *s) {
 };
 
 
-
-
-
 void MultipleParameterLoop::loop (MultipleParameterLoop::UserClass &uc) {
   for (int run_no=0; run_no<n_branches; ++run_no) 
     {
@@ -929,9 +895,8 @@ void MultipleParameterLoop::init_branches () {
             << "    does not have the right number of entries for the " << endl
             << "        " << n_branches << " variant runs that will be performed." << endl;
 
-  
-  
-                                  // do a first run on filling the values to
+
+// do a first run on filling the values to
                                   // check for the conformance with the regexp
                                   // (afterwards, this will be lost in the whole
                                   // other output)
@@ -940,7 +905,6 @@ void MultipleParameterLoop::init_branches () {
 };
 
 
-
 void MultipleParameterLoop::init_branches_section (const ParameterHandler::Section &sec) {
                                   // check all entries in the present subsection
                                   // whether it is a multiple entry
@@ -950,9 +914,9 @@ void MultipleParameterLoop::init_branches_section (const ParameterHandler::Secti
       multiple_choices.push_back (Entry(subsection_path,
                                        e->first,
                                        e->second.first));
-               
 
-                                  // transverse subsections
+
+// transverse subsections
   map<string, Section*>::const_iterator s;
   for (s = sec.subsections.begin(); s != sec.subsections.end(); ++s) 
     {
@@ -1031,7 +995,6 @@ void MultipleParameterLoop::fill_entry_values (const unsigned int run_no) {
   
 };
 
-  
 
 MultipleParameterLoop::Entry::Entry (const vector<string> &ssp,
                                     const string& Name,
@@ -1039,7 +1002,6 @@ MultipleParameterLoop::Entry::Entry (const vector<string> &ssp,
     subsection_path (ssp), entry_name(Name), entry_value(Value) {};
 
 
-
 void MultipleParameterLoop::Entry::split_different_values () {
                                   // split string into three parts:
                                   // part before the opening "{",
index b5e64f609223d089479751d9640a37084ed59aa8..788b65764e17be12f437a7fff0d1d0773ae495cc 100644 (file)
@@ -1,4 +1,16 @@
-// $Id$
+//----------------------------  programid.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  programid.cc  ---------------------------
+
 
 #include <base/job_identifier.h>
 
index 0c7b0671cb9feed5a1ba912fa1057fd58f48d88e..65afff7526bf6fcfff35fc732a07142bc840df33 100644 (file)
@@ -1,18 +1,25 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  quadrature.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  quadrature.cc  ---------------------------
 
 
-#include <base/quadrature.h>
 #include <cmath>
 
 
-
 template <>
 Quadrature<0>::Quadrature (const unsigned int)
 {};
 
 
-
 template <int dim>
 Quadrature<dim>::Quadrature (const unsigned int n_q) :
                n_quadrature_points(n_q),
@@ -39,7 +46,6 @@ Quadrature<0>::Quadrature (const Quadrature<-1> &,
 };
 
 
-
 template <>
 Quadrature<1>::Quadrature (const Quadrature<0> &,
                           const Quadrature<1> &) {
@@ -47,7 +53,6 @@ Quadrature<1>::Quadrature (const Quadrature<0> &,
 };
 
 
-
 template <int dim>
 Quadrature<dim>::Quadrature (const Quadrature<dim-1> &q1,
                             const Quadrature<1>     &q2) :
@@ -86,12 +91,10 @@ Quadrature<dim>::Quadrature (const Quadrature<dim-1> &q1,
 };
 
 
-
 template <int dim>
 Quadrature<dim>::~Quadrature () {};
 
 
-
 template <>
 const Point<0> & Quadrature<0>::quad_point (const unsigned int) const {
   Assert (false, ExcInternalError());
@@ -100,7 +103,6 @@ const Point<0> & Quadrature<0>::quad_point (const unsigned int) const {
 };
 
 
-
 template <int dim>
 const Point<dim> & Quadrature<dim>::quad_point (const unsigned int i) const {
   Assert (i<n_quadrature_points, ExcIndexRange(i, 0, n_quadrature_points));
@@ -108,7 +110,6 @@ const Point<dim> & Quadrature<dim>::quad_point (const unsigned int i) const {
 };
 
 
-
 template <>
 const vector<Point<0> > & Quadrature<0>::get_quad_points () const {
   Assert (false, ExcInternalError());
@@ -116,14 +117,12 @@ const vector<Point<0> > & Quadrature<0>::get_quad_points () const {
 };
 
 
-
 template <int dim>
 const vector<Point<dim> > & Quadrature<dim>::get_quad_points () const {
   return quadrature_points;
 };
 
 
-
 template <>
 double Quadrature<0>::weight (const unsigned int) const {
   Assert (false, ExcInternalError());
@@ -131,7 +130,6 @@ double Quadrature<0>::weight (const unsigned int) const {
 };
 
 
-
 template <int dim>
 double Quadrature<dim>::weight (const unsigned int i) const {
   Assert (i<n_quadrature_points, ExcIndexRange(i, 0, n_quadrature_points));
@@ -139,14 +137,12 @@ double Quadrature<dim>::weight (const unsigned int i) const {
 };
 
 
-
 template <int dim>
 const vector<double> & Quadrature<dim>::get_weights () const {
   return weights;
 };
 
 
-
 template <>
 const vector<double> & Quadrature<0>::get_weights () const {
   Assert (false, ExcInternalError());
@@ -154,7 +150,6 @@ const vector<double> & Quadrature<0>::get_weights () const {
 };
 
 
-
 template <>
 void QProjector<2>::project_to_face (const Quadrature<1> &quadrature,
                                     const unsigned int   face_no,
@@ -183,7 +178,6 @@ void QProjector<2>::project_to_face (const Quadrature<1> &quadrature,
 };
 
 
-
 template <>
 void QProjector<3>::project_to_face (const Quadrature<2> &quadrature,
                                     const unsigned int   face_no,
@@ -231,7 +225,6 @@ void QProjector<3>::project_to_face (const Quadrature<2> &quadrature,
 };
 
 
-
 template <>
 void QProjector<2>::project_to_subface (const Quadrature<1> &quadrature,
                                        const unsigned int   face_no,
@@ -304,7 +297,6 @@ void QProjector<2>::project_to_subface (const Quadrature<1> &quadrature,
 };
 
 
-
 template <>
 void QProjector<3>::project_to_subface (const Quadrature<2> &quadrature,
                                        const unsigned int   face_no,
@@ -315,7 +307,7 @@ void QProjector<3>::project_to_subface (const Quadrature<2> &quadrature,
   Assert (subface_no<(1<<(dim-1)), ExcIndexRange (face_no, 0, 1<<(dim-1)));
 
 
-                                  // for all faces and subfaces: first project
+// for all faces and subfaces: first project
                                   // onto the first subface of each face, then
                                   // move it to the right place
   for (unsigned int p=0; p<quadrature.n_quadrature_points; ++p)
@@ -460,8 +452,6 @@ void QProjector<3>::project_to_subface (const Quadrature<2> &quadrature,
 };
 
 
-
-
 template <>
 bool
 QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature)
@@ -480,7 +470,6 @@ QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature)
 };
 
 
-
 template <>
 QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
                         const unsigned int   n_copies) :
@@ -533,9 +522,9 @@ QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
                                       // has only one quadrature point
                                       // per end point
       Assert (n_end_points == 2, ExcInvalidQuadratureFormula());
-      
-      
-      for (unsigned int copy=0; copy<n_copies; ++copy)
+
+
+for (unsigned int copy=0; copy<n_copies; ++copy)
        for (unsigned int q_point=0; q_point<base_quadrature.n_quadrature_points; ++q_point)
          {
                                             // skip the left point of this copy
@@ -572,8 +561,6 @@ QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
 };
 
 
-
-
 // construct higher dimensional quadrature formula by tensor product of lower
 // dimensional iterated quadrature formulae
 template <int dim>
@@ -584,8 +571,6 @@ QIterated<dim>::QIterated (const Quadrature<1> &base_quadrature,
 {};
 
 
-
-
 // explicit instantiations; note: we need them all for all dimensions
 template class Quadrature<1>;
 template class Quadrature<2>;
index a88aae710c29befef696c89689627123f7b0666b..30117523b17aa556b050435f84a289cf0060a85d 100644 (file)
@@ -1,8 +1,17 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  quadrature_lib.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  quadrature_lib.cc  ---------------------------
 
 
-#include <base/quadrature_lib.h>
 #include <cmath>
 
 
@@ -33,7 +42,6 @@ QGauss2<1>::QGauss2 () :
 };
 
 
-
 template <>
 QGauss3<1>::QGauss3 () :
                Quadrature<1> (3)
@@ -96,7 +104,6 @@ QGauss4<1>::QGauss4 () :
 };
 
 
-
 template <>
 QGauss5<1>::QGauss5 () :
                Quadrature<1> (5)
@@ -134,7 +141,6 @@ QGauss5<1>::QGauss5 () :
 };
 
 
-
 template <>
 QGauss6<1>::QGauss6 () :
                Quadrature<1> (6)
@@ -176,7 +182,6 @@ QGauss6<1>::QGauss6 () :
 };
 
 
-
 template <>
 QGauss7<1>::QGauss7 () :
                Quadrature<1> (7)
@@ -222,7 +227,6 @@ QGauss7<1>::QGauss7 () :
 };
 
 
-
 template <>
 QGauss8<1>::QGauss8 () :
                Quadrature<1> (8)
@@ -272,7 +276,6 @@ QGauss8<1>::QGauss8 () :
 };
 
 
-
 template <>
 QMidpoint<1>::QMidpoint () :
                Quadrature<1>(1)
@@ -282,7 +285,6 @@ QMidpoint<1>::QMidpoint () :
 };
 
 
-
 template <>
 QSimpson<1>::QSimpson () :
                Quadrature<1> (3)
@@ -298,7 +300,6 @@ QSimpson<1>::QSimpson () :
 };
 
 
-
 template <>
 QTrapez<1>::QTrapez () :
                Quadrature<1> (2)
@@ -357,8 +358,6 @@ QTrapez<dim>::QTrapez () :
                Quadrature<dim> (QTrapez<dim-1>(), QTrapez<1>()){};
 
 
-
-
 // explicite specialization
 // note that 1d formulae are specialized by implementation above
 template class QGauss2<2>;
index f002171125e2a859815a5c106092b479a83bbe84..72e6ab803a394d75cc54b67e1b1244a8497bb6c3 100644 (file)
@@ -1,7 +1,18 @@
-/*      $Id$                 */
+//----------------------------  subscriptor.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  subscriptor.cc  ---------------------------
 
-#include <base/subscriptor.h>
 
+#include <base/subscriptor.h>
 
 
 Subscriptor::Subscriptor () :
@@ -9,31 +20,26 @@ Subscriptor::Subscriptor () :
 {};
 
 
-
 Subscriptor::Subscriptor (const Subscriptor &) :
                counter (0)
 {};
 
 
-
 Subscriptor::~Subscriptor () {
   Assert (counter == 0, ExcInUse(counter));
 };
 
 
-
 Subscriptor & Subscriptor::operator = (const Subscriptor &) {
   return *this;
 };
 
 
-
 void Subscriptor::subscribe () const {
   ++counter;
 };
 
 
-
 void Subscriptor::unsubscribe () const {
   Assert (counter>0, ExcNotUsed());
   --counter;
index fbf8b694f84be636302382b5b27bb7d7e2be797b..32f368827790576ee8caf2d6b3d74563e1ebe595 100644 (file)
@@ -1,16 +1,20 @@
-/*----------------------------   table_handler.cc     ---------------------------*/
-/*      $Id$                 */
+//----------------------------  table_handler.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  table_handler.cc  ---------------------------
 
 
-
-#include <base/table_handler.h>
-
-#include <iostream>
 #include <iomanip>
 
 
-
-
 TableEntryBase::TableEntryBase ()
 {}
 
@@ -68,7 +72,6 @@ TableHandler::Column::Column():
 {}
 
 
-
 TableHandler::Column::~Column()
 {
   for (unsigned int i=0; i<entries.size(); ++i)
@@ -102,7 +105,6 @@ void TableHandler::add_value (const string &key,
 }
 
 
-
 void TableHandler::add_column_to_supercolumn (const string &key,
                                              const string &superkey)
 {
@@ -147,7 +149,6 @@ void TableHandler::add_column_to_supercolumn (const string &key,
 }
 
 
-
 void TableHandler::set_column_order (const vector<string> &new_order)
 {
   for (unsigned int j=0; j<new_order.size(); ++j)
@@ -185,7 +186,6 @@ void TableHandler::set_tex_format (const string &key,
 }
 
 
-
 void TableHandler::set_precision (const string &key,
                                  unsigned int precision)
 {
@@ -194,7 +194,6 @@ void TableHandler::set_precision (const string &key,
 }
 
 
-
 void TableHandler::set_scientific (const string &key,
                                   bool scientific)
 {
@@ -203,14 +202,13 @@ void TableHandler::set_scientific (const string &key,
 }
 
 
-
 void TableHandler::write_text(ostream &out) const
 {
   vector<string> sel_columns;
   get_selected_columns(sel_columns);
 
 
-                                  // write the caption line
+// write the caption line
   for (unsigned int j=0; j<column_order.size(); ++j)
     {
       string key=column_order[j];
@@ -262,7 +260,6 @@ void TableHandler::write_text(ostream &out) const
 }
 
 
-
 void TableHandler::write_tex(ofstream &out) const
 {
   out << "\\documentclass[10pt]{report}" << endl
@@ -394,7 +391,6 @@ unsigned int TableHandler::n_rows() const
 }
 
 
-
 void TableHandler::get_selected_columns(vector<string> &sel_columns) const
 {
   sel_columns.clear();
@@ -427,7 +423,6 @@ void TableHandler::get_selected_columns(vector<string> &sel_columns) const
 }
 
 
-
 // explicit instantiations
 template class TableEntry<double>;
 template class TableEntry<float>;
@@ -436,7 +431,6 @@ template class TableEntry<unsigned int>;
 template class TableEntry<string>;
 
 
-
 template
 void TableHandler::add_value(const string &, double);
 
index d1035b500899ad3ee99a903a060e5952eb796725..74d5b2ebf114a2735cdcc5f05b2e74eec03a6476 100644 (file)
@@ -1,7 +1,17 @@
-// $Id$
+//----------------------------  tensor.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tensor.cc  ---------------------------
+
 
-#include <base/tensor.h>
-#include <cmath>
 #include <lac/vector.h>
 
 
index 85ac7c405baee3c59f2a28983c83199836f927aa..6fc4e4fdb22245f3725503c487142e42f1ae4387 100644 (file)
@@ -1,14 +1,20 @@
-// $Id$
+//----------------------------  tensor_function.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  tensor_function.cc  ---------------------------
 
 
-#include <base/tensor_function.h>
-#include <vector>
-#include <base/tensor.h>
-#include <cmath>
 #include <lac/vector.h>
 
 
-
 //////////////////////////////////////////////////////////////////////
 // TensorFunction
 //////////////////////////////////////////////////////////////////////
@@ -20,13 +26,11 @@ TensorFunction<rank, dim>::TensorFunction (const double initial_time)
 {};
 
 
-
 template <int rank, int dim>
 TensorFunction<rank, dim>::~TensorFunction ()
 {};
 
 
-
 template <int rank, int dim>
 Tensor<rank,dim>
 TensorFunction<rank, dim>::value (const Point<dim> &) const
@@ -36,7 +40,6 @@ TensorFunction<rank, dim>::value (const Point<dim> &) const
 };
 
 
-
 template <int rank, int dim>
 void
 TensorFunction<rank, dim>::value_list (const vector<Point<dim> > &points,
@@ -50,7 +53,6 @@ TensorFunction<rank, dim>::value_list (const vector<Point<dim> > &points,
 };
 
 
-
 template <int rank, int dim>
 Tensor<rank+1,dim>
 TensorFunction<rank, dim>::gradient (const Point<dim> &) const
@@ -60,7 +62,6 @@ TensorFunction<rank, dim>::gradient (const Point<dim> &) const
 };
 
 
-
 template <int rank, int dim>
 void
 TensorFunction<rank, dim>::gradient_list (const vector<Point<dim> > &points,
@@ -74,7 +75,6 @@ TensorFunction<rank, dim>::gradient_list (const vector<Point<dim> > &points,
 };
 
 
-
 template class TensorFunction<1,1>;
 template class TensorFunction<2,1>;
 template class TensorFunction<3,1>;
index b9800b294e3426000878570aceb53986da9713e8..9c17fd95734e520f6ccef44f1500ceff89feaf81 100644 (file)
@@ -1,14 +1,17 @@
-/* $Id$ */
-/* Copyright W. Bangerth, University of Heidelberg, 1998 */
+//----------------------------  timer.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  timer.cc  ---------------------------
 
 
-#include <base/timer.h>
-
-
-
-// these includes should probably be properly
-// ./configure'd using the AC_HEADER_TIME macro:
-#include <sys/resource.h>
 #include <sys/time.h>
 
 Timer::Timer()
@@ -27,7 +30,6 @@ void Timer::start ()
 }
 
 
-
 double Timer::stop ()
 {
   if (running)
@@ -42,7 +44,6 @@ double Timer::stop ()
 }
 
 
-
 double Timer::operator() () const
 {
   if (running)
@@ -58,7 +59,6 @@ double Timer::operator() () const
 }
 
 
-
 void Timer::reset ()
 {
   cumulative_time = 0.;
@@ -66,7 +66,6 @@ void Timer::reset ()
 }
 
 
-
 double Timer::full_time () const
 {
   return cumulative_time;

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.