From 85d9c3cf9ca24293c949e6a11195f39da66a4280 Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Thu, 18 Jul 2013 19:42:40 +0000 Subject: [PATCH] Process a whole bunch of remaining copyright notices git-svn-id: https://svn.dealii.org/trunk@30049 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/cmake/config/Config.cmake.in | 28 ++++++++++--------- .../cmake/scripts/expand_instantiations.cc | 22 +++++++++------ deal.II/cmake/scripts/make_dependencies.cc | 22 +++++++++------ deal.II/cmake/scripts/report_features.cc.in | 21 ++++++++------ .../lapack_templates/lapack_templates.pl | 20 +++++++------ deal.II/doc/development/testsuite.html | 20 +++++++------ deal.II/doc/doxygen/headers/boundary.h | 22 +++++++++------ .../doc/doxygen/headers/coding_conventions.h | 22 +++++++++------ deal.II/doc/doxygen/headers/constraints.h | 22 +++++++++------ deal.II/doc/doxygen/headers/distributed.h | 22 +++++++++------ deal.II/doc/doxygen/headers/dofs.h | 22 +++++++++------ deal.II/doc/doxygen/headers/exceptions.h | 22 +++++++++------ deal.II/doc/doxygen/headers/fe.h | 22 +++++++++------ deal.II/doc/doxygen/headers/functions.h | 22 +++++++++------ deal.II/doc/doxygen/headers/geodynamics.h | 22 +++++++++------ .../doxygen/headers/geometry_and_primitives.h | 22 +++++++++------ .../doc/doxygen/headers/global_dof_index.h | 22 +++++++++------ deal.II/doc/doxygen/headers/glossary.h | 23 ++++++++------- deal.II/doc/doxygen/headers/grid.h | 22 +++++++++------ deal.II/doc/doxygen/headers/hp.h | 22 +++++++++------ deal.II/doc/doxygen/headers/instantiations.h | 22 +++++++++------ deal.II/doc/doxygen/headers/integrators.h | 22 +++++++++------ deal.II/doc/doxygen/headers/io.h | 22 +++++++++------ deal.II/doc/doxygen/headers/iterators.h | 16 +++++++++++ deal.II/doc/doxygen/headers/lac.h | 22 +++++++++------ deal.II/doc/doxygen/headers/main.h | 22 +++++++++------ deal.II/doc/doxygen/headers/matrices.h | 22 +++++++++------ deal.II/doc/doxygen/headers/memory.h | 22 +++++++++------ deal.II/doc/doxygen/headers/mesh_worker.h | 22 +++++++++------ deal.II/doc/doxygen/headers/mg.h | 22 +++++++++------ deal.II/doc/doxygen/headers/multithreading.h | 22 +++++++++------ .../doc/doxygen/headers/namespace_dealii.h | 16 +++++++++++ .../doxygen/headers/numerical_algorithms.h | 22 +++++++++------ deal.II/doc/doxygen/headers/parallel.h | 22 +++++++++------ deal.II/doc/doxygen/headers/petsc.h | 22 +++++++++------ deal.II/doc/doxygen/headers/polynomials.h | 22 +++++++++------ deal.II/doc/doxygen/headers/preconditioners.h | 22 +++++++++------ deal.II/doc/doxygen/headers/quadrature.h | 22 +++++++++------ deal.II/doc/doxygen/headers/slepc.h | 22 +++++++++------ deal.II/doc/doxygen/headers/solvers.h | 22 +++++++++------ deal.II/doc/doxygen/headers/std_cxx1x.h | 22 +++++++++------ deal.II/doc/doxygen/headers/trilinos.h | 22 +++++++++------ deal.II/doc/doxygen/headers/tutorial.h | 22 +++++++++------ deal.II/doc/doxygen/headers/update_flags.h | 21 ++++++++------ deal.II/doc/doxygen/headers/utilities.h | 22 +++++++++------ deal.II/doc/doxygen/headers/vector_memory.h | 22 +++++++++------ deal.II/doc/doxygen/headers/vector_valued.h | 22 +++++++++------ deal.II/doc/doxygen/headers/vectors.h | 22 +++++++++------ deal.II/doc/doxygen/scripts/create_anchors | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/intro2toc | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/make_step.pl | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/program2doxygen | 28 ++++++++++--------- deal.II/doc/doxygen/scripts/program2doxyplain | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/program2html | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/program2plain | 27 ++++++++++-------- deal.II/doc/doxygen/scripts/program2toc | 27 ++++++++++-------- deal.II/source/algorithms/operator.inst.in | 22 +++++++++------ .../distributed/grid_refinement.inst.in | 22 +++++++++------ .../distributed/solution_transfer.inst.in | 22 +++++++++------ deal.II/source/distributed/tria.inst.in | 22 +++++++++------ deal.II/source/dofs/block_info.inst.in | 22 +++++++++------ deal.II/source/dofs/dof_accessor.inst.in | 22 +++++++++------ deal.II/source/dofs/dof_handler.inst.in | 22 +++++++++------ .../source/dofs/dof_handler_policy.inst.in | 22 +++++++++------ deal.II/source/dofs/dof_objects.inst.in | 22 +++++++++------ deal.II/source/dofs/dof_renumbering.inst.in | 22 +++++++++------ deal.II/source/dofs/dof_tools.inst.in | 21 ++++++++------ deal.II/source/fe/fe.inst.in | 22 +++++++++------ deal.II/source/fe/fe_abf.inst.in | 22 +++++++++------ deal.II/source/fe/fe_bdm.inst.in | 22 +++++++++------ deal.II/source/fe/fe_dg_vector.inst.in | 22 +++++++++------ deal.II/source/fe/fe_dgp.inst.in | 22 +++++++++------ deal.II/source/fe/fe_dgp_monomial.inst.in | 22 +++++++++------ .../source/fe/fe_dgp_nonparametric.inst.in | 22 +++++++++------ deal.II/source/fe/fe_dgq.inst.in | 22 +++++++++------ deal.II/source/fe/fe_face.inst.in | 22 +++++++++------ deal.II/source/fe/fe_nedelec.inst.in | 22 +++++++++------ deal.II/source/fe/fe_nothing.inst.in | 22 +++++++++------ deal.II/source/fe/fe_poly.inst.in | 22 +++++++++------ deal.II/source/fe/fe_poly_tensor.inst.in | 22 +++++++++------ deal.II/source/fe/fe_q.inst.in | 22 +++++++++------ deal.II/source/fe/fe_q_base.inst.in | 22 +++++++++------ deal.II/source/fe/fe_q_dg0.inst.in | 22 +++++++++------ deal.II/source/fe/fe_q_hierarchical.inst.in | 22 +++++++++------ deal.II/source/fe/fe_q_iso_q1.inst.in | 22 +++++++++------ deal.II/source/fe/fe_raviart_thomas.inst.in | 22 +++++++++------ .../source/fe/fe_raviart_thomas_nodal.inst.in | 22 +++++++++------ deal.II/source/fe/fe_system.inst.in | 22 +++++++++------ deal.II/source/fe/fe_tools.inst.in | 22 +++++++++------ deal.II/source/fe/fe_values.decl.1.inst.in | 22 +++++++++------ deal.II/source/fe/fe_values.decl.2.inst.in | 22 +++++++++------ deal.II/source/fe/fe_values.impl.1.inst.in | 22 +++++++++------ deal.II/source/fe/fe_values.impl.2.inst.in | 22 +++++++++------ deal.II/source/fe/fe_values.inst.in | 22 +++++++++------ deal.II/source/fe/mapping.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_c1.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_cartesian.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_q.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_q1.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_q1_eulerian.inst.in | 22 +++++++++------ deal.II/source/fe/mapping_q_eulerian.inst.in | 22 +++++++++------ deal.II/source/grid/grid_generator.inst.in | 22 +++++++++------ deal.II/source/grid/grid_in.inst.in | 22 +++++++++------ deal.II/source/grid/grid_out.inst.in | 22 +++++++++------ deal.II/source/grid/grid_refinement.inst.in | 22 +++++++++------ deal.II/source/grid/grid_tools.inst.in | 22 +++++++++------ deal.II/source/grid/intergrid_map.inst.in | 22 +++++++++------ deal.II/source/grid/tria.inst.in | 22 +++++++++------ deal.II/source/grid/tria_accessor.inst.in | 22 +++++++++------ deal.II/source/grid/tria_boundary.inst.in | 22 +++++++++------ deal.II/source/grid/tria_boundary_lib.inst.in | 22 +++++++++------ deal.II/source/grid/tria_objects.inst.in | 22 +++++++++------ deal.II/source/hp/dof_handler.inst.in | 22 +++++++++------ deal.II/source/hp/fe_collection.inst.in | 22 +++++++++------ deal.II/source/hp/fe_values.inst.in | 22 +++++++++------ deal.II/source/hp/mapping_collection.inst.in | 22 +++++++++------ .../source/lac/block_sparse_matrix.inst.in | 16 +++++++++++ deal.II/source/lac/block_vector.inst.in | 22 +++++++++------ .../source/lac/chunk_sparse_matrix.inst.in | 22 +++++++++------ deal.II/source/lac/constraint_matrix.inst.in | 16 +++++++++++ deal.II/source/lac/full_matrix.inst.in | 22 +++++++++------ deal.II/source/lac/lapack_full_matrix.inst.in | 22 +++++++++------ deal.II/source/lac/parallel_vector.inst.in | 22 +++++++++------ deal.II/source/lac/precondition_block.inst.in | 21 ++++++++------ deal.II/source/lac/relaxation_block.inst.in | 21 ++++++++------ deal.II/source/lac/solver.inst.in | 22 +++++++++------ deal.II/source/lac/sparse_matrix.inst.in | 22 +++++++++------ deal.II/source/lac/sparse_matrix_ez.inst.in | 22 +++++++++------ .../source/lac/trilinos_sparse_matrix.inst.in | 22 +++++++++------ .../source/lac/trilinos_vector_base.inst.in | 22 +++++++++------ deal.II/source/lac/vector.inst.in | 22 +++++++++------ deal.II/source/lac/vector_memory.inst.in | 22 +++++++++------ deal.II/source/lac/vector_view.inst.in | 22 +++++++++------ .../source/matrix_free/matrix_free.inst.in | 22 +++++++++------ .../meshworker/mesh_worker_info.inst.in | 21 ++++++++------ .../mesh_worker_vector_selector.inst.in | 21 ++++++++------ deal.II/source/multigrid/mg_base.inst.in | 21 ++++++++------ .../source/multigrid/mg_dof_handler.inst.in | 22 +++++++++------ deal.II/source/multigrid/mg_tools.inst.in | 21 ++++++++------ .../multigrid/mg_transfer_block.inst.in | 22 +++++++++------ .../multigrid/mg_transfer_component.inst.in | 22 +++++++++------ .../multigrid/mg_transfer_prebuilt.inst.in | 21 ++++++++------ deal.II/source/multigrid/multigrid.inst.in | 21 ++++++++------ deal.II/source/numerics/data_out.inst.in | 22 +++++++++------ .../source/numerics/data_out_faces.inst.in | 22 +++++++++------ .../source/numerics/data_out_rotation.inst.in | 22 +++++++++------ .../source/numerics/data_out_stack.inst.in | 22 +++++++++------ .../numerics/data_postprocessor.inst.in | 22 +++++++++------ .../numerics/derivative_approximation.inst.in | 22 +++++++++------ .../numerics/dof_output_operator.inst.in | 22 +++++++++------ .../source/numerics/error_estimator.inst.in | 22 +++++++++------ .../source/numerics/fe_field_function.inst.in | 21 ++++++++------ deal.II/source/numerics/matrix_tools.inst.in | 22 +++++++++------ .../numerics/point_value_history.inst.in | 22 +++++++++------ .../source/numerics/solution_transfer.inst.in | 22 +++++++++------ .../source/numerics/time_dependent.inst.in | 22 +++++++++------ deal.II/source/numerics/vector_tools.inst.in | 21 ++++++++------ tests/lib/test_grids.h | 12 -------- 158 files changed, 2067 insertions(+), 1406 deletions(-) diff --git a/deal.II/cmake/config/Config.cmake.in b/deal.II/cmake/config/Config.cmake.in index 017b6f2510..150793f5cc 100644 --- a/deal.II/cmake/config/Config.cmake.in +++ b/deal.II/cmake/config/Config.cmake.in @@ -1,23 +1,25 @@ -##### +## --------------------------------------------------------------------- +## $Id$ ## -## Copyright (C) 2012 by the deal.II authors +## Copyright (C) 2012 - 2013 by the deal.II authors ## ## This file is part of the deal.II library. ## -## -## This file is dual licensed under QPL 1.0 and LGPL 2.1 or any later -## version of the LGPL license. +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. ## -## Author: Matthias Maier -## -##### +## --------------------------------------------------------------------- -########################################################################## -## ## -## The deal.II project configuration file ## -## ## -########################################################################## +######################################################################## +## ## +## The deal.II project configuration file ## +## ## +######################################################################## # diff --git a/deal.II/cmake/scripts/expand_instantiations.cc b/deal.II/cmake/scripts/expand_instantiations.cc index 8f62d4ed71..6f89828b70 100644 --- a/deal.II/cmake/scripts/expand_instantiations.cc +++ b/deal.II/cmake/scripts/expand_instantiations.cc @@ -1,15 +1,19 @@ -//---------------------------- expand_instantiations.cc ------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2007, 2008, 2009, 2010, 2011 by the deal.II authors +// Copyright (C) 2007 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------- expand_instantiations.cc ------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // This is the program that we use to generate explicit instantiations for a // variety of template arguments. It takes two kinds of input files. The first diff --git a/deal.II/cmake/scripts/make_dependencies.cc b/deal.II/cmake/scripts/make_dependencies.cc index 1e6e2bb2f6..b7796338bf 100644 --- a/deal.II/cmake/scripts/make_dependencies.cc +++ b/deal.II/cmake/scripts/make_dependencies.cc @@ -1,15 +1,19 @@ -//---------------------------- make_dependencies.cc ------------------------ -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2003, 2007, 2008, 2010, 2011 by the deal.II authors +// Copyright (C) 2003 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------- make_dependencies.cc ------------------------ +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // Make a dependency file tree // usage: make_depencies -Iinc_path1 -Iinc_path2 ... -Bbasepath files diff --git a/deal.II/cmake/scripts/report_features.cc.in b/deal.II/cmake/scripts/report_features.cc.in index 207a374326..457d226e04 100644 --- a/deal.II/cmake/scripts/report_features.cc.in +++ b/deal.II/cmake/scripts/report_features.cc.in @@ -1,15 +1,18 @@ -//---------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2011, 2012, 2013 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- #include diff --git a/deal.II/contrib/lapack_templates/lapack_templates.pl b/deal.II/contrib/lapack_templates/lapack_templates.pl index 08cea1600a..acfd48c119 100644 --- a/deal.II/contrib/lapack_templates/lapack_templates.pl +++ b/deal.II/contrib/lapack_templates/lapack_templates.pl @@ -40,19 +40,21 @@ my $double; print << 'EOT' -//--------------------------------------------------------------------------- +// --------------------------------------------------------------------- +// $Id$ // -// This file was automatically generated from lapack_templates.h.in -// See blastemplates in the deal.II contrib directory +// Copyright (C) 2005 - 2013 by the deal.II authors // -// Copyright (C) 2005, 2006, 2007, 2008, 2009, 2010 by the deal authors +// This file is part of the deal.II library. // -// 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. +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. // -//--------------------------------------------------------------------------- +// --------------------------------------------------------------------- #ifndef __LAPACK_TEMPLATES_H #define __LAPACK_TEMPLATES_H diff --git a/deal.II/doc/development/testsuite.html b/deal.II/doc/development/testsuite.html index 27b34d04ab..e101dcf7ed 100644 --- a/deal.II/doc/development/testsuite.html +++ b/deal.II/doc/development/testsuite.html @@ -360,17 +360,21 @@ For the testcase, we usually start from a template like this:
 
-//----------------------------  my_new_test.cc  ---------------------------
-//    $Id$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005 by the deal.II authors
+// Copyright (C) 2013 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.
+// This file is part of the deal.II library.
 //
-//----------------------------  my_new_test.cc  ---------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
 
 
 // a short (a few lines) description of what the program does
diff --git a/deal.II/doc/doxygen/headers/boundary.h b/deal.II/doc/doxygen/headers/boundary.h
index 7ffad2ac01..adfe76abf7 100644
--- a/deal.II/doc/doxygen/headers/boundary.h
+++ b/deal.II/doc/doxygen/headers/boundary.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2012 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup boundary Boundary description for triangulations
diff --git a/deal.II/doc/doxygen/headers/coding_conventions.h b/deal.II/doc/doxygen/headers/coding_conventions.h
index 1382e47390..f6fff10ef5 100644
--- a/deal.II/doc/doxygen/headers/coding_conventions.h
+++ b/deal.II/doc/doxygen/headers/coding_conventions.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 1998, 2007, 2008, 2011 by the deal.II authors
+// Copyright (C) 1998 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @page CodingConventions Coding conventions used throughout deal.II
diff --git a/deal.II/doc/doxygen/headers/constraints.h b/deal.II/doc/doxygen/headers/constraints.h
index e4c4e6dbda..999a97659e 100644
--- a/deal.II/doc/doxygen/headers/constraints.h
+++ b/deal.II/doc/doxygen/headers/constraints.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2010, 2012, 2013 by the deal.II authors
+// Copyright (C) 2010 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup constraints Constraints on degrees of freedom
diff --git a/deal.II/doc/doxygen/headers/distributed.h b/deal.II/doc/doxygen/headers/distributed.h
index 93830f4e6a..d5a76f7850 100644
--- a/deal.II/doc/doxygen/headers/distributed.h
+++ b/deal.II/doc/doxygen/headers/distributed.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2009, 2010, 2012 by the deal.II authors
+// Copyright (C) 2009 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup distributed Parallel computing with multiple processors using distributed memory
diff --git a/deal.II/doc/doxygen/headers/dofs.h b/deal.II/doc/doxygen/headers/dofs.h
index 9a324be081..6448f2b930 100644
--- a/deal.II/doc/doxygen/headers/dofs.h
+++ b/deal.II/doc/doxygen/headers/dofs.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2010, 2011 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup dofs Degrees of Freedom
diff --git a/deal.II/doc/doxygen/headers/exceptions.h b/deal.II/doc/doxygen/headers/exceptions.h
index b6f5cf43b6..03594750c2 100644
--- a/deal.II/doc/doxygen/headers/exceptions.h
+++ b/deal.II/doc/doxygen/headers/exceptions.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Exceptions Exceptions and assertions
diff --git a/deal.II/doc/doxygen/headers/fe.h b/deal.II/doc/doxygen/headers/fe.h
index 499e2476aa..eb21a6d7b7 100644
--- a/deal.II/doc/doxygen/headers/fe.h
+++ b/deal.II/doc/doxygen/headers/fe.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2007, 2008, 2011 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup feall Finite elements
diff --git a/deal.II/doc/doxygen/headers/functions.h b/deal.II/doc/doxygen/headers/functions.h
index cb84efad75..620fb25260 100644
--- a/deal.II/doc/doxygen/headers/functions.h
+++ b/deal.II/doc/doxygen/headers/functions.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup functions Functions
diff --git a/deal.II/doc/doxygen/headers/geodynamics.h b/deal.II/doc/doxygen/headers/geodynamics.h
index 47afee7243..d67db9b198 100644
--- a/deal.II/doc/doxygen/headers/geodynamics.h
+++ b/deal.II/doc/doxygen/headers/geodynamics.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2009 by the deal.II authors
+// Copyright (C) 2009 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
 @defgroup geodynamics The geodynamics demonstration suite
diff --git a/deal.II/doc/doxygen/headers/geometry_and_primitives.h b/deal.II/doc/doxygen/headers/geometry_and_primitives.h
index aa90d31cb1..e52cb5a444 100644
--- a/deal.II/doc/doxygen/headers/geometry_and_primitives.h
+++ b/deal.II/doc/doxygen/headers/geometry_and_primitives.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006, 2007 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup geomprimitives Geometric and other primitives
diff --git a/deal.II/doc/doxygen/headers/global_dof_index.h b/deal.II/doc/doxygen/headers/global_dof_index.h
index f01770a050..a4b5542416 100644
--- a/deal.II/doc/doxygen/headers/global_dof_index.h
+++ b/deal.II/doc/doxygen/headers/global_dof_index.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id: coding_conventions.h 29312 2013-04-17 13:00:07Z turcksin $
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @page GlobalDoFIndex When to use types::global_dof_index instead of unsigned int
diff --git a/deal.II/doc/doxygen/headers/glossary.h b/deal.II/doc/doxygen/headers/glossary.h
index c9dec751ae..a84c1a6612 100644
--- a/deal.II/doc/doxygen/headers/glossary.h
+++ b/deal.II/doc/doxygen/headers/glossary.h
@@ -1,16 +1,19 @@
-
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2005 - 2013 by the deal.II authors
 //
-//    Copyright (C) 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2012, 2013 by the deal.II authors
+// This file is part of the deal.II library.
 //
-//    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.
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
 //
-//-------------------------------------------------------------------------
+// ---------------------------------------------------------------------
+
 
 /**
  * @page DEALGlossary Glossary
diff --git a/deal.II/doc/doxygen/headers/grid.h b/deal.II/doc/doxygen/headers/grid.h
index cc800ac710..61395d223c 100644
--- a/deal.II/doc/doxygen/headers/grid.h
+++ b/deal.II/doc/doxygen/headers/grid.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup grid Grid classes
diff --git a/deal.II/doc/doxygen/headers/hp.h b/deal.II/doc/doxygen/headers/hp.h
index 487e4dee4d..2cd5ac1e52 100644
--- a/deal.II/doc/doxygen/headers/hp.h
+++ b/deal.II/doc/doxygen/headers/hp.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2007, 2011 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup hp hp finite element support
diff --git a/deal.II/doc/doxygen/headers/instantiations.h b/deal.II/doc/doxygen/headers/instantiations.h
index f53e2ae151..91e95805d0 100644
--- a/deal.II/doc/doxygen/headers/instantiations.h
+++ b/deal.II/doc/doxygen/headers/instantiations.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2005 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @page Instantiations Template instantiations
diff --git a/deal.II/doc/doxygen/headers/integrators.h b/deal.II/doc/doxygen/headers/integrators.h
index 0a649fc5c3..9f598c9684 100644
--- a/deal.II/doc/doxygen/headers/integrators.h
+++ b/deal.II/doc/doxygen/headers/integrators.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2010, 2011 by the deal.II authors
+// Copyright (C) 2010 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Integrators Integrators
diff --git a/deal.II/doc/doxygen/headers/io.h b/deal.II/doc/doxygen/headers/io.h
index 4fed985a4e..11382be961 100644
--- a/deal.II/doc/doxygen/headers/io.h
+++ b/deal.II/doc/doxygen/headers/io.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005, 2006, 2010 by the deal.II authors
+// Copyright (C) 2005 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup IO Input/Output
diff --git a/deal.II/doc/doxygen/headers/iterators.h b/deal.II/doc/doxygen/headers/iterators.h
index 52f44bea81..144ffeaa0f 100644
--- a/deal.II/doc/doxygen/headers/iterators.h
+++ b/deal.II/doc/doxygen/headers/iterators.h
@@ -1,3 +1,19 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 /**
  @defgroup Iterators Iterators on mesh-like containers
  @{
diff --git a/deal.II/doc/doxygen/headers/lac.h b/deal.II/doc/doxygen/headers/lac.h
index 8f200ba5db..e697d1eb7a 100644
--- a/deal.II/doc/doxygen/headers/lac.h
+++ b/deal.II/doc/doxygen/headers/lac.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/main.h b/deal.II/doc/doxygen/headers/main.h
index 965c5ae618..8f4995fa9a 100644
--- a/deal.II/doc/doxygen/headers/main.h
+++ b/deal.II/doc/doxygen/headers/main.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006, 2007, 2010, 2011, 2012 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @mainpage
diff --git a/deal.II/doc/doxygen/headers/matrices.h b/deal.II/doc/doxygen/headers/matrices.h
index 1ec2f373fe..979bcaa9b0 100644
--- a/deal.II/doc/doxygen/headers/matrices.h
+++ b/deal.II/doc/doxygen/headers/matrices.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006, 2007, 2010, 2012 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/memory.h b/deal.II/doc/doxygen/headers/memory.h
index 82d4748a2e..413040165f 100644
--- a/deal.II/doc/doxygen/headers/memory.h
+++ b/deal.II/doc/doxygen/headers/memory.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup memory Memory handling
diff --git a/deal.II/doc/doxygen/headers/mesh_worker.h b/deal.II/doc/doxygen/headers/mesh_worker.h
index c23e4d46fd..937675e30f 100644
--- a/deal.II/doc/doxygen/headers/mesh_worker.h
+++ b/deal.II/doc/doxygen/headers/mesh_worker.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id: lac.h 12034 2006-01-15 21:16:14Z wolf $
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2010 by the deal.II authors
+// Copyright (C) 2010 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/mg.h b/deal.II/doc/doxygen/headers/mg.h
index ab162e9d50..bebf6c7987 100644
--- a/deal.II/doc/doxygen/headers/mg.h
+++ b/deal.II/doc/doxygen/headers/mg.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2005, 2006, 2009, 2010 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup mg Multilevel support
diff --git a/deal.II/doc/doxygen/headers/multithreading.h b/deal.II/doc/doxygen/headers/multithreading.h
index e4e9d99228..ca73ffd0a5 100644
--- a/deal.II/doc/doxygen/headers/multithreading.h
+++ b/deal.II/doc/doxygen/headers/multithreading.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006, 2008, 2009, 2010, 2011, 2012 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup threads Parallel computing with multiple processors accessing shared memory
diff --git a/deal.II/doc/doxygen/headers/namespace_dealii.h b/deal.II/doc/doxygen/headers/namespace_dealii.h
index 4edf5ab273..df80dbf758 100644
--- a/deal.II/doc/doxygen/headers/namespace_dealii.h
+++ b/deal.II/doc/doxygen/headers/namespace_dealii.h
@@ -1,3 +1,19 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 /**
  * This is the namespace in which everything in deal.II is. To avoid prefixing
  * every class and function call with the namespace name, the @ref Tutorial
diff --git a/deal.II/doc/doxygen/headers/numerical_algorithms.h b/deal.II/doc/doxygen/headers/numerical_algorithms.h
index 34ac3d345a..86a018e324 100644
--- a/deal.II/doc/doxygen/headers/numerical_algorithms.h
+++ b/deal.II/doc/doxygen/headers/numerical_algorithms.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup numerics Numerical algorithms
diff --git a/deal.II/doc/doxygen/headers/parallel.h b/deal.II/doc/doxygen/headers/parallel.h
index 83334380cc..b169b70043 100644
--- a/deal.II/doc/doxygen/headers/parallel.h
+++ b/deal.II/doc/doxygen/headers/parallel.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2009, 2012 by the deal.II authors
+// Copyright (C) 2009 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Parallel Parallel computing
diff --git a/deal.II/doc/doxygen/headers/petsc.h b/deal.II/doc/doxygen/headers/petsc.h
index 6b1aa90532..e47048c9a1 100644
--- a/deal.II/doc/doxygen/headers/petsc.h
+++ b/deal.II/doc/doxygen/headers/petsc.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006, 2010 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/polynomials.h b/deal.II/doc/doxygen/headers/polynomials.h
index e56bf7a015..f98b898bfe 100644
--- a/deal.II/doc/doxygen/headers/polynomials.h
+++ b/deal.II/doc/doxygen/headers/polynomials.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005, 2006 by the deal.II authors
+// Copyright (C) 2005 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Polynomials Polynomials and polynomial spaces
diff --git a/deal.II/doc/doxygen/headers/preconditioners.h b/deal.II/doc/doxygen/headers/preconditioners.h
index 0c7c7ccae0..a40f6ccde6 100644
--- a/deal.II/doc/doxygen/headers/preconditioners.h
+++ b/deal.II/doc/doxygen/headers/preconditioners.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006, 2007, 2009, 2010 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/quadrature.h b/deal.II/doc/doxygen/headers/quadrature.h
index 5ef0b996eb..c40ac9b5f9 100644
--- a/deal.II/doc/doxygen/headers/quadrature.h
+++ b/deal.II/doc/doxygen/headers/quadrature.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2005 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Quadrature Quadrature formulas
diff --git a/deal.II/doc/doxygen/headers/slepc.h b/deal.II/doc/doxygen/headers/slepc.h
index b142d896f8..c9c227e336 100644
--- a/deal.II/doc/doxygen/headers/slepc.h
+++ b/deal.II/doc/doxygen/headers/slepc.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id: slepc.h 22855 2011-01-01 15:01:47Z young $
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2011 by the deal.II authors
+// Copyright (C) 2011 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/solvers.h b/deal.II/doc/doxygen/headers/solvers.h
index 10b8fa0761..5057d7dae9 100644
--- a/deal.II/doc/doxygen/headers/solvers.h
+++ b/deal.II/doc/doxygen/headers/solvers.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006, 2007 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 /**
  * @defgroup Solvers Linear solver classes
  *
diff --git a/deal.II/doc/doxygen/headers/std_cxx1x.h b/deal.II/doc/doxygen/headers/std_cxx1x.h
index 94333162bf..5cc44b5fc5 100644
--- a/deal.II/doc/doxygen/headers/std_cxx1x.h
+++ b/deal.II/doc/doxygen/headers/std_cxx1x.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2009 by the deal.II authors
+// Copyright (C) 2009 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * A namespace that contains a selection of classes and functions that will be part of the
diff --git a/deal.II/doc/doxygen/headers/trilinos.h b/deal.II/doc/doxygen/headers/trilinos.h
index 8c4077afe0..7f1f5724bf 100644
--- a/deal.II/doc/doxygen/headers/trilinos.h
+++ b/deal.II/doc/doxygen/headers/trilinos.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2008, 2010 by the deal.II authors
+// Copyright (C) 2008 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/tutorial.h b/deal.II/doc/doxygen/headers/tutorial.h
index e967a2c12a..0cb94932d6 100644
--- a/deal.II/doc/doxygen/headers/tutorial.h
+++ b/deal.II/doc/doxygen/headers/tutorial.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2005 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @page Tutorial Tutorial programs
diff --git a/deal.II/doc/doxygen/headers/update_flags.h b/deal.II/doc/doxygen/headers/update_flags.h
index cb63177193..c1c6893cb2 100644
--- a/deal.II/doc/doxygen/headers/update_flags.h
+++ b/deal.II/doc/doxygen/headers/update_flags.h
@@ -1,14 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006, 2007, 2012, 2013 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
 
diff --git a/deal.II/doc/doxygen/headers/utilities.h b/deal.II/doc/doxygen/headers/utilities.h
index 7ecc871bb3..3d0c87c15c 100644
--- a/deal.II/doc/doxygen/headers/utilities.h
+++ b/deal.II/doc/doxygen/headers/utilities.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup utilities Utility functions and classes
diff --git a/deal.II/doc/doxygen/headers/vector_memory.h b/deal.II/doc/doxygen/headers/vector_memory.h
index 0c65f902b1..3ab9499eed 100644
--- a/deal.II/doc/doxygen/headers/vector_memory.h
+++ b/deal.II/doc/doxygen/headers/vector_memory.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006, 2008 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/vector_valued.h b/deal.II/doc/doxygen/headers/vector_valued.h
index cd3090b848..9c24a2f7c5 100644
--- a/deal.II/doc/doxygen/headers/vector_valued.h
+++ b/deal.II/doc/doxygen/headers/vector_valued.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2008, 2011, 2012 by the deal.II authors
+// Copyright (C) 2008 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 
 /**
diff --git a/deal.II/doc/doxygen/headers/vectors.h b/deal.II/doc/doxygen/headers/vectors.h
index 24ed56085a..a82529b300 100644
--- a/deal.II/doc/doxygen/headers/vectors.h
+++ b/deal.II/doc/doxygen/headers/vectors.h
@@ -1,15 +1,19 @@
-//-------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
+// ---------------------------------------------------------------------
+// $Id$
 //
-//    Copyright (C) 2003, 2004, 2006 by the deal.II authors
+// Copyright (C) 2003 - 2013 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.
+// This file is part of the deal.II library.
 //
-//-------------------------------------------------------------------------
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
 
 /**
  * @defgroup Vectors Vector classes
diff --git a/deal.II/doc/doxygen/scripts/create_anchors b/deal.II/doc/doxygen/scripts/create_anchors
index 75fabccd19..0c1dcf57c9 100644
--- a/deal.II/doc/doxygen/scripts/create_anchors
+++ b/deal.II/doc/doxygen/scripts/create_anchors
@@ -1,15 +1,18 @@
-#---------------------------------------------------------------------------
-#    $Id: create_anchors 14782 2007-06-15 16:37:12Z kanschat $
-#    Version: $Name$
-#
-#    Copyright (C) 2007, 2012 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.
-#
-#---------------------------------------------------------------------------
+## ---------------------------------------------------------------------
+## $Id$
+##
+## Copyright (C) 2007 - 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## The deal.II library is free software; you can use it, redistribute
+## it, and/or modify it under the terms of the GNU Lesser General
+## Public License as published by the Free Software Foundation; either
+## version 2.1 of the License, or (at your option) any later version.
+## The full text of the license can be found in the file LICENSE at
+## the top level of the deal.II distribution.
+##
+## ---------------------------------------------------------------------
 
 
 # If we find a heading in a .dox file, create an HTML anchor for it.
diff --git a/deal.II/doc/doxygen/scripts/intro2toc b/deal.II/doc/doxygen/scripts/intro2toc
index 53839ab09a..0911ca1aee 100644
--- a/deal.II/doc/doxygen/scripts/intro2toc
+++ b/deal.II/doc/doxygen/scripts/intro2toc
@@ -1,15 +1,18 @@
-#---------------------------------------------------------------------------
-#    $Id: intro2toc 14782 2007-06-15 16:37:12Z kanschat $
-#    Version: $Name$
-#
-#    Copyright (C) 2006, 2007, 2008 by the deal.II authors
-#
-#    This file is subject to QPL and may not be  distributed
-#    without copyright and license information. Please refer
-#    to the file deal.II/doc/license.html for the  text  and
-#    further information on this license.
-#
-#---------------------------------------------------------------------------
+## ---------------------------------------------------------------------
+## $Id$
+##
+## Copyright (C) 2006 - 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## The deal.II library is free software; you can use it, redistribute
+## it, and/or modify it under the terms of the GNU Lesser General
+## Public License as published by the Free Software Foundation; either
+## version 2.1 of the License, or (at your option) any later version.
+## The full text of the license can be found in the file LICENSE at
+## the top level of the deal.II distribution.
+##
+## ---------------------------------------------------------------------
 
 print "    
    \n"; diff --git a/deal.II/doc/doxygen/scripts/make_step.pl b/deal.II/doc/doxygen/scripts/make_step.pl index 9c2569660e..d4a39193a8 100644 --- a/deal.II/doc/doxygen/scripts/make_step.pl +++ b/deal.II/doc/doxygen/scripts/make_step.pl @@ -1,15 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2013 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. -# -#--------------------------------------------------------------------------- +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- if ($#ARGV != 1) { print "\nUsage: make_step.pl step cmake_source_dir\n"; diff --git a/deal.II/doc/doxygen/scripts/program2doxygen b/deal.II/doc/doxygen/scripts/program2doxygen index 662bc8c749..67565a5513 100644 --- a/deal.II/doc/doxygen/scripts/program2doxygen +++ b/deal.II/doc/doxygen/scripts/program2doxygen @@ -1,16 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2006, 2007, 2010, 2013 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. -# -#--------------------------------------------------------------------------- - +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2006 - 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- print " * \n"; diff --git a/deal.II/doc/doxygen/scripts/program2doxyplain b/deal.II/doc/doxygen/scripts/program2doxyplain index 73782b71a1..2d5529ed28 100644 --- a/deal.II/doc/doxygen/scripts/program2doxyplain +++ b/deal.II/doc/doxygen/scripts/program2doxyplain @@ -1,15 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2006, 2007 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. -# -#--------------------------------------------------------------------------- +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2006 - 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- print "\n"; diff --git a/deal.II/doc/doxygen/scripts/program2html b/deal.II/doc/doxygen/scripts/program2html index f5894dc8ff..9d3083c5f5 100644 --- a/deal.II/doc/doxygen/scripts/program2html +++ b/deal.II/doc/doxygen/scripts/program2html @@ -1,15 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2006, 2007, 2010 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. -# -#--------------------------------------------------------------------------- +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2006 - 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- print "\n"; print "

    The commented program

    \n"; diff --git a/deal.II/doc/doxygen/scripts/program2plain b/deal.II/doc/doxygen/scripts/program2plain index d18bf8ca86..7e2e0f0fc5 100644 --- a/deal.II/doc/doxygen/scripts/program2plain +++ b/deal.II/doc/doxygen/scripts/program2plain @@ -1,15 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2010, 2011 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. -# -#--------------------------------------------------------------------------- +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2010 - 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- # Remove all comments from the source file diff --git a/deal.II/doc/doxygen/scripts/program2toc b/deal.II/doc/doxygen/scripts/program2toc index 8518966815..5a5927999b 100644 --- a/deal.II/doc/doxygen/scripts/program2toc +++ b/deal.II/doc/doxygen/scripts/program2toc @@ -1,15 +1,18 @@ -#--------------------------------------------------------------------------- -# $Id$ -# Version: $Name$ -# -# Copyright (C) 2006, 2007 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. -# -#--------------------------------------------------------------------------- +## --------------------------------------------------------------------- +## $Id$ +## +## Copyright (C) 2006 - 2013 by the deal.II authors +## +## This file is part of the deal.II library. +## +## The deal.II library is free software; you can use it, redistribute +## it, and/or modify it under the terms of the GNU Lesser General +## Public License as published by the Free Software Foundation; either +## version 2.1 of the License, or (at your option) any later version. +## The full text of the license can be found in the file LICENSE at +## the top level of the deal.II distribution. +## +## --------------------------------------------------------------------- print "
      \n"; diff --git a/deal.II/source/algorithms/operator.inst.in b/deal.II/source/algorithms/operator.inst.in index ba4fbd847f..f3aa5de504 100644 --- a/deal.II/source/algorithms/operator.inst.in +++ b/deal.II/source/algorithms/operator.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS) { diff --git a/deal.II/source/distributed/grid_refinement.inst.in b/deal.II/source/distributed/grid_refinement.inst.in index ab54188964..556d53ea75 100644 --- a/deal.II/source/distributed/grid_refinement.inst.in +++ b/deal.II/source/distributed/grid_refinement.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + diff --git a/deal.II/source/distributed/solution_transfer.inst.in b/deal.II/source/distributed/solution_transfer.inst.in index 70d0ef4fab..d4b2ace584 100644 --- a/deal.II/source/distributed/solution_transfer.inst.in +++ b/deal.II/source/distributed/solution_transfer.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/distributed/tria.inst.in b/deal.II/source/distributed/tria.inst.in index 9f1eae89b8..b5199699f3 100644 --- a/deal.II/source/distributed/tria.inst.in +++ b/deal.II/source/distributed/tria.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/dofs/block_info.inst.in b/deal.II/source/dofs/block_info.inst.in index 5e5b2ed571..a416b87ba8 100644 --- a/deal.II/source/dofs/block_info.inst.in +++ b/deal.II/source/dofs/block_info.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 2009 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/dofs/dof_accessor.inst.in b/deal.II/source/dofs/dof_accessor.inst.in index e433bbb599..103290a711 100644 --- a/deal.II/source/dofs/dof_accessor.inst.in +++ b/deal.II/source/dofs/dof_accessor.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // TODO: This could surely be made more systematic! diff --git a/deal.II/source/dofs/dof_handler.inst.in b/deal.II/source/dofs/dof_handler.inst.in index 9f9ccbf7ba..594bbd4c4a 100644 --- a/deal.II/source/dofs/dof_handler.inst.in +++ b/deal.II/source/dofs/dof_handler.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/dofs/dof_handler_policy.inst.in b/deal.II/source/dofs/dof_handler_policy.inst.in index dbe008f664..9b86beb03f 100644 --- a/deal.II/source/dofs/dof_handler_policy.inst.in +++ b/deal.II/source/dofs/dof_handler_policy.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/dofs/dof_objects.inst.in b/deal.II/source/dofs/dof_objects.inst.in index 08e28bcc33..5f234b43b6 100644 --- a/deal.II/source/dofs/dof_objects.inst.in +++ b/deal.II/source/dofs/dof_objects.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2006, 2010, 2011 by the deal.II authors +// Copyright (C) 2006 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/dofs/dof_renumbering.inst.in b/deal.II/source/dofs/dof_renumbering.inst.in index cfde20f725..c8c1115558 100644 --- a/deal.II/source/dofs/dof_renumbering.inst.in +++ b/deal.II/source/dofs/dof_renumbering.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/dofs/dof_tools.inst.in b/deal.II/source/dofs/dof_tools.inst.in index e8eb94087b..2f4747d6b5 100644 --- a/deal.II/source/dofs/dof_tools.inst.in +++ b/deal.II/source/dofs/dof_tools.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2009, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 2009 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe.inst.in b/deal.II/source/fe/fe.inst.in index f9ff03fcfd..f73ecc0b25 100644 --- a/deal.II/source/fe/fe.inst.in +++ b/deal.II/source/fe/fe.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_abf.inst.in b/deal.II/source/fe/fe_abf.inst.in index 39c7426305..4c3d98f38e 100644 --- a/deal.II/source/fe/fe_abf.inst.in +++ b/deal.II/source/fe/fe_abf.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_bdm.inst.in b/deal.II/source/fe/fe_bdm.inst.in index 314d27c5e9..78bf3e9d7f 100644 --- a/deal.II/source/fe/fe_bdm.inst.in +++ b/deal.II/source/fe/fe_bdm.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_dg_vector.inst.in b/deal.II/source/fe/fe_dg_vector.inst.in index 1bb7dcb6b0..8c2cba0254 100644 --- a/deal.II/source/fe/fe_dg_vector.inst.in +++ b/deal.II/source/fe/fe_dg_vector.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_dgp.inst.in b/deal.II/source/fe/fe_dgp.inst.in index e28b03e1b8..060ba1f7e4 100644 --- a/deal.II/source/fe/fe_dgp.inst.in +++ b/deal.II/source/fe/fe_dgp.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_dgp_monomial.inst.in b/deal.II/source/fe/fe_dgp_monomial.inst.in index 401fe4df15..71da79061f 100644 --- a/deal.II/source/fe/fe_dgp_monomial.inst.in +++ b/deal.II/source/fe/fe_dgp_monomial.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_dgp_nonparametric.inst.in b/deal.II/source/fe/fe_dgp_nonparametric.inst.in index 7e6cfe9486..48069e7969 100644 --- a/deal.II/source/fe/fe_dgp_nonparametric.inst.in +++ b/deal.II/source/fe/fe_dgp_nonparametric.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_dgq.inst.in b/deal.II/source/fe/fe_dgq.inst.in index ebef67e748..f9c6ccb13d 100644 --- a/deal.II/source/fe/fe_dgq.inst.in +++ b/deal.II/source/fe/fe_dgq.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_face.inst.in b/deal.II/source/fe/fe_face.inst.in index 631a8f52f6..8d99474428 100644 --- a/deal.II/source/fe/fe_face.inst.in +++ b/deal.II/source/fe/fe_face.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_nedelec.inst.in b/deal.II/source/fe/fe_nedelec.inst.in index 72a5fe8d82..62125b0440 100644 --- a/deal.II/source/fe/fe_nedelec.inst.in +++ b/deal.II/source/fe/fe_nedelec.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_nothing.inst.in b/deal.II/source/fe/fe_nothing.inst.in index b2eb93ec76..28d87008e9 100644 --- a/deal.II/source/fe/fe_nothing.inst.in +++ b/deal.II/source/fe/fe_nothing.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_poly.inst.in b/deal.II/source/fe/fe_poly.inst.in index 50ad8f5f85..5ac8c5c78c 100644 --- a/deal.II/source/fe/fe_poly.inst.in +++ b/deal.II/source/fe/fe_poly.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_poly_tensor.inst.in b/deal.II/source/fe/fe_poly_tensor.inst.in index 945f4670d7..8e44bd2903 100644 --- a/deal.II/source/fe/fe_poly_tensor.inst.in +++ b/deal.II/source/fe/fe_poly_tensor.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_q.inst.in b/deal.II/source/fe/fe_q.inst.in index 3f1dc35893..8e9d1c7356 100644 --- a/deal.II/source/fe/fe_q.inst.in +++ b/deal.II/source/fe/fe_q.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_q_base.inst.in b/deal.II/source/fe/fe_q_base.inst.in index 8d6c49215b..8a5488c479 100644 --- a/deal.II/source/fe/fe_q_base.inst.in +++ b/deal.II/source/fe/fe_q_base.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_q_dg0.inst.in b/deal.II/source/fe/fe_q_dg0.inst.in index 4f73f2c255..5cb57c5386 100644 --- a/deal.II/source/fe/fe_q_dg0.inst.in +++ b/deal.II/source/fe/fe_q_dg0.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id: fe_q.inst.in 25229 2012-03-09 18:34:59Z pauletti $ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_q_hierarchical.inst.in b/deal.II/source/fe/fe_q_hierarchical.inst.in index 0350400b9f..b1431f7f7c 100644 --- a/deal.II/source/fe/fe_q_hierarchical.inst.in +++ b/deal.II/source/fe/fe_q_hierarchical.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_q_iso_q1.inst.in b/deal.II/source/fe/fe_q_iso_q1.inst.in index 785a122589..47f935af28 100644 --- a/deal.II/source/fe/fe_q_iso_q1.inst.in +++ b/deal.II/source/fe/fe_q_iso_q1.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/fe_raviart_thomas.inst.in b/deal.II/source/fe/fe_raviart_thomas.inst.in index 46eca9e9b1..b61955369e 100644 --- a/deal.II/source/fe/fe_raviart_thomas.inst.in +++ b/deal.II/source/fe/fe_raviart_thomas.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_raviart_thomas_nodal.inst.in b/deal.II/source/fe/fe_raviart_thomas_nodal.inst.in index 951a219fe4..cd5757d9f3 100644 --- a/deal.II/source/fe/fe_raviart_thomas_nodal.inst.in +++ b/deal.II/source/fe/fe_raviart_thomas_nodal.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/fe_system.inst.in b/deal.II/source/fe/fe_system.inst.in index 5e28b445d8..75934ade41 100644 --- a/deal.II/source/fe/fe_system.inst.in +++ b/deal.II/source/fe/fe_system.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/fe/fe_tools.inst.in b/deal.II/source/fe/fe_tools.inst.in index 82fb725f88..081a327485 100644 --- a/deal.II/source/fe/fe_tools.inst.in +++ b/deal.II/source/fe/fe_tools.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; Vector : SERIAL_VECTORS) diff --git a/deal.II/source/fe/fe_values.decl.1.inst.in b/deal.II/source/fe/fe_values.decl.1.inst.in index 3ce481ba0d..e220a5e85b 100644 --- a/deal.II/source/fe/fe_values.decl.1.inst.in +++ b/deal.II/source/fe/fe_values.decl.1.inst.in @@ -1,15 +1,19 @@ -//----------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2011 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//----------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // Declarations of member functions of FEValuesBase::CellIteratorBase diff --git a/deal.II/source/fe/fe_values.decl.2.inst.in b/deal.II/source/fe/fe_values.decl.2.inst.in index ea74d7d29e..567c93f435 100644 --- a/deal.II/source/fe/fe_values.decl.2.inst.in +++ b/deal.II/source/fe/fe_values.decl.2.inst.in @@ -1,15 +1,19 @@ -//----------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//----------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // Declarations of member functions of FEValuesBase::CellIteratorBase diff --git a/deal.II/source/fe/fe_values.impl.1.inst.in b/deal.II/source/fe/fe_values.impl.1.inst.in index 2bc5e86253..3dfaaa1a9d 100644 --- a/deal.II/source/fe/fe_values.impl.1.inst.in +++ b/deal.II/source/fe/fe_values.impl.1.inst.in @@ -1,15 +1,19 @@ -//----------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//----------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS) { diff --git a/deal.II/source/fe/fe_values.impl.2.inst.in b/deal.II/source/fe/fe_values.impl.2.inst.in index 5abe9d29fd..95883209fd 100644 --- a/deal.II/source/fe/fe_values.impl.2.inst.in +++ b/deal.II/source/fe/fe_values.impl.2.inst.in @@ -1,15 +1,19 @@ -//----------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//----------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS) { diff --git a/deal.II/source/fe/fe_values.inst.in b/deal.II/source/fe/fe_values.inst.in index 8298609ef1..e63ce3fced 100644 --- a/deal.II/source/fe/fe_values.inst.in +++ b/deal.II/source/fe/fe_values.inst.in @@ -1,15 +1,19 @@ -//----------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2012, 2013 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//----------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // Instantiations of functions in FEValuesViews (explicitly write // dealii:: namespace in order to not confuse the compiler with diff --git a/deal.II/source/fe/mapping.inst.in b/deal.II/source/fe/mapping.inst.in index df9073dc3b..f0dd595bac 100644 --- a/deal.II/source/fe/mapping.inst.in +++ b/deal.II/source/fe/mapping.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + diff --git a/deal.II/source/fe/mapping_c1.inst.in b/deal.II/source/fe/mapping_c1.inst.in index 27a107a0d9..d9e830d5d0 100644 --- a/deal.II/source/fe/mapping_c1.inst.in +++ b/deal.II/source/fe/mapping_c1.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/mapping_cartesian.inst.in b/deal.II/source/fe/mapping_cartesian.inst.in index ab9c3cf951..e6f1a0e6be 100644 --- a/deal.II/source/fe/mapping_cartesian.inst.in +++ b/deal.II/source/fe/mapping_cartesian.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/fe/mapping_q.inst.in b/deal.II/source/fe/mapping_q.inst.in index c705674d50..f1ec88e76f 100644 --- a/deal.II/source/fe/mapping_q.inst.in +++ b/deal.II/source/fe/mapping_q.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + diff --git a/deal.II/source/fe/mapping_q1.inst.in b/deal.II/source/fe/mapping_q1.inst.in index a528ce957a..b4ee36efc4 100644 --- a/deal.II/source/fe/mapping_q1.inst.in +++ b/deal.II/source/fe/mapping_q1.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/fe/mapping_q1_eulerian.inst.in b/deal.II/source/fe/mapping_q1_eulerian.inst.in index e479e35903..06d1ebc290 100644 --- a/deal.II/source/fe/mapping_q1_eulerian.inst.in +++ b/deal.II/source/fe/mapping_q1_eulerian.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/fe/mapping_q_eulerian.inst.in b/deal.II/source/fe/mapping_q_eulerian.inst.in index 4bed2047f6..dd64c5497f 100644 --- a/deal.II/source/fe/mapping_q_eulerian.inst.in +++ b/deal.II/source/fe/mapping_q_eulerian.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/grid/grid_generator.inst.in b/deal.II/source/grid/grid_generator.inst.in index a579b33217..fadcea0bc7 100644 --- a/deal.II/source/grid/grid_generator.inst.in +++ b/deal.II/source/grid/grid_generator.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/grid/grid_in.inst.in b/deal.II/source/grid/grid_in.inst.in index 613147debb..ff205bac0c 100644 --- a/deal.II/source/grid/grid_in.inst.in +++ b/deal.II/source/grid/grid_in.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/grid/grid_out.inst.in b/deal.II/source/grid/grid_out.inst.in index 1a470c9a47..1da4845a0b 100644 --- a/deal.II/source/grid/grid_out.inst.in +++ b/deal.II/source/grid/grid_out.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/grid/grid_refinement.inst.in b/deal.II/source/grid/grid_refinement.inst.in index 366c0f8324..9116a20fb3 100644 --- a/deal.II/source/grid/grid_refinement.inst.in +++ b/deal.II/source/grid/grid_refinement.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2011 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + diff --git a/deal.II/source/grid/grid_tools.inst.in b/deal.II/source/grid/grid_tools.inst.in index 0a1d6e7558..9087a8e74f 100644 --- a/deal.II/source/grid/grid_tools.inst.in +++ b/deal.II/source/grid/grid_tools.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 2001 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/grid/intergrid_map.inst.in b/deal.II/source/grid/intergrid_map.inst.in index cd766fd4f4..392ba342dd 100644 --- a/deal.II/source/grid/intergrid_map.inst.in +++ b/deal.II/source/grid/intergrid_map.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (X : TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/grid/tria.inst.in b/deal.II/source/grid/tria.inst.in index 16a72fdfbe..e16829955d 100644 --- a/deal.II/source/grid/tria.inst.in +++ b/deal.II/source/grid/tria.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/grid/tria_accessor.inst.in b/deal.II/source/grid/tria_accessor.inst.in index 1aed96c4f7..fbf7755c76 100644 --- a/deal.II/source/grid/tria_accessor.inst.in +++ b/deal.II/source/grid/tria_accessor.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/grid/tria_boundary.inst.in b/deal.II/source/grid/tria_boundary.inst.in index 7d3392dd1d..3e44346c13 100644 --- a/deal.II/source/grid/tria_boundary.inst.in +++ b/deal.II/source/grid/tria_boundary.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2010 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) diff --git a/deal.II/source/grid/tria_boundary_lib.inst.in b/deal.II/source/grid/tria_boundary_lib.inst.in index e175f58d33..24af1048b7 100644 --- a/deal.II/source/grid/tria_boundary_lib.inst.in +++ b/deal.II/source/grid/tria_boundary_lib.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/grid/tria_objects.inst.in b/deal.II/source/grid/tria_objects.inst.in index 777e0ba6cb..4f8448ed55 100644 --- a/deal.II/source/grid/tria_objects.inst.in +++ b/deal.II/source/grid/tria_objects.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2006, 2007, 2010, 2012 by the deal.II authors +// Copyright (C) 2006 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/hp/dof_handler.inst.in b/deal.II/source/hp/dof_handler.inst.in index 8272116607..b83830a8b5 100644 --- a/deal.II/source/hp/dof_handler.inst.in +++ b/deal.II/source/hp/dof_handler.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/hp/fe_collection.inst.in b/deal.II/source/hp/fe_collection.inst.in index d8dabcc8bd..7b95936715 100644 --- a/deal.II/source/hp/fe_collection.inst.in +++ b/deal.II/source/hp/fe_collection.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/hp/fe_values.inst.in b/deal.II/source/hp/fe_values.inst.in index 59e2c96811..ceb33fa701 100644 --- a/deal.II/source/hp/fe_values.inst.in +++ b/deal.II/source/hp/fe_values.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/hp/mapping_collection.inst.in b/deal.II/source/hp/mapping_collection.inst.in index 43d2362466..35caaf7c17 100644 --- a/deal.II/source/hp/mapping_collection.inst.in +++ b/deal.II/source/hp/mapping_collection.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/lac/block_sparse_matrix.inst.in b/deal.II/source/lac/block_sparse_matrix.inst.in index e0e5b97008..4d9463d81c 100644 --- a/deal.II/source/lac/block_sparse_matrix.inst.in +++ b/deal.II/source/lac/block_sparse_matrix.inst.in @@ -1,3 +1,19 @@ +// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) { template class BlockSparseMatrix; diff --git a/deal.II/source/lac/block_vector.inst.in b/deal.II/source/lac/block_vector.inst.in index a2c442c7e4..cc9f945d88 100644 --- a/deal.II/source/lac/block_vector.inst.in +++ b/deal.II/source/lac/block_vector.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 2000 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/chunk_sparse_matrix.inst.in b/deal.II/source/lac/chunk_sparse_matrix.inst.in index d8a46dcf3f..9b5f64387c 100644 --- a/deal.II/source/lac/chunk_sparse_matrix.inst.in +++ b/deal.II/source/lac/chunk_sparse_matrix.inst.in @@ -1,15 +1,19 @@ -//---------------------------- sparse_matrix.inst.in --------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2006, 2007, 2008 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------- sparse_matrix.inst.in --------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // real instantiations diff --git a/deal.II/source/lac/constraint_matrix.inst.in b/deal.II/source/lac/constraint_matrix.inst.in index 9880f7044a..6320aaa188 100644 --- a/deal.II/source/lac/constraint_matrix.inst.in +++ b/deal.II/source/lac/constraint_matrix.inst.in @@ -1,3 +1,19 @@ +// --------------------------------------------------------------------- +// $Id$ +// +// Copyright (C) 2013 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S: REAL_SCALARS; T : DEAL_II_VEC_TEMPLATES) { template void ConstraintMatrix::condense >(const T &, T &) const; diff --git a/deal.II/source/lac/full_matrix.inst.in b/deal.II/source/lac/full_matrix.inst.in index d04b444c29..f902a72697 100644 --- a/deal.II/source/lac/full_matrix.inst.in +++ b/deal.II/source/lac/full_matrix.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/lapack_full_matrix.inst.in b/deal.II/source/lac/lapack_full_matrix.inst.in index ddde87b7cc..9db46db4a0 100644 --- a/deal.II/source/lac/lapack_full_matrix.inst.in +++ b/deal.II/source/lac/lapack_full_matrix.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/parallel_vector.inst.in b/deal.II/source/lac/parallel_vector.inst.in index 534d690dc1..5763c77c13 100644 --- a/deal.II/source/lac/parallel_vector.inst.in +++ b/deal.II/source/lac/parallel_vector.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2011 by the deal.II authors +// Copyright (C) 2011 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (SCALAR : REAL_SCALARS) diff --git a/deal.II/source/lac/precondition_block.inst.in b/deal.II/source/lac/precondition_block.inst.in index 0f601bcfa6..e079184b97 100644 --- a/deal.II/source/lac/precondition_block.inst.in +++ b/deal.II/source/lac/precondition_block.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2009, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/relaxation_block.inst.in b/deal.II/source/lac/relaxation_block.inst.in index aea5d8324f..b16557a2d8 100644 --- a/deal.II/source/lac/relaxation_block.inst.in +++ b/deal.II/source/lac/relaxation_block.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S1, S2 : REAL_SCALARS) diff --git a/deal.II/source/lac/solver.inst.in b/deal.II/source/lac/solver.inst.in index f01301a37e..7e158b9d2a 100644 --- a/deal.II/source/lac/solver.inst.in +++ b/deal.II/source/lac/solver.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : SERIAL_VECTORS) diff --git a/deal.II/source/lac/sparse_matrix.inst.in b/deal.II/source/lac/sparse_matrix.inst.in index 53eee70191..8905a99209 100644 --- a/deal.II/source/lac/sparse_matrix.inst.in +++ b/deal.II/source/lac/sparse_matrix.inst.in @@ -1,15 +1,19 @@ -//---------------------------- sparse_matrix.inst.in --------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2006, 2007, 2009, 2011 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------- sparse_matrix.inst.in --------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + // real instantiations diff --git a/deal.II/source/lac/sparse_matrix_ez.inst.in b/deal.II/source/lac/sparse_matrix_ez.inst.in index 1747bc210b..e0c33c4102 100644 --- a/deal.II/source/lac/sparse_matrix_ez.inst.in +++ b/deal.II/source/lac/sparse_matrix_ez.inst.in @@ -1,15 +1,19 @@ -//---------------------------- sparse_matrix_ez.inst.in --------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2002, 2003, 2006, 2007 by the deal.II authors +// Copyright (C) 2002 - 2013 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. +// This file is part of the deal.II library. // -//---------------------------- sparse_matrix_ez.inst.in --------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/trilinos_sparse_matrix.inst.in b/deal.II/source/lac/trilinos_sparse_matrix.inst.in index 32fc182ad8..c145556104 100644 --- a/deal.II/source/lac/trilinos_sparse_matrix.inst.in +++ b/deal.II/source/lac/trilinos_sparse_matrix.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (S : REAL_SCALARS) diff --git a/deal.II/source/lac/trilinos_vector_base.inst.in b/deal.II/source/lac/trilinos_vector_base.inst.in index 976e0bd070..9c4d495f91 100644 --- a/deal.II/source/lac/trilinos_vector_base.inst.in +++ b/deal.II/source/lac/trilinos_vector_base.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2008 by the deal.II authors +// Copyright (C) 2008 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (SCALAR : REAL_SCALARS) diff --git a/deal.II/source/lac/vector.inst.in b/deal.II/source/lac/vector.inst.in index 73bdab2d77..ac8514b522 100644 --- a/deal.II/source/lac/vector.inst.in +++ b/deal.II/source/lac/vector.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (SCALAR : REAL_SCALARS) diff --git a/deal.II/source/lac/vector_memory.inst.in b/deal.II/source/lac/vector_memory.inst.in index 39228c1fdd..32f15b0e4c 100644 --- a/deal.II/source/lac/vector_memory.inst.in +++ b/deal.II/source/lac/vector_memory.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VECTOR : SERIAL_VECTORS) diff --git a/deal.II/source/lac/vector_view.inst.in b/deal.II/source/lac/vector_view.inst.in index 7971632165..8475af26db 100644 --- a/deal.II/source/lac/vector_view.inst.in +++ b/deal.II/source/lac/vector_view.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 1999 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (SCALAR : REAL_SCALARS) diff --git a/deal.II/source/matrix_free/matrix_free.inst.in b/deal.II/source/matrix_free/matrix_free.inst.in index 3c2dee08e8..2b8d9aac8c 100644 --- a/deal.II/source/matrix_free/matrix_free.inst.in +++ b/deal.II/source/matrix_free/matrix_free.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/meshworker/mesh_worker_info.inst.in b/deal.II/source/meshworker/mesh_worker_info.inst.in index d0225173a2..f23c25e24f 100644 --- a/deal.II/source/meshworker/mesh_worker_info.inst.in +++ b/deal.II/source/meshworker/mesh_worker_info.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012, 2013 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/meshworker/mesh_worker_vector_selector.inst.in b/deal.II/source/meshworker/mesh_worker_vector_selector.inst.in index 3b545d35eb..797b59f8ea 100644 --- a/deal.II/source/meshworker/mesh_worker_vector_selector.inst.in +++ b/deal.II/source/meshworker/mesh_worker_vector_selector.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 2009 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/multigrid/mg_base.inst.in b/deal.II/source/multigrid/mg_base.inst.in index 6697887ffd..7446bc6e32 100644 --- a/deal.II/source/multigrid/mg_base.inst.in +++ b/deal.II/source/multigrid/mg_base.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id: vector_tools.inst.in 26105 2012-08-23 22:10:05Z heister $ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2012 by the deal.II authors +// Copyright (C) 2012 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS) { diff --git a/deal.II/source/multigrid/mg_dof_handler.inst.in b/deal.II/source/multigrid/mg_dof_handler.inst.in index 8ae02f0e91..52779b60d5 100644 --- a/deal.II/source/multigrid/mg_dof_handler.inst.in +++ b/deal.II/source/multigrid/mg_dof_handler.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/multigrid/mg_tools.inst.in b/deal.II/source/multigrid/mg_tools.inst.in index 2b9be32ad2..8d4a68359b 100644 --- a/deal.II/source/multigrid/mg_tools.inst.in +++ b/deal.II/source/multigrid/mg_tools.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (PATTERN : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS; diff --git a/deal.II/source/multigrid/mg_transfer_block.inst.in b/deal.II/source/multigrid/mg_transfer_block.inst.in index 466aac4c48..6bff38e9f7 100644 --- a/deal.II/source/multigrid/mg_transfer_block.inst.in +++ b/deal.II/source/multigrid/mg_transfer_block.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/multigrid/mg_transfer_component.inst.in b/deal.II/source/multigrid/mg_transfer_component.inst.in index 272f78d852..6c53ccb816 100644 --- a/deal.II/source/multigrid/mg_transfer_component.inst.in +++ b/deal.II/source/multigrid/mg_transfer_component.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in b/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in index 47e315f225..c72b279ae0 100644 --- a/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in +++ b/deal.II/source/multigrid/mg_transfer_prebuilt.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (V1 : VECTORS_WITH_MATRIX) diff --git a/deal.II/source/multigrid/multigrid.inst.in b/deal.II/source/multigrid/multigrid.inst.in index 9623c2413a..f74b685f14 100644 --- a/deal.II/source/multigrid/multigrid.inst.in +++ b/deal.II/source/multigrid/multigrid.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id: vector_tools.inst.in 26105 2012-08-23 22:10:05Z heister $ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2012 by the deal.II authors +// Copyright (C) 2012 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS) { diff --git a/deal.II/source/numerics/data_out.inst.in b/deal.II/source/numerics/data_out.inst.in index b084eabe27..55fc701433 100644 --- a/deal.II/source/numerics/data_out.inst.in +++ b/deal.II/source/numerics/data_out.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS; DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/data_out_faces.inst.in b/deal.II/source/numerics/data_out_faces.inst.in index f33ccf0591..84516e4da6 100644 --- a/deal.II/source/numerics/data_out_faces.inst.in +++ b/deal.II/source/numerics/data_out_faces.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/data_out_rotation.inst.in b/deal.II/source/numerics/data_out_rotation.inst.in index 95bbbea204..a44a7c69f8 100644 --- a/deal.II/source/numerics/data_out_rotation.inst.in +++ b/deal.II/source/numerics/data_out_rotation.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/data_out_stack.inst.in b/deal.II/source/numerics/data_out_stack.inst.in index 2c77b5ff57..67a6ccc773 100644 --- a/deal.II/source/numerics/data_out_stack.inst.in +++ b/deal.II/source/numerics/data_out_stack.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/data_postprocessor.inst.in b/deal.II/source/numerics/data_postprocessor.inst.in index 601653a179..b170d35b3b 100644 --- a/deal.II/source/numerics/data_postprocessor.inst.in +++ b/deal.II/source/numerics/data_postprocessor.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/derivative_approximation.inst.in b/deal.II/source/numerics/derivative_approximation.inst.in index 8abdb2bde7..6e7ed876ab 100644 --- a/deal.II/source/numerics/derivative_approximation.inst.in +++ b/deal.II/source/numerics/derivative_approximation.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS ; VEC : SERIAL_VECTORS ; DH : DOFHANDLER_TEMPLATES) { diff --git a/deal.II/source/numerics/dof_output_operator.inst.in b/deal.II/source/numerics/dof_output_operator.inst.in index 2f28e5e08b..5aeafb7734 100644 --- a/deal.II/source/numerics/dof_output_operator.inst.in +++ b/deal.II/source/numerics/dof_output_operator.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/error_estimator.inst.in b/deal.II/source/numerics/error_estimator.inst.in index 7b701a6992..34b06e672b 100644 --- a/deal.II/source/numerics/error_estimator.inst.in +++ b/deal.II/source/numerics/error_estimator.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/numerics/fe_field_function.inst.in b/deal.II/source/numerics/fe_field_function.inst.in index 1a8f3c9e6b..e124e5cce3 100644 --- a/deal.II/source/numerics/fe_field_function.inst.in +++ b/deal.II/source/numerics/fe_field_function.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2007, 2008, 2009, 2012 by the deal.II authors +// Copyright (C) 2007 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VECTOR : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/numerics/matrix_tools.inst.in b/deal.II/source/numerics/matrix_tools.inst.in index 9b37200449..2f97b2a818 100644 --- a/deal.II/source/numerics/matrix_tools.inst.in +++ b/deal.II/source/numerics/matrix_tools.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2010, 2012 by the deal.II authors +// Copyright (C) 2010 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension <= deal_II_space_dimension diff --git a/deal.II/source/numerics/point_value_history.inst.in b/deal.II/source/numerics/point_value_history.inst.in index e175ccbb23..c3ae1f0896 100644 --- a/deal.II/source/numerics/point_value_history.inst.in +++ b/deal.II/source/numerics/point_value_history.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 2009 by Michael Rapson and the deal.II authors +// Copyright (C) 2009 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) diff --git a/deal.II/source/numerics/solution_transfer.inst.in b/deal.II/source/numerics/solution_transfer.inst.in index 5d8ec479d6..fe64874d34 100644 --- a/deal.II/source/numerics/solution_transfer.inst.in +++ b/deal.II/source/numerics/solution_transfer.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/deal.II/source/numerics/time_dependent.inst.in b/deal.II/source/numerics/time_dependent.inst.in index 863f5d5524..b851acc61c 100644 --- a/deal.II/source/numerics/time_dependent.inst.in +++ b/deal.II/source/numerics/time_dependent.inst.in @@ -1,15 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2011, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (deal_II_dimension : DIMENSIONS) { diff --git a/deal.II/source/numerics/vector_tools.inst.in b/deal.II/source/numerics/vector_tools.inst.in index 6d0e6054de..a1031c5958 100644 --- a/deal.II/source/numerics/vector_tools.inst.in +++ b/deal.II/source/numerics/vector_tools.inst.in @@ -1,14 +1,19 @@ -//--------------------------------------------------------------------------- -// $Id$ +// --------------------------------------------------------------------- +// $Id$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2011, 2012 by the deal.II authors +// Copyright (C) 1998 - 2013 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. +// This file is part of the deal.II library. // -//--------------------------------------------------------------------------- +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { diff --git a/tests/lib/test_grids.h b/tests/lib/test_grids.h index 36abbbb597..0d6deed02b 100644 --- a/tests/lib/test_grids.h +++ b/tests/lib/test_grids.h @@ -13,18 +13,6 @@ // the top level of the deal.II distribution. // // --------------------------------------------------------------------- -//---------------------------------------------------------------------- -// $Id$ -// Version: $Name$ -// -// Copyright (C) 2006, 2010 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. -// -//---------------------------------------------------------------------- #include #include -- 2.39.5