/**
* Laplacian at a single point.
*/
- double laplacian(const Point<dim> &p,
- const unsigned int component = 0) const;
+ double laplacian (const Point<dim> &p,
+ const unsigned int component = 0) const;
/**
* Laplacian at multiple points.
*/
- void laplacian_list(const vector<Point<dim> > &points,
- vector<double> &values,
- const unsigned int component = 0) const;
+ void laplacian_list (const vector<Point<dim> > &points,
+ vector<double> &values,
+ const unsigned int component = 0) const;
};
#include <map>
+template <int dim> class FEFaceValues;
+template <int dim> class FESubfaceValues;
+
+
/**
* Implementation of the error estimator by Kelly, Gago, Zienkiewicz
template <typename number, int rows, int columns > class BlockSparseMatrix;
template <int n_blocks, typename Number> class BlockVector;
+
+template <int dim> class DoFHandler;
+template <int dim> class MGDoFHandler;
template <int dim> class FEValues;
template <int dim> class Equation;
// classes derived from
// ``Function'', that class
// declares an exception
- // ``ExcVectorHasWrongSize'' which
+ // ``ExcDimensionMismatch'' which
// takes the sizes of two vectors
// and prints some output in case
// the condition is violated:
Assert (values.size() == n_points,
- ExcVectorHasWrongSize (values.size(), n_points));
+ ExcDimensionMismatch (values.size(), n_points));
// Since examples are not very good
// if they do not demonstrate their
// point, we will show how to
// components that this function
// has.)
Assert (component == 0,
- ExcWrongComponent (component, 1));
+ ExcIndexRange (component, 0, 1));
for (unsigned int i=0; i<n_points; ++i)
{
const unsigned int n_points = points.size();
Assert (values.size() == n_points,
- ExcVectorHasWrongSize (values.size(), n_points));
+ ExcDimensionMismatch (values.size(), n_points));
Assert (component == 0,
- ExcWrongComponent (component, 1));
+ ExcIndexRange (component, 0, 1));
for (unsigned int i=0; i<n_points; ++i)
{
// for this case and otherwise
// throw an exception:
Assert (values.size() == dim,
- ExcVectorHasWrongSize (values.size(), dim));
+ ExcDimensionMismatch (values.size(), dim));
// Likewise, if by some accident
// someone tried to compile and run
// the program in only one space
// correctly, i.e. to the number of
// input points:
Assert (value_list.size() == n_points,
- ExcVectorHasWrongSize (value_list.size(), n_points));
+ ExcDimensionMismatch (value_list.size(), n_points));
// Finally we treat each of the
// points. In one of the previous
#include <lac/vector_memory.h>
+template <typename number> class Vector;
+template <typename number> class SparseMatrix;
+
+
/**
* No preconditioning.
* This class helps you, if you want to use a linear solver without