-/*---------------------------- 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>
}
-
void ConvergenceTable::evaluate_all_convergence_rates(const string &reference_column_key,
const RateMode rate_mode)
{
}
-/*---------------------------- convergence_table.cc ---------------------------*/
-/* $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>
{};
-
DataOutBase::PovrayFlags::PovrayFlags (const bool smooth,
const bool bicubic_patch,
const bool external_data) :
{};
-
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",
};
-
void DataOutBase::PovrayFlags::parse_parameters (ParameterHandler &prm)
{
smooth = prm.get_bool ("Use smooth triangles");
};
-
DataOutBase::EpsFlags::EpsFlags (const unsigned int height_vector,
const unsigned int color_vector,
const SizeType size_type,
{};
-
DataOutBase::EpsFlags::RgbValues
DataOutBase::EpsFlags::default_color_function (const double x,
const double xmin,
};
-
DataOutBase::EpsFlags::RgbValues
DataOutBase::EpsFlags::grey_scale_color_function (const double x,
const double xmin,
};
-
bool DataOutBase::EpsCell2d::operator < (const EpsCell2d &e) const
{
// note the "wrong" order in
};
-
void DataOutBase::EpsFlags::declare_parameters (ParameterHandler &prm)
{
prm.declare_entry ("Index of vector for height", "0",
};
-
void DataOutBase::EpsFlags::parse_parameters (ParameterHandler &prm)
{
height_vector = prm.get_integer ("Index of vector for height");
};
-
void DataOutBase::GmvFlags::declare_parameters (ParameterHandler &/*prm*/)
{
};
-
void DataOutBase::GmvFlags::parse_parameters (ParameterHandler &/*prm*/)
{
};
-/* $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
<< "}" << 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)
(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)
{
};
-
-
template <int dim>
void DataOutBase::write_eps (const vector<Patch<dim> > &patches,
const vector<string> &/*data_names*/,
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
const Point<2> offset(x_min, y_min);
-
- // now write preamble
+
+// now write preamble
if (true)
{
// block this to have local
};
-
template <int dim>
void DataOutBase::write_gmv (const vector<Patch<dim> > &patches,
const vector<string> &data_names,
};
- ///////////////////////////////
+///////////////////////////////
// first make up a list of used
// vertices along with their
// coordinates
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)
default:
Assert (false, ExcNotImplemented());
};
-
-
- // finally update the number
+
+
+// finally update the number
// of the first vertex of this patch
switch (dim)
{
<< endl;
};
};
-
-
- // end of variable section
+
+
+// end of variable section
out << "endvars" << endl;
// end of output
};
-
-
-
/* --------------------------- class DataOutInterface ---------------------- */
};
-
template <int dim>
void DataOutInterface<dim>::write_gnuplot (ostream &out) const
{
};
-
template <int dim>
void DataOutInterface<dim>::write_povray (ostream &out) const
{
};
-
template <int dim>
void DataOutInterface<dim>::write_eps (ostream &out) const
{
};
-
template <int dim>
void DataOutInterface<dim>::write_gmv (ostream &out) const
{
};
-
template <int dim>
void DataOutInterface<dim>::write (ostream &out,
OutputFormat output_format) const
};
-
template <int dim>
void DataOutInterface<dim>::set_default_format(OutputFormat fmt)
{
}
-
template <int dim>
void DataOutInterface<dim>::set_flags (const UcdFlags &flags)
{
};
-
template <int dim>
void DataOutInterface<dim>::set_flags (const GnuplotFlags &flags)
{
};
-
template <int dim>
void DataOutInterface<dim>::set_flags (const PovrayFlags &flags)
{
};
-
template <int dim>
void DataOutInterface<dim>::set_flags (const EpsFlags &flags)
{
};
-
template <int dim>
void DataOutInterface<dim>::set_flags (const GmvFlags &flags)
{
};
-
template <int dim>
string DataOutInterface<dim>::default_suffix (OutputFormat output_format)
{
return "";
};
};
-
template <int dim>
};
-
template <int dim>
string DataOutInterface<dim>::get_output_format_names ()
{
}
-
template <int dim>
void DataOutInterface<dim>::declare_parameters (ParameterHandler &prm)
{
}
-
template <int dim>
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>;
-/* $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,
};
-
void ExceptionBase::PrintExcData (ostream &out) const {
out << "An error occurred in line <" << line
<< "> of file <" << file
};
-
-
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 *
-/* $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>
{};
-
template <int dim>
Function<dim>::~Function ()
{};
-
template <int dim>
double Function<dim>::value (const Point<dim> &,
const unsigned int) const
};
-
template <int dim>
void Function<dim>::vector_value (const Point<dim> &,
Vector<double> &) const
};
-
template <int dim>
void Function<dim>::value_list (const vector<Point<dim> > &points,
vector<double> &values,
};
-
template <int dim>
void Function<dim>::vector_value_list (const vector<Point<dim> > &points,
vector<Vector<double> > &values) const
};
-
-
template <int dim>
Tensor<1,dim> Function<dim>::gradient (const Point<dim> &,
const unsigned int) const
};
-
template <int dim>
void Function<dim>::vector_gradient (const Point<dim> &,
vector<Tensor<1,dim> > &) const
};
-
template <int dim>
void Function<dim>::gradient_list (const vector<Point<dim> > &points,
vector<Tensor<1,dim> > &gradients,
};
-
template <int dim>
void Function<dim>::vector_gradient_list (const vector<Point<dim> > &points,
vector<vector<Tensor<1,dim> > > &gradients) const
};
-
-
-
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
};
-
template <int dim>
void ZeroFunction<dim>::vector_value (const Point<dim> &,
Vector<double> &return_value) const
};
-
template <int dim>
void ZeroFunction<dim>::value_list (const vector<Point<dim> > &points,
vector<double> &values,
};
-
template <int dim>
void ZeroFunction<dim>::vector_value_list (const vector<Point<dim> > &points,
vector<Vector<double> > &values) const
};
-
template <int dim>
Tensor<1,dim> ZeroFunction<dim>::gradient (const Point<dim> &,
const unsigned int) const
};
-
template <int dim>
void ZeroFunction<dim>::vector_gradient (const Point<dim> &,
vector<Tensor<1,dim> > &gradients) const
};
-
template <int dim>
void ZeroFunction<dim>::gradient_list (const vector<Point<dim> > &points,
vector<Tensor<1,dim> > &gradients,
};
-
template <int dim>
void ZeroFunction<dim>::vector_gradient_list (const vector<Point<dim> > &points,
vector<vector<Tensor<1,dim> > > &gradients) const
};
-
-
-
template <int dim>
ConstantFunction<dim>::ConstantFunction (const double value,
const unsigned int n_components) :
ConstantFunction<dim>::~ConstantFunction () {};
-
template <int dim>
double ConstantFunction<dim>::value (const Point<dim> &,
const unsigned int) const
};
-
template <int dim>
void ConstantFunction<dim>::vector_value (const Point<dim> &,
Vector<double> &return_value) const
};
-
template <int dim>
void ConstantFunction<dim>::value_list (const vector<Point<dim> > &points,
vector<double> &values,
};
-
template <int dim>
void ConstantFunction<dim>::vector_value_list (const vector<Point<dim> > &points,
vector<Vector<double> > &values) const
}
-
template <int dim>
void Function<dim>::vector_laplacian (const Point<dim> &,
Vector<double> &) const
}
-
template <int dim>
void Function<dim>::laplacian_list (const vector<Point<dim> > &points,
vector<double> &laplacians,
}
-
template <int dim>
void Function<dim>::vector_laplacian_list (const vector<Point<dim> > &points,
vector<Vector<double> > &laplacians) const
-// $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>
-// $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>
};
-
-// $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>
-// $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),
}
-
-
void
LogStream::attach(ostream& o)
{
}
-
void LogStream::detach ()
{
file = 0;
};
-
ostream&
LogStream::get_console()
{
}
-
ostream&
LogStream::get_file_stream()
{
}
-
void
LogStream::push (const string& text)
{
};
-
void LogStream::pop ()
{
prefixes.pop();
};
-
void
LogStream::depth_console(unsigned n)
{
};
-
void
LogStream::depth_file(unsigned n)
{
};
-
void
LogStream::log_execution_time(bool flag)
{
}
-
void
LogStream::print_line_head()
{
}
-
LogStream&
LogStream::operator << (void (f)(LogStream &))
{
}
-
-/* $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>
};
-
Patterns::Selection::Selection (const string &seq) {
sequence = seq;
};
-
Patterns::MultipleSelection::MultipleSelection (const string &seq) {
Assert (seq.find (",") == string::npos, ExcCommasNotAllowed(seq.find(",")));
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)
{
};
-
Patterns::Bool::Bool () :
Selection ("true|false")
{};
};
-
Patterns::Anything::Anything ()
{};
-
bool Patterns::Anything::match (const string &) const {
return true;
};
};
-
-
-
-
ParameterHandler::ParameterHandler () :
status(true) {};
ParameterHandler::~ParameterHandler () {};
-
bool ParameterHandler::read_input (istream &input) {
AssertThrow (input, ExcIO());
}
-
bool ParameterHandler::read_input_from_string (const char *s) {
// if empty string then exit
// with success
};
-
-
void ParameterHandler::clear () {
status = true;
};
-
bool ParameterHandler::declare_entry (const string &entry,
const string &default_value,
const Patterns::PatternBase &pattern) {
return true;
};
-
-
void ParameterHandler::enter_subsection (const string &subsection) {
subsection_path.push_back (subsection);
};
-
bool ParameterHandler::leave_subsection () {
// assert there is a subsection that
};
-
const string & ParameterHandler::get (const string &entry_string) const {
const Section* pd = get_present_defaults_subsection ();
const Section* pc = get_present_changed_subsection ();
};
- // 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);
};
-
long int ParameterHandler::get_integer (const string &entry_string) const {
string s = get (entry_string);
char *endptr;
};
-
double ParameterHandler::get_double (const string &entry_string) const {
string s = get (entry_string);
char *endptr;
};
-
bool ParameterHandler::get_bool (const string &entry_string) const {
string s = get(entry_string);
};
-
ostream & ParameterHandler::print_parameters (ostream &out, OutputStyle style) {
// assert that only known formats are
// given as "style"
};
-
void ParameterHandler::print_parameters_section (ostream &out,
const OutputStyle style,
const unsigned int indent_level) {
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)
{
};
-
-
bool ParameterHandler::scan_line (string line, const unsigned int lineno) {
// if there is a comment, delete it
if (line.find('#') != string::npos)
};
-
ParameterHandler::Section* ParameterHandler::get_present_defaults_subsection () {
Section* sec = &defaults;
vector<string>::const_iterator SecName = subsection_path.begin();
};
-
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#
};
-
ParameterHandler::Section* ParameterHandler::get_present_changed_subsection () {
Section* sec = &changed_entries;
vector<string>::iterator SecName = subsection_path.begin();
};
-
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();
};
-
ParameterHandler::Section::~Section () {
entries.clear ();
delete p->second;
- subsections.clear ();
+subsections.clear ();
};
-
-
-
MultipleParameterLoop::MultipleParameterLoop() :
n_branches(0) {};
};
-
bool MultipleParameterLoop::read_input (const string &filename)
{
return ParameterHandler::read_input (filename);
};
-
bool MultipleParameterLoop::read_input_from_string (const char *s) {
bool x = ParameterHandler::read_input (s);
init_branches ();
};
-
-
-
void MultipleParameterLoop::loop (MultipleParameterLoop::UserClass &uc) {
for (int run_no=0; run_no<n_branches; ++run_no)
{
<< " 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)
};
-
void MultipleParameterLoop::init_branches_section (const ParameterHandler::Section &sec) {
// check all entries in the present subsection
// whether it is a multiple entry
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)
{
};
-
MultipleParameterLoop::Entry::Entry (const vector<string> &ssp,
const string& Name,
subsection_path (ssp), entry_name(Name), entry_value(Value) {};
-
void MultipleParameterLoop::Entry::split_different_values () {
// split string into three parts:
// part before the opening "{",
-// $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>
-/* $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),
};
-
template <>
Quadrature<1>::Quadrature (const Quadrature<0> &,
const Quadrature<1> &) {
};
-
template <int dim>
Quadrature<dim>::Quadrature (const Quadrature<dim-1> &q1,
const Quadrature<1> &q2) :
};
-
template <int dim>
Quadrature<dim>::~Quadrature () {};
-
template <>
const Point<0> & Quadrature<0>::quad_point (const unsigned int) const {
Assert (false, ExcInternalError());
};
-
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));
};
-
template <>
const vector<Point<0> > & Quadrature<0>::get_quad_points () const {
Assert (false, ExcInternalError());
};
-
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());
};
-
template <int dim>
double Quadrature<dim>::weight (const unsigned int i) const {
Assert (i<n_quadrature_points, ExcIndexRange(i, 0, n_quadrature_points));
};
-
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());
};
-
template <>
void QProjector<2>::project_to_face (const Quadrature<1> &quadrature,
const unsigned int face_no,
};
-
template <>
void QProjector<3>::project_to_face (const Quadrature<2> &quadrature,
const unsigned int face_no,
};
-
template <>
void QProjector<2>::project_to_subface (const Quadrature<1> &quadrature,
const unsigned int face_no,
};
-
template <>
void QProjector<3>::project_to_subface (const Quadrature<2> &quadrature,
const unsigned int face_no,
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)
};
-
-
template <>
bool
QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature)
};
-
template <>
QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
const unsigned int n_copies) :
// 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
};
-
-
// construct higher dimensional quadrature formula by tensor product of lower
// dimensional iterated quadrature formulae
template <int dim>
{};
-
-
// explicit instantiations; note: we need them all for all dimensions
template class Quadrature<1>;
template class Quadrature<2>;
-/* $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>
};
-
template <>
QGauss3<1>::QGauss3 () :
Quadrature<1> (3)
};
-
template <>
QGauss5<1>::QGauss5 () :
Quadrature<1> (5)
};
-
template <>
QGauss6<1>::QGauss6 () :
Quadrature<1> (6)
};
-
template <>
QGauss7<1>::QGauss7 () :
Quadrature<1> (7)
};
-
template <>
QGauss8<1>::QGauss8 () :
Quadrature<1> (8)
};
-
template <>
QMidpoint<1>::QMidpoint () :
Quadrature<1>(1)
};
-
template <>
QSimpson<1>::QSimpson () :
Quadrature<1> (3)
};
-
template <>
QTrapez<1>::QTrapez () :
Quadrature<1> (2)
Quadrature<dim> (QTrapez<dim-1>(), QTrapez<1>()){};
-
-
// explicite specialization
// note that 1d formulae are specialized by implementation above
template class QGauss2<2>;
-/* $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 () :
{};
-
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;
-/*---------------------------- 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 ()
{}
{}
-
TableHandler::Column::~Column()
{
for (unsigned int i=0; i<entries.size(); ++i)
}
-
void TableHandler::add_column_to_supercolumn (const string &key,
const string &superkey)
{
}
-
void TableHandler::set_column_order (const vector<string> &new_order)
{
for (unsigned int j=0; j<new_order.size(); ++j)
}
-
void TableHandler::set_precision (const string &key,
unsigned int precision)
{
}
-
void TableHandler::set_scientific (const string &key,
bool scientific)
{
}
-
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];
}
-
void TableHandler::write_tex(ofstream &out) const
{
out << "\\documentclass[10pt]{report}" << endl
}
-
void TableHandler::get_selected_columns(vector<string> &sel_columns) const
{
sel_columns.clear();
}
-
// explicit instantiations
template class TableEntry<double>;
template class TableEntry<float>;
template class TableEntry<string>;
-
template
void TableHandler::add_value(const string &, double);
-// $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>
-// $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
//////////////////////////////////////////////////////////////////////
{};
-
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
};
-
template <int rank, int dim>
void
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
};
-
template <int rank, int dim>
void
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>;
-/* $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()
}
-
double Timer::stop ()
{
if (running)
}
-
double Timer::operator() () const
{
if (running)
}
-
void Timer::reset ()
{
cumulative_time = 0.;
}
-
double Timer::full_time () const
{
return cumulative_time;