]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update license file in copyright header ./source
authorMatthias Maier <tamiko@43-1.org>
Wed, 6 Jun 2018 15:53:59 +0000 (10:53 -0500)
committerMatthias Maier <tamiko@43-1.org>
Wed, 6 Jun 2018 17:00:29 +0000 (12:00 -0500)
505 files changed:
source/CMakeLists.txt
source/algorithms/CMakeLists.txt
source/algorithms/operator.cc
source/algorithms/operator.inst.in
source/algorithms/timestep_control.cc
source/base/CMakeLists.txt
source/base/auto_derivative_function.cc
source/base/bounding_box.cc
source/base/bounding_box.inst.in
source/base/conditional_ostream.cc
source/base/config.cc
source/base/convergence_table.cc
source/base/cuda.cu
source/base/data_out_base.cc
source/base/data_out_base.inst.in
source/base/event.cc
source/base/exceptions.cc
source/base/flow_function.cc
source/base/function.cc
source/base/function.inst.in
source/base/function_cspline.cc
source/base/function_derivative.cc
source/base/function_lib.cc
source/base/function_lib_cutoff.cc
source/base/function_parser.cc
source/base/function_spherical.cc
source/base/function_time.cc
source/base/function_time.inst.in
source/base/geometric_utilities.cc
source/base/geometric_utilities.inst.in
source/base/geometry_info.cc
source/base/graph_coloring.cc
source/base/index_set.cc
source/base/job_identifier.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/mpi.inst.in
source/base/multithread_info.cc
source/base/named_selection.cc
source/base/parallel.cc
source/base/parameter_acceptor.cc
source/base/parameter_handler.cc
source/base/parsed_function.cc
source/base/partitioner.cc
source/base/partitioner.inst.in
source/base/path_search.cc
source/base/patterns.cc
source/base/polynomial.cc
source/base/polynomial_space.cc
source/base/polynomials_abf.cc
source/base/polynomials_adini.cc
source/base/polynomials_bdm.cc
source/base/polynomials_bernstein.cc
source/base/polynomials_integrated_legendre_sz.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_p.cc
source/base/polynomials_piecewise.cc
source/base/polynomials_rannacher_turek.cc
source/base/polynomials_rannacher_turek.inst.in
source/base/polynomials_raviart_thomas.cc
source/base/polynomials_rt_bubbles.cc
source/base/process_grid.cc
source/base/quadrature.cc
source/base/quadrature_lib.cc
source/base/quadrature_selector.cc
source/base/subscriptor.cc
source/base/symmetric_tensor.cc
source/base/symmetric_tensor.inst.in
source/base/table_handler.cc
source/base/tensor.cc
source/base/tensor.inst.in
source/base/tensor_function.cc
source/base/tensor_function.inst.in
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/base/thread_management.cc
source/base/time_stepping.cc
source/base/time_stepping.inst.in
source/base/timer.cc
source/base/utilities.cc
source/differentiation/CMakeLists.txt
source/differentiation/ad/CMakeLists.txt
source/differentiation/ad/adolc_number_types.cc
source/differentiation/ad/adolc_number_types.inst.in
source/differentiation/ad/sacado_number_types.cc
source/differentiation/ad/sacado_number_types.inst1.in
source/differentiation/ad/sacado_number_types.inst2.in
source/distributed/CMakeLists.txt
source/distributed/grid_refinement.cc
source/distributed/grid_refinement.inst.in
source/distributed/p4est_wrappers.inst.in
source/distributed/shared_tria.cc
source/distributed/shared_tria.inst.in
source/distributed/solution_transfer.cc
source/distributed/solution_transfer.inst.in
source/distributed/tria.cc
source/distributed/tria.inst.in
source/distributed/tria_base.cc
source/distributed/tria_base.inst.in
source/dofs/CMakeLists.txt
source/dofs/block_info.cc
source/dofs/block_info.inst.in
source/dofs/dof_accessor.cc
source/dofs/dof_accessor.inst.in
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_get.inst.in
source/dofs/dof_accessor_set.cc
source/dofs/dof_accessor_set.inst.in
source/dofs/dof_faces.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_handler_policy.inst.in
source/dofs/dof_objects.cc
source/dofs/dof_objects.inst.in
source/dofs/dof_renumbering.cc
source/dofs/dof_renumbering.inst.in
source/dofs/dof_tools.cc
source/dofs/dof_tools.inst.in
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_constraints.inst.in
source/dofs/dof_tools_sparsity.cc
source/dofs/dof_tools_sparsity.inst.in
source/dofs/number_cache.cc
source/dummy.cc
source/fe/CMakeLists.txt
source/fe/block_mask.cc
source/fe/component_mask.cc
source/fe/fe.cc
source/fe/fe.inst.in
source/fe/fe_abf.cc
source/fe/fe_abf.inst.in
source/fe/fe_bdm.cc
source/fe/fe_bdm.inst.in
source/fe/fe_bernstein.cc
source/fe/fe_bernstein.inst.in
source/fe/fe_data.cc
source/fe/fe_dg_vector.cc
source/fe/fe_dg_vector.inst.in
source/fe/fe_dgp.cc
source/fe/fe_dgp.inst.in
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_monomial.inst.in
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgp_nonparametric.inst.in
source/fe/fe_dgq.cc
source/fe/fe_dgq.inst.in
source/fe/fe_enriched.cc
source/fe/fe_enriched.inst.in
source/fe/fe_face.cc
source/fe/fe_face.inst.in
source/fe/fe_nedelec.cc
source/fe/fe_nedelec.inst.in
source/fe/fe_nedelec_sz.cc
source/fe/fe_nedelec_sz.inst.in
source/fe/fe_nothing.cc
source/fe/fe_nothing.inst.in
source/fe/fe_p1nc.cc
source/fe/fe_poly.cc
source/fe/fe_poly.inst.in
source/fe/fe_poly_tensor.cc
source/fe/fe_poly_tensor.inst.in
source/fe/fe_q.cc
source/fe/fe_q.inst.in
source/fe/fe_q_base.cc
source/fe/fe_q_base.inst.in
source/fe/fe_q_bubbles.cc
source/fe/fe_q_bubbles.inst.in
source/fe/fe_q_dg0.cc
source/fe/fe_q_dg0.inst.in
source/fe/fe_q_hierarchical.cc
source/fe/fe_q_hierarchical.inst.in
source/fe/fe_q_iso_q1.cc
source/fe/fe_q_iso_q1.inst.in
source/fe/fe_rannacher_turek.cc
source/fe/fe_rannacher_turek.inst.in
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas.inst.in
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_raviart_thomas_nodal.inst.in
source/fe/fe_rt_bubbles.cc
source/fe/fe_rt_bubbles.inst.in
source/fe/fe_series.cc
source/fe/fe_system.cc
source/fe/fe_system.inst.in
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in
source/fe/fe_tools_extrapolate.cc
source/fe/fe_tools_extrapolate.inst.in
source/fe/fe_tools_interpolate.cc
source/fe/fe_tools_interpolate.inst.in
source/fe/fe_trace.cc
source/fe/fe_trace.inst.in
source/fe/fe_values.cc
source/fe/fe_values.decl.1.inst.in
source/fe/fe_values.decl.2.inst.in
source/fe/fe_values.impl.1.inst.in
source/fe/fe_values.impl.2.inst.in
source/fe/fe_values.inst.in
source/fe/fe_values_inst2.cc
source/fe/fe_values_inst3.cc
source/fe/fe_values_inst4.cc
source/fe/fe_values_inst5.cc
source/fe/fe_values_inst6.cc
source/fe/mapping.cc
source/fe/mapping.inst.in
source/fe/mapping_c1.cc
source/fe/mapping_c1.inst.in
source/fe/mapping_cartesian.cc
source/fe/mapping_cartesian.inst.in
source/fe/mapping_fe_field.cc
source/fe/mapping_fe_field.inst.in
source/fe/mapping_fe_field_inst2.cc
source/fe/mapping_manifold.cc
source/fe/mapping_manifold.inst.in
source/fe/mapping_q.cc
source/fe/mapping_q.inst.in
source/fe/mapping_q1.cc
source/fe/mapping_q1.inst.in
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q1_eulerian.inst.in
source/fe/mapping_q_eulerian.cc
source/fe/mapping_q_eulerian.inst.in
source/fe/mapping_q_generic.cc
source/fe/mapping_q_generic.inst.in
source/gmsh/CMakeLists.txt
source/gmsh/utilities.cc
source/gmsh/utilities.inst.in
source/grid/CMakeLists.txt
source/grid/cell_id.cc
source/grid/cell_id.inst.in
source/grid/grid_generator.cc
source/grid/grid_generator.inst.in
source/grid/grid_in.cc
source/grid/grid_in.inst.in
source/grid/grid_out.cc
source/grid/grid_out.inst.in
source/grid/grid_refinement.cc
source/grid/grid_refinement.inst.in
source/grid/grid_reordering.cc
source/grid/grid_tools.cc
source/grid/grid_tools.inst.in
source/grid/grid_tools_cache.cc
source/grid/grid_tools_cache.inst.in
source/grid/grid_tools_dof_handlers.cc
source/grid/intergrid_map.cc
source/grid/intergrid_map.inst.in
source/grid/manifold.cc
source/grid/manifold.inst.in
source/grid/manifold_lib.cc
source/grid/manifold_lib.inst.in
source/grid/persistent_tria.cc
source/grid/tria.cc
source/grid/tria.inst.in
source/grid/tria_accessor.cc
source/grid/tria_accessor.inst.in
source/grid/tria_faces.cc
source/grid/tria_levels.cc
source/grid/tria_objects.cc
source/grid/tria_objects.inst.in
source/hp/CMakeLists.txt
source/hp/dof_faces.cc
source/hp/dof_handler.cc
source/hp/dof_handler.inst.in
source/hp/dof_level.cc
source/hp/fe_collection.cc
source/hp/fe_collection.inst.in
source/hp/fe_values.cc
source/hp/fe_values.inst.in
source/hp/mapping_collection.cc
source/hp/mapping_collection.inst.in
source/integrators/CMakeLists.txt
source/lac/CMakeLists.txt
source/lac/affine_constraints.cc
source/lac/affine_constraints.inst.in
source/lac/block_matrix_array.cc
source/lac/block_sparse_matrix.cc
source/lac/block_sparse_matrix.inst.in
source/lac/block_sparse_matrix_ez.cc
source/lac/block_sparsity_pattern.cc
source/lac/block_vector.cc
source/lac/block_vector.inst.in
source/lac/chunk_sparse_matrix.cc
source/lac/chunk_sparse_matrix.inst.in
source/lac/chunk_sparsity_pattern.cc
source/lac/cuda_solver_direct.cu
source/lac/cuda_sparse_matrix.cu
source/lac/cuda_vector.cu
source/lac/dynamic_sparsity_pattern.cc
source/lac/exceptions.cc
source/lac/full_matrix.cc
source/lac/full_matrix.inst.in
source/lac/la_parallel_block_vector.cc
source/lac/la_parallel_block_vector.inst.in
source/lac/la_parallel_vector.cc
source/lac/la_parallel_vector.inst.in
source/lac/la_vector.cc
source/lac/la_vector.inst.in
source/lac/lapack_full_matrix.cc
source/lac/lapack_full_matrix.inst.in
source/lac/matrix_lib.cc
source/lac/matrix_out.cc
source/lac/petsc_full_matrix.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_matrix_free.cc
source/lac/petsc_parallel_block_sparse_matrix.cc
source/lac/petsc_parallel_block_vector.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/petsc_sparse_matrix.cc
source/lac/petsc_vector_base.cc
source/lac/precondition_block.cc
source/lac/precondition_block.inst.in
source/lac/precondition_block_ez.cc
source/lac/read_write_vector.cc
source/lac/read_write_vector.inst.in
source/lac/relaxation_block.cc
source/lac/relaxation_block.inst.in
source/lac/scalapack.cc
source/lac/scalapack.inst.in
source/lac/slepc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/solver.cc
source/lac/solver.inst.in
source/lac/solver_bicgstab.cc
source/lac/solver_control.cc
source/lac/sparse_decomposition.cc
source/lac/sparse_direct.cc
source/lac/sparse_ilu.cc
source/lac/sparse_matrix.cc
source/lac/sparse_matrix.inst.in
source/lac/sparse_matrix_ez.cc
source/lac/sparse_matrix_ez.inst.in
source/lac/sparse_matrix_inst2.cc
source/lac/sparse_mic.cc
source/lac/sparse_vanka.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/swappable_vector.cc
source/lac/tridiagonal_matrix.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_block_vector.cc
source/lac/trilinos_epetra_communication_pattern.cc
source/lac/trilinos_epetra_vector.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparse_matrix.inst.in
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/trilinos_vector.inst.in
source/lac/vector.cc
source/lac/vector.inst.in
source/lac/vector_memory.cc
source/lac/vector_memory.inst.in
source/lac/vector_memory_release.inst.in
source/lac/vector_view.cc
source/lac/vector_view.inst.in
source/matrix_free/CMakeLists.txt
source/matrix_free/cuda_matrix_free.cu
source/matrix_free/cuda_matrix_free.inst.in
source/matrix_free/evaluation_selector.cc
source/matrix_free/evaluation_selector.inst.in
source/matrix_free/mapping_info.cc
source/matrix_free/mapping_info.inst.in
source/matrix_free/matrix_free.cc
source/matrix_free/matrix_free.inst.in
source/matrix_free/task_info.cc
source/meshworker/CMakeLists.txt
source/meshworker/mesh_worker.cc
source/meshworker/mesh_worker_info.cc
source/meshworker/mesh_worker_info.inst.in
source/meshworker/mesh_worker_vector_selector.cc
source/meshworker/mesh_worker_vector_selector.inst.in
source/multigrid/CMakeLists.txt
source/multigrid/mg_base.cc
source/multigrid/mg_base.inst.in
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_level_global_transfer.inst.in
source/multigrid/mg_tools.cc
source/multigrid/mg_tools.inst.in
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_block.inst.in
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_component.inst.in
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_internal.inst.in
source/multigrid/mg_transfer_matrix_free.cc
source/multigrid/mg_transfer_matrix_free.inst.in
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
source/multigrid/multigrid.cc
source/multigrid/multigrid.inst.in
source/non_matching/CMakeLists.txt
source/non_matching/coupling.cc
source/non_matching/coupling.inst.in
source/non_matching/immersed_surface_quadrature.cc
source/numerics/CMakeLists.txt
source/numerics/data_out.cc
source/numerics/data_out.inst.in
source/numerics/data_out_dof_data.cc
source/numerics/data_out_dof_data.inst.in
source/numerics/data_out_dof_data_codim.cc
source/numerics/data_out_dof_data_codim.inst.in
source/numerics/data_out_dof_data_inst2.cc
source/numerics/data_out_faces.cc
source/numerics/data_out_faces.inst.in
source/numerics/data_out_rotation.cc
source/numerics/data_out_rotation.inst.in
source/numerics/data_out_stack.cc
source/numerics/data_out_stack.inst.in
source/numerics/data_postprocessor.cc
source/numerics/data_postprocessor.inst.in
source/numerics/derivative_approximation.cc
source/numerics/derivative_approximation.inst.in
source/numerics/dof_output_operator.cc
source/numerics/dof_output_operator.inst.in
source/numerics/error_estimator.cc
source/numerics/error_estimator.inst.in
source/numerics/error_estimator_1d.cc
source/numerics/error_estimator_1d.inst.in
source/numerics/error_estimator_inst2.cc
source/numerics/fe_field_function.cc
source/numerics/fe_field_function.inst.in
source/numerics/histogram.cc
source/numerics/matrix_creator.cc
source/numerics/matrix_creator.inst.in
source/numerics/matrix_creator_inst2.cc
source/numerics/matrix_creator_inst3.cc
source/numerics/matrix_tools.cc
source/numerics/matrix_tools.inst.in
source/numerics/matrix_tools_once.cc
source/numerics/point_value_history.cc
source/numerics/point_value_history.inst.in
source/numerics/solution_transfer.cc
source/numerics/solution_transfer.inst.in
source/numerics/solution_transfer_inst2.cc
source/numerics/solution_transfer_inst3.cc
source/numerics/solution_transfer_inst4.cc
source/numerics/time_dependent.cc
source/numerics/time_dependent.inst.in
source/numerics/vector_tools_boundary.cc
source/numerics/vector_tools_boundary.inst.in
source/numerics/vector_tools_constraints.cc
source/numerics/vector_tools_constraints.inst.in
source/numerics/vector_tools_integrate_difference.cc
source/numerics/vector_tools_integrate_difference.inst.in
source/numerics/vector_tools_interpolate.cc
source/numerics/vector_tools_interpolate.inst.in
source/numerics/vector_tools_mean_value.cc
source/numerics/vector_tools_mean_value.inst.in
source/numerics/vector_tools_point_gradient.cc
source/numerics/vector_tools_point_gradient.inst.in
source/numerics/vector_tools_point_value.cc
source/numerics/vector_tools_point_value.inst.in
source/numerics/vector_tools_project.cc
source/numerics/vector_tools_project.inst.in
source/numerics/vector_tools_project_codim.cc
source/numerics/vector_tools_project_codim.inst.in
source/numerics/vector_tools_project_hp.cc
source/numerics/vector_tools_project_hp.inst.in
source/numerics/vector_tools_project_inst2.cc
source/numerics/vector_tools_project_inst3.cc
source/numerics/vector_tools_project_qp.cc
source/numerics/vector_tools_project_qp.inst.in
source/numerics/vector_tools_project_qpmf.cc
source/numerics/vector_tools_project_qpmf.inst.in
source/numerics/vector_tools_rhs.cc
source/numerics/vector_tools_rhs.inst.in
source/opencascade/CMakeLists.txt
source/opencascade/boundary_lib.cc
source/opencascade/boundary_lib.inst.in
source/opencascade/manifold_lib.cc
source/opencascade/manifold_lib.inst.in
source/opencascade/utilities.cc
source/opencascade/utilities.inst.in
source/optimization/rol/CMakeLists.txt
source/particles/CMakeLists.txt
source/particles/particle.cc
source/particles/particle.inst.in
source/particles/particle_accessor.cc
source/particles/particle_accessor.inst.in
source/particles/particle_handler.cc
source/particles/particle_handler.inst.in
source/particles/particle_iterator.cc
source/particles/particle_iterator.inst.in
source/particles/property_pool.cc
source/physics/CMakeLists.txt
source/physics/elasticity/CMakeLists.txt
source/physics/elasticity/kinematics.cc
source/physics/elasticity/kinematics.inst.in
source/physics/elasticity/standard_tensors.cc
source/physics/elasticity/standard_tensors.inst.in
source/physics/transformations.cc
source/physics/transformations.inst.in
source/sundials/CMakeLists.txt
source/sundials/arkode.cc
source/sundials/copy.cc
source/sundials/ida.cc
source/sundials/kinsol.cc

index 7cf7aa4c7a13329b14693fc305d9e9590b7687f5..c79c40e1806cd14a436628260ff2c88e3c47ae2d 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 8e5c633da04d02ea02fa919b450d1a1eade23958..2eb6e268dbcc1a7337d97de4a9ce492b7fd9f7ea 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index f34009b31505d9901f9c463330fff6de088f64e5..715ce2b508460769cf7c7e3e90dde18d69b04041 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9b08ee9905459d867b5ed05534dd705fe1445038..260672c1710532b2100c63563ec3fd3c62ae8139 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b006fe2bc2540be4554c7895802c37f934cc588c..20d7113caeb303840d5543e7019ac8e9a5153503 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a95b341c0d89f7e2a7cd8ab2ea2fa7f52dd7d6e7..20c544892c2a631a41aed6273acae79b8264199f 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index a233aa771ed962b42604d6b48ddd6bb4ae2308c8..76baae3015f1d1323ea182efab608ad9666b8059 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0f840ac21fc9dc8db2672d9cc6ace111bfdd6d95..0aecd537f4636a9abd704b4f35dfe93f12f285ed 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 #include <deal.II/base/bounding_box.h>
index beeca0ea6b3f901f36b992c39ce766bb61e51bf9..2f6de01bc985bb3343f62c5afb013040a6825b7a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fdb27729ec2869fe31e6d8362f34883ec6bdd982..1bbde98ab0ab9dedef86e3089ac7f9965ba50926 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9a8ea36e47fa8cc2407eb5676edc6186d8aa7dc4..f19d115fa55a9edabfcab7a07630e2171286d74b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 145677f30ebd313769908b93a3c647b6a667b380..0d57f0c8a73ad3cb6cc3c145d2927950cd409a05 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0493da8c4c2eb6c0954f9422b9791bc4aa587089..ac746b62e210b56998eb1673ed96ad39866708ac 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 920daa5bb412cfeeed071ea26a30c7aa5dfcdf48..8f6d440772e41b6527cd7c7c6f7ee24b322b0803 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c137eaddf9f75393e1ea6316a4a1079a1769b25b..718d6123c077af473ea57791d9bc277e2f1822d1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c1fe05fa6245bdb99ba4f08fd83eb4f00db25fdb..efd0663ef08c03b5f85389201274c2f602ae845c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7da9b7d167d2aba12b2cd33992912dfc1e89dc29..69b2e5d2c7162b9848f2d61474d7c744fe998084 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c6d2f1d5c788c00a398d9062dcc9c88a87c09604..dbef91fb8cc93e45edb4aa7fa3706ce53f78bbd8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ffe3fb2eccee87033e67d3df1c7f845d7942d6ac..05e3028eb03c417d66ee4846439159106e6b3880 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bc688b74cf486026e85187404178330f37424fdb..3efdc972bf846ca904dda1ea9f635009d4ee5831 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8bb3d17fdfc7f9e17a026dabcd1bb3da3d8e9379..affbc699749ce25f2a935aeb022a9ed3bef0274a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4113dc83faf025916005230508b5638ea56b34df..9c3605bd3da5bc39b4710b862cb6240851f99be1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 115401afc450254ec7f46d871b0506aedbf3e296..fa4c2b47b9467ff6ce3f5c20afa8560b3b533c04 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 97d2b4265a682351e53afbfadc3059835f257067..d4cacab11f23f9494c7472b51f57c60eec72bcc2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9093c0cb08c69a5196d37d891201237c081cd40a..cf143b97abd4f77dc2c9690345ba3dd47c61ead4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0f643cff4f94f2bf85b19771ee0df00d6c32031b..23d8ce06121538e98e50d8980c49b4e457d8e9a5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 617a6e630384c241af4e6b9a9872f569539c23ef..0ff1a504f4d8b91963027456d4a50ae37d8537eb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6059e5c4163301d8f4a127097edba0cbab70bea5..3f2eb24024339bdf72b7b2873bfbb5580766899b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d9fa11421cdb11ace5d3875aa26dd0df7aac9c0d..72d976cec982414746a7d8895e60a4f8dbf46cdc 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b405bfbd23531eba52ba046ca67fcfc02821bfe1..01b8d7524b521ad6d775c90533208a860eef89c9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 46f9b3658c5c233eedf744d49a9f827325718e43..e2578d83a11d5582a521e97ee99d1a42c73fe15c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c9b7520c910a322091ab20d7cdadda2d11cdfea7..52745b037988c9e72669a47986cf5ed7a3dd3fba 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b5d3e5c993a575aff991e23152fd34dc1cb5168b..c37c65ecc9a535131f020f937c4552f0f7afa053 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bb479916281b0adca5a6ceca68c4384145c4e384..e7fc49573f33115b31be3daa03a3d486c7f506f4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9ffbbc93c63ad18cf1e537aad663356fae86b37d..e10858c292ce6ab5227c1d483c01ede83ceb00ed 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1d814137bce7e6dc8a6587de863f21f40fcb7cde..ec3ed8a8a99ac793fd01a0bd5ab686b422de7a6d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 26b26fe852c03dcfb77805096144bc60b200694f..e0bfc3d3fef4074e2585dd7ab5d65787adecf540 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d430ad285749447a0f135884b67c16dd09d021a6..a921e982fae80cc3186a5c3d86f8e94135ad712e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 79a758d949d27fcbeda856a843f2c62df34b8018..d9a00d88e43da5247c7d266e81be04329fb1267a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2d6b67791042a0ba1e52b5ade0df21601918c0e9..a11cfc4183591c0d35b386d9c5a14196d6e7762c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 410852e7fda9aba456e246cd4eb20a5f1767e9a7..03e220c68b25be27d7f60ab5dbd76462c0d846c5 100644 (file)
@@ -8,8 +8,8 @@
 //    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.
+//    The full text of the license can be found in the file LICENSE.md at
+//    the top level directory of deal.II.
 //
 //-----------------------------------------------------------
 
index 80d5fe8c574bfeb1f0a135b6d8c7f9225d24b9d9..f7485d11166d1558e7f61d0f2369254c7c75eb11 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4c7585c0c4aaa9e6ec16839323e28dd15078e187..27ffb81725d991bbe69cfaa90dbe6533cf037da3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bc90d123f58ca5ff261ea50fc000c4f07d189afd..9024873cd3630fa5fe144e3239fd227ea1890341 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0497a218fdf7e822740ed045d7a9af89d41389ec..6d126912280d2b10bcac26da08e2ebc3222f0505 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9cfabeabc1c4935fcdd75de8a080c2c6441903f6..59fe396e694b776e28fd4649315b9be92d6780fc 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1e09b7e6fdaa2cff1b985a5edf4948f3aaca7a02..0ace857cd140e39e7094ea5faaee9d5ec1a77055 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 604c22bda0fa2bf34a9116d0815aca8146e4ba21..4fb96a4943843201c90b1ef57f64e1c8145d140d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 262efebd8ebeed0bd7a9531c12e47b520440f2b0..0680f6e79736821bded5c71d08fc169e9b1ccd69 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4711dc9e0dadecda5f5dfd0032496b41610e4482..b5c486f71794eede1a6eca4fd2d1093cff4f0fe4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a79c965b6d31a26fb9b6dfdee1ab6193e2f11ef6..2e26621356469ed2cca2854f6e6ad206a206e3e2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f0dbe8beec6af568b65e8013a8b121db59756182..99d51454b732b4e4845908a6fc6b6f64e7debbf2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f83267e41069248a3dbe65123dbf50eaf15a85f6..3cb0f88ed67da7aa0b0dd22106e5bf4deb39fd03 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8fdc167efc2dc6a3e8f9ff574629511d3b1c2577..695dbbd8f8892ae11dfd65d17e28a9f4a94ff5f5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7d6cfd2c5c3ef392b91147fc03ad5a5f8716218f..76b5d74374ffec79adbb8f2cb472fae550d261b6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 66916a0c5fdc0650bf6d598b792bbc66a5a229f8..e23bd2291b35b524b4a8a2eb64c109833c45d002 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ef2ddd03a64e201699c3ff3040d0c8df4531bd86..7f050c59dcd112fe5f90736b31c4059768ebd058 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d9cdc6129c55a35132199be3034acfc5852d20fd..ca5ca128bf6f0339be51e26f4eedaa7df0ce2114 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 14e4ac3ade24c37b4fe0a7cfef65852e2de18442..58d0fe9d6b63c6475d7325f05417bbaae9551074 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 081a51053d339fe1745e2a43e360fcba0a0c8226..c7525d98a3945eb51a435ece8fa119250717c08e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9563243780dbbc252832a64027d52eaebf71cb99..2cb1ea017adc19a6361a5d75fbf2fe8fb26b0895 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 96670bff07ad9b7daa5bfc870a9d4f3a038a5e85..26c505c9b7692400beb442608f02c7716bfbae23 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0e0bb3bae14c2c9741a875f442fc31370f313880..492849764415e2eb17370a0e42bb7e06d925dbbf 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b617efd7988522fe0487ebd9077b85842ceb8550..78c2056d33d31962def85a1d3fb8e933e0c9fc3c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 14719335a78f7510f1a97f795539b77d78bbccbb..df6c3f122295ed7bc8690a358151cf1b1f95219c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 248d6e17989ac53d8b205640b5aa1be83f9de858..b54565f65f0ad8cda9897620beed549742762cf5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bf74f26e323ea1a44138215eb8ff817c358f03c7..1d767f817cd5db6b40426d8ffafdb826c937f030 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fbb9d786762183b0268a3ff26f6cdc76af13e813..1729ec17b08b559245239a33da73202599a2ca70 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1d48a44cb3227a55976dd5161771e5f6877ca474..2ec27b19024dd743c36657bde4f7ab291a99feb2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5b43033596f90b0b99ffcfdc2d4a8179ccdf1493..15cb6f3b5dfec105e24c8a7e68c7d2ee3ff22877 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 961c116bf858624f7b659c6eab30ffd85f57be79..02c1f9d06a3fab880a2deb7f96aefd97d82253f5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 50a6d224ea9648a1ac94ada47b4d3001755f80f6..1d5252dfe2210b1899be06c7df4c8ff08dbad594 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7f877c63a36a6ccb250e1308d58ae597b24cb85e..f7d1f99e022f0b6abcc308824ce7622fb2c83b10 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 92c4dcbda239a360aa784dfba721c93e47dc125f..aadd565203751877f37db720462e5ecfd0c34c77 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 28987ae3d989e4785ce7cba7c403d7af57787e29..ab303aed43b9362b35f385d27f918c96eec626f3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d0094a4b0436f8aaeb91652b78f4cdfcac28dc3a..44d6984c033693a6e498edf7839a9846d2aa450d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 61748dc95ce88aa001ad88531750cd9048a74994..07b92787471da6bf0102e94f711c07214614cc72 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a071c0ebc36ddb84acd86b10e57ef0dea9823f44..a4efc6f7a7ba79369af376f05ae33c2bded67f61 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index aaa7cac45014d790314c9a7429889a4c4137a206..787f5f11e442232848aeb54bf27d91b5705e307a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b63a08afb0585e15683e23bd96c6b1df5f9f5fee..a41457c7d39306eee5793f9179a645e370df966f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e1d75ee570568fed4db0b85587cb813d0046a316..a32b9de10e3004d7416b29ac5cd3a94e353f211c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 77bb11c734e9c364839cb4f4fdfe9e52987dae6e..28015cc9d5a74706e727b947806fe1290b03c3fa 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index babc220ee567a58a211aa0064da0b8cfc25d8f6f..10781942edf268c71295da6bb71d0b510216c41c 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 88de0c54a9da78c99dd8cb42aeb06599a294a295..6477862ba0630b281146db84115b03ecee3bebe8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d2e1b0d785ccc938d64c1dca124af2a607da0c40..0d78dd030d6bdc2dd370d044021d4578ada256cd 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d17376299e9ab8efa2a98b037c427ea92ea5c7a5..ec2a10b5118da836a6dfc7fb909be86812d4a66c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d297c16dfd05ad3992e6fca36a14d82ac8a924d8..622d5b5c34946e63da37569fee24b13ecc053fd5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 580a215633b75eeb8829e80bba0fbdc1bd59b20b..b7761b1ec5fdee28ce3bed8d1f92ba8542b46022 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9ad620431e7d411785cc84eeb39e1928f7108806..7bd4ad0b68e2ace223fded4eb8510283cef06e07 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 61fe4d9105aa27a3bcf2e60253b4532271d3f826..3b4d2186277fa63f8f4cafa4e00c26540635feb6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c62d52bc7c760dedaf614e72a4cd48dad2dbe148..acc289a0b90e74bca9e164910231f35167a20fa0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 52c02c225ede2a70b44614f16db4ce02b4222932..041528d0196c70483ffddefcd1b77716289f78e3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 32c29383810f3ae3ef70e07c74bd28293faffb7c..cdaa2f47c97d4d7675d4f3846af69855872a95e6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5c24d5d265c17594800b1f567650f0c94474e5ac..32100be23954133f142bf2a17c069e06924f39fe 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 565731a2c0315cf7c08f5f4cc6ab451291fc2cbf..c4beaa56ed0bcdd385743037c6a3b83242af00e4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 70588539357102c6e07a30cacd138611aae05ab6..0396a91b99acdb11c13b6d4f9766309d57d5a026 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 991f5a5b9cecb26991c272b9682153c220d00852..c2c73f12e351b8b93a56f7e628dc299401434ecd 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cdc45b5451b5d7b40c80488d874c71aba46244c1..a7747746837f2a96d415dff3b28b170ed9054b58 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a105879f425578185f13abf80dcb4fedbcbca0d5..5e736baf6790b58864dce7037034e5055acf12d0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3bff19e889629990811ef071d19a3f185555208d..af043c2d717e13754c47ccabdf6b503b7d4ba9e4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 106dd81f92fbc73d7d42c7e4ce1bc458b6f4feb7..2fbdbb5ac5a7959d915e8f0753b0c42b35234391 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 8cc890a429f94bb58eaa07cd0e3b5a764cebf7a6..bc0c3990a97068c88229d9921bda6d27289bf71e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bad77876e6bbaa311568b5affe5952c20bbef448..e632e38f7d9d73fd6fc1da4bac09b8562ed89296 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3996c531897a1ebba5e95821069ba4259d501419..8a4b5b3f42b27c4bcb3a4327e78dea5321398c3c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6dfe09d3fb10d1dab96f0127c3f7c47009055dfe..6f35eebf3ec1665cf4ba7c61a1a2bc899560afba 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index debe73cb7ac9ded51eddb57463e1a6a4c0fb122d..d99971712aac95ae549f0eacdca712896ebc363e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0d18af677de4e817bb386c36e0b755bc41e29e14..3f0ca2cfe6f1118e35d12fcef15771f5bf930d02 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9100aa0957a9785203e707b3636ed3e4ea46773a..c6d75c65f63e169880f6d97c9a7bc60504eb42c5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0969b00b5be7b15f647339c4e37a62d1d134a69e..958e46f14ea2e5bbd1b40f8ce7ea0833bb21ac34 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 623429d119259136cb5e4800e5c63d433f080e4c..09ecf8039ae26df3f30d800fc48addd0975b25fa 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d66f6ceebe6134df3333fcc9a835f353e1171720..1de0ef9a2b74abef9d5809a612eb49a4f2494f66 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a117ecc8ecf350b2cb20dec7e5d6ba4522c98644..39a5ff67ed16258c579c00b9af65eb924b7da979 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 307e06fe6573f4ced1f64484e1b43a79d6a450a8..3560386e78cdb505b755168fa4b7e5961f21e3ff 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2cafddd40abfd489256d0a3d469ec7b1ec6904d5..3ce19a2d281b79a5479823c3daf60e343e0214c5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b2a10496c9bffe72b0e130d07c54af7944d4c4b1..5d55b546e687b483be0bc410ab7cd940b8595a67 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bc7ba4f77093655f8a77d0b3ba0333fc9e639589..983f5081854da8ae1c7b6eaa2fcea8883a04bfa5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 285ff72b0386ada49b99cb21696eb6d8b5ab71f6..3bf4d5c38c539a2fca54a56a4bb61a7d90e4dd83 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 572fc6c171910357f9468021a7559183068ab6ac..1422db062aea4aba84327c29033cc0a688d9fe79 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 755df3315263acb87b516a266179f37fc8790693..fbbb9ad32c769b3920d26ebb557002624bfec258 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3d55ba3e55da95c352ad2aed4a61a3f3d2fe5fe8..75e1ff9583ed87e10da145b2126087b0e7e7f6c4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1b055b046efb30e79d0375dea3e495ccc78cf3f6..ca5ba56afd00c56de4db16fcb9c64439b53ad3de 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a9aae2a9629be0839073a20a4e7426f1a1f12665..17971edc731ed183a6ab776bbcdeb73dd7a3bae0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 109ed2578a165648092cb2ae2fea199d5addf9c3..a0cc18295b1874e5ed4e8089e0ffdee777ddd9c4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 33dd80096c542ea2b12f6385b634274a8c496725..bfc03f0d14495634a9068dbb63fbf1e5e2440be1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 66969cd237833b87a0f03aec9e5da551066565a9..27d334a1eb6bca1a45ebd4dcdf0e2ae6be4034f0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7a5158ff416294bfa813654aca93cf7440badf62..4f56c4fc0b8014c0ddcb2a74ef087ab35e3cbb31 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8ec617c984367ffa152b3aaa05944bd1b66f6b1f..35e0bc1ca190ba60e51e9cac35df2377117f232e 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index e28bcc81ce91f52c6d04fda06380544dbeb282c9..632a4eaa2f15785ac17308d31fcc4b34f04a5d63 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c98007bbb3d9d2c93f8d65540a065a56a19d1afe..9d7ded1755780aee975e1ddcf27283eda1ecca55 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 93a3b161d060b64fa193ca98fd14936b8c333f31..220256c34eed5e29d0cc97b4ef06a9e931b9ac54 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e6b22d6b0609fea7aec21ae28cfbb39559c9a1bf..6fda7e7c490efbf00caecd6348c6ff660b0a01c8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 17cd6d50fc59c5745d05175eeffabf403978429b..f4efe8681fdb9352765e702ce37a3e99b5955014 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 62cf0302c9b977e73b762f48f5e3667b36ca7f01..6e12e2cc4448466404ed1931763ce856aac09fa0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b116ae0db0440a2fa2a8c6290edb0a8c9b9b2fd4..30ab52d7ac71ca2470eec4c5d4e9f6902182581b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e4a734d7fef65d5533f4e4f92a540087ec8ba760..0e70925448beb42830a80b4c5fc227261609426a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index af811775957760d73964998572d9582ce0bb3cee..549811ae46010d36d2efb5636175082a4c9b8925 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 501fd5e02cd4b24e5ed209b8543837248508f06a..4eceaab44f5102c5f01da40a9975b7600122e619 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ba0ab25826a34a3384253ace38cb549b319a6f9a..fe5032b343776ffdefec081082f56ca195aec5f3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2b5c04c3addeec15b9c3de6906b66e5bdd8f6054..39e8b7deeaf1b4158ca3f0bc1218aad73cdc470a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c2c6d56713ee0766031d67c8c92c9510dc0989be..a04450e9d785400b2b5e440974c6a2bdec664fc6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 946a3d7bbab6afeab69cb60f06e23619215e84f1..71f07f5e46060cdaee2fcc59eef40a8d44c84b74 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 50ff102a3a94153d3dfb6224a15f3f4001d1a463..5e1f00157a19837d9c8cf20ffea44fad1b44bd69 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 63484caa047da94e5bee5cf6bffecca6ff42f880..dd6ec78dc6d65a19c23b1c90d2f2647e9d3ba108 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b2187cf9e4b85452ce0923a49d525eedcae0183f..1364da3c0e88ab909990de95e608ee9165ecedf6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2fa5ff4fdcf56fb6e6cf4b6916b715308dba0190..c3efdc14c63e521d562a3239843dea9f8e703c5c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 64097aa4f1c1cddd6b75ae279d733cdca670e416..319e9b388cfeca550111db0ca9dbf3e2c7e23d06 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 09e77343ce008689e857b6056378fd52abefc6b1..9707efbf5dd24ba2775ccf3999db35370d717d34 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d5c002964902033488e9acad183f9e1b92bf91b9..64ad6924d8c85a6173b4f464f8f23f15745bc7d0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d118d6e7c98c96d106430e92546395386776f6fb..0a9ca583dd42f64883b5c35304df2609218dd9d9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index af9a4cfc2c7b8ae5fb3c747a3eea97f6e9f0ee49..f80860e9a058ee7c084b1c79825ed2b94ba6127f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3f7b0356959f01a91d3d236fb784856cccff0459..0827a4b4ebe3447bafeec9cb12423b38e2355c47 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 969ab43eab6a850ff0307c1acbb3b2f9814f8fbc..5e20f0af2c9aa2c69f7407b439246b034cf8f3a5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b1ee409e0001384db3ab2b58cad69b6adec5a4fb..cf180e9508f5ec21e1254d260de6b5f29e9155f3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0c3dd872f3ad3d8cb30cb77801c9d67234918d5d..3659801071a10b3fa2ebd8e088eb30279cf21904 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cb30847a67a74414fbb282c2c26b87cfcfa7e035..f0307c4f011f34ac6f396a64379d734eeaf037b2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7794654ea61481b5726010d0fa0bb9c549b7c3df..13a6e7bd82ae0db29b5d9148db9ab0731f34602b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 152f9ad80d893483562d1e37da080a33d59d8c16..c147d986cb351ffeb3fa705dbe04b66a14ef875d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5e376418b2685d1fba4a454284046fd9c3cbf669..5e395ca02d5ea88f8e727017811965782789d10e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 74d2699737ec928f7211f2044ca30fd716f93fac..1fa4add09ff285a51453d85f1b695bad59654bec 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c4ca3a2590c54487aa94901e29e5c861264567c9..1478252edafafd50ad5b25789547e229fbeead26 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bce7447b70ff907369506bf63005fd61bc59a900..1f053173bf933cbf6e406f846ee85b59920fbb95 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e2addb9d735f264587cb08d168e5897de09016d2..0f7e8131714b7132326e7234941639b8238f2fff 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6489f3b4b473d5810075feb94c4617f215a7506b..b073e9c8e53d7cd466e792eedcaebdcab20941fc 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index da8bc5d08bc05336083555dfaa7468725d2f9509..84633066b8a7701014d0df638f0aaea285f316f7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9263c027f9461eef335c6e409fc060f15c58c186..8a7ebb383924d9153dadf7830bd705a716afe5a7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8d80b3375c900fd1a69978fdd8a9f1084d8b6d9e..6b51e8fe45d08069fea0d0b7e9dd25e98e1b01f7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3cc85da55fbf5483ecd585d5cd10db494dd21d22..84e4de172e654de15ee3afb78e417e09a12f0595 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b60dc63bd0defdb89d0da1ab30f2ed69882ea293..4bd5d15737bec3fc9f8dcaffc68cf9b945c30f46 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 21f2f31620a5ccfd01954b46fc987311420557fc..9ec664eff392bcad59e1ef9f113c7221cc4f17f1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d5e207f270f9aef481bccae7e931c38ca1a2d2e0..b84f54ac3fe3e9fdd674698c352784f184371365 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 82389b698837894c4d903b7c4f6308e7320e92db..ccfc5d1b500145cfa0676e8b781c85cac38fd935 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7c260af61f5d29a70622aea43c570aafc00fa8ed..0cc213ec6d988098744fcfe97ec5353501c72592 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 55d3962fb7f30656b19726ee377833e27cc495c6..ff69dc0da24718a18d976f9417932cbe8d10f5d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a62f504cc87d21ca4adfb502cbf3b16083fbad47..31f63f19c060a853e6463f7e9232c4d3f05f94cb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d8c621f75d369337bba32babf34d73b16e9b8325..54a10a84f7af0d8174a73ca7163a9f72fcb5ddad 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4f269f10afcb01d76158c9d90f544300f9d79c84..37d0612d2f24c1c4314c469edab726d8a716ae9d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 269df569866d4526e2a35309b54aeed424877932..a8778bdc2f34a5289e7aa85e3f736d804632b3da 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 646ba9bb346403c7280df2ccb5c9a833f07a056f..8f025995888c6e535036dd22e7187c7858a63ac4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a80f3cd7e01358c4c17df8195aecbc98ab1c00c6..189f94af0e468c16381ac7bc7a56fe248a991089 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0aa1da74a0a02a6ee0048002f82a044af7942579..33c37dbd85a3c43b94e8f2e6987234a837cdbd63 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 34251756f941776fd1a816658645b44bcd452357..167be0f266a011c5ae3ddd53543bcc392d090975 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4ee98e8cf34fe357398e9d213db8979197bbda9a..d244f1a8ff376028f6b961786045b5253ee436ad 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7ed41245b97f3ae89571ec92aec050bd654ded7f..3eb6bf7494fe127425744be74893126e0ed65edd 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 65a8327ac12bcf4acae124f90e0486885171987e..fac5272aa550a9271cb838856c0b31d0ff5d54da 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index dd21eb232c15ae1f459db37fec4f26c4295efbab..34e5fbcd624190c88ea8b59a0f538cb4c32dda38 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2a1eb87d4c219bb6d0aa7386fafe80ac2f5badc0..7e45ff6c6f2369ca4cab2f4715d8561063d522de 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7f170e032054dd7a685a16f4d00b7ba305a14d40..4b7989991eea61df9a47b61efad8b8279f6260e9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 608e349b548420c898463d94075c99eacf117a67..4e7e3aac6c008fab8ffa8d61cc244401e5328890 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1d10933ff093f88f468f7d67388cbb2b94ff6790..ed752727c6cdf76f6369e9bab6a50ea8c98a1b95 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3f09588d6ff1d3c66e428203f32f315ab432ef2d..cfb66e9e39c72b06b05cc5e2e4c20c7b7619da91 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 97a014bbcce59d3a9aecc386c31cf61967baa0c8..6018a9091fb074e99c835281b420b1e5cd58b7fb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a301dac43ea5fb9ba5a1fd3590fb07982ceac749..a71311ffb00c352b56ed31393fb5db1f56758694 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ea52d3956179e197bfbe53a5a1df9c25b78d447e..b498665e568f84e558a8f31f0dc92abf26876a32 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index abcdea5363e55435ad44f7857c758d3886311aa5..8a46842b6af169c46e604f3a012fe04bc235eae4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1797905dd88fd2113978218adf1bfea1ee88a6c6..6404f1f55b3db25b8dfd79315f52a72892688c18 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 43f8abf80d24904926ff5a047cf70b7eaeda3577..d6be7f73a1e99d1dae1b7c2c107f341f4632a616 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8018699b6d4756ecfecea34d163a6441af197cdc..d0633b14a5dc79ceab490f22a4409b216cb2a006 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7fa9a8cb5d9fac12c47dbdcb7402a09094b14908..943e4a2605cfeee68722e090e7ebb773edf098ca 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e78db0f3c78edff45a90f719bf691a8389f6e735..23b9108ea5c6a3c3a2c2d8bfb5603414d8c6d73e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 177410e87140d69d9afd5dfc5437aa926b714520..742db05a80784e3a7211cc021817419a49dfa554 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index aacdfb8a823b4d61ca54cf68eefe99653dc6326b..248e92468819cf370b6599660f1d7c74a941be19 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fa934d3a46a15ac5702ebc6fa52bc71682a76ce2..e3e368034f365e4b00a14954b4bdb8fdb5562d38 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 27dac84c833b1dd859d2bbc0b32803a32b0a6d95..a057bb5bff048271c601bdbe18b999809f72259f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a6f595ba1c1f05b9818decf4b46d822adcbb96c5..ce4df48111d2e32e5074381c0a8c6c9be01480a5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f6158ff2c0d79f90da548d4bb83ebef587bc62c1..9833794f750d9e60c6bf42ba78f9f563b1c66964 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 662666a03b7a3619a87bbb53ea082429a7c060ad..ec816a71120b0730b4e4195b92020d8246af00e3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3827453eadc7fea83efe0b433bd80291ed8be0ee..ff953563f266d51ae43fc5a5b0a05169b4ee4e32 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 179a753c3d058160a07fba195a636de6163f3f2d..47f2ed6c1b12b7c8489cc4d40e849e1e1b4b4f83 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e1cb74878f4eb7a85db41278c23ae9ad79b8f5b1..5f9bf54b95bb69e3cd5f209fc921c2f41f28204e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 30ef2e2cac771dfe075ae4f6b88f7421d0fa346d..698e3386f941f01f7518efa71b0ade9cf751ad03 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 54e61fbe555d5529730b9cbc85e19e36db8b7140..931a4027b644ef4ef3095081d3f4c0e1ac4dcdb4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bccf71a87e7cfcf7ce1cb873d596dbfacbfc82c7..4e49643f2cc237c431c77249e348b1d6bbbbf812 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 763e24da0a9dc3013138486a7e9f6bc0dc38853e..0678d37a507e1cecb8db27e1840e462f98baed46 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index efe9d52d0bd568e60d56e3da261e18feb1422428..94f2a04bdd5faf11becaca203446fce74a63f377 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2ec64546ca6fbbcd5fa5136f32051fa155f3139a..aa55d28352f96abb5d7ef8e84cf479d386a60e50 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 73307b6d04cb99eee914cdf29291937f7e45f2eb..c21d7a329b9f85412a01e9de8ce55cb0c0f7be15 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 344c5b3a001b9463e05bac1273210a4ce91b9910..e8d711b15dfeb87f5ac84e52efd8cf26beb0ca60 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index dbcc9b1c6a49a732775162afe372f752d8aa7c63..fa0cdb48ee7321e7320a1e28e90edcc8c01a5e36 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cc3cd20b3696c8ebcf1d87cd20bd27e4ac95df86..7e29f42dc0ad0f993468f78c335e18051bd30e82 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4e20fde96c13549679c1c0276baeedb1f0ec55b7..7058c169e02a7baf3321db89997a54b9cc2d20a1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3069c12ef651c0ac8fcc50eeed846251c0bf3d4c..46c0e30f24025e12ab91559f8d473f64e23f3f0f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3a2b1db15cf45e7def2cbcc083e42429ba7c9999..428cf4ac396a3e84d1a4f0e4fffb7b2c90caa81d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9aa26d11a79b68dd46a8946fab41c6fe61af4120..fbbf6fa92577e5bc6a1d5190774052534c7c96e8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 34a09d2079b31e3c16563efb3450ce68f9ecbcd6..939ca94f86b137599d3879d3d18ffed200282d97 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8f8bf0f2fa6210670468ee64d78d46f8136911d8..6c5d1ae2551fc1558c5fbd6c20a75c31425e1471 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 901e5665a4b3d771c225a4efae096371823de7ba..8881c40db6c875cf6473479d01eede2c14776f9c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ccf5502dadeeed898c27178304343b74b1a36b3f..63429a2fc576beaf1e7d461a81100c2096c2a96e 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 62d58b9150ba7ef4af804f2e16cee3ca0e713b1d..8755d3c95cef5fa12d10f8f488838ede59153248 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ac723ddea3eeaa0a84aafae5f2281d02ce63085c..d5f8c5889bbcfca00a7a3375260aae91efdbac9b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6de7024fd7b3c60f7b3540e37c7b07bcf60aafdb..b4aebcc298bde909861cc10679bd20712fb906d6 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 4015c0a6dba9fadda9bf3697b6c7ef495ba78d52..44a5bbbba9bbe8a4cf50f9c17d69538957fdc390 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1bdf2493dd7278d39841dbc9476fa07fb7a26796..81f787a40314ec35018b902e848b23de02411d45 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 29df390576778f231b27f464636068234ac97401..728280c3983e551641402fa3caaec5b1ccab9ed5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 136480afb96480c2a972c35f1e6454f82d95371e..f581285c88720901ca0387b584d4d4e577343bb3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3b7f403c3bcbf95bcdd3ca63856c06eb0163f360..b0c713c69825a2437a19b1d69785b922f81231ba 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a91a9697ce246528011e6add3554637681ebbe63..a6d74b65a81699e2593d9de5f8b03f06ecd1a925 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0406f0444a59883cd1a823f86b0a82ff0267e19e..a0b86d2ef6933aaad65700d10c86e95a070e9a15 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9dc064732873e08c54e87f529f74a04fdda3eca1..e3250108eb36369f22a32f33f0ba583fb6642b80 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 622f73a6a804d91bdf478f1ad9c256e3ca4d2329..e3731bf86c0c232aac3706e022a80d676b4b611c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 873b0ac43f29cc50351ec031d4772d42b969bc17..9bcb471d2f26ff9b5f14b9854e380a767794ae4f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 483d194bdabb0c3e2c5bb0a8d6a39c50b3ed5630..58544cf44b2e992a83b997d32a130bcc14ed829a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ecdea29bf670ff535cb20c883a27791b4da33839..93066d615b89735c76f656fc734735f0613f548b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7abb30f2500d3c80536f74b1e9a81c2db29a8f78..673d937c91f0050beca27ccc59711aa2c9a3a328 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0754ad6b74eac35284cd402d13e389bda7faca67..78c50c405c61c27dd53bc31d609b8bbcfc50361f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index acc68a648acd1d42b008f93c1572860e9c9e27e0..b6ff4427d26c3d113e715ba4defe5f78a737e08e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9e5760e287e26c82fa961ca5bce7cd6158aff7d0..aff3ec0568bf6be4cf5306cf9a111684b4921a93 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c0076a55521f7a5733ffd19ffbf3c1b0519bbd2c..2290eea6de2458fd47fbee6f32e6c791377e40f6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 550822e371fcaf384d24d5e7994fcf10ae43e5a4..18dbfbb6887792c2be226adeac7f954d7d41e5eb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 870f8cf00b65753b0fcb93967501a77a25ac287d..77d38e74ced3bd8d801200a95da23b6340d01c4b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 76ded2bd4cbcfbdd23e43cc64deca43ab6c051ac..7de6c326ba2de8c3cfc92a802455b359f9bf3b08 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a25f7ffb0e9e8dc22f4729553292681f55338e33..6e3c4d89324835693c33ff2be698f88185fde06b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c8156074c7871640ba6838b1ba650a0ad97ae8bc..28d018188d7d5a7d0b49182e601c1a06c38a4eda 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7b762ec0ea21dc469e61dc9aeed96518e936ec70..ae551f29679efc0cce442585a8ad9879bae1a225 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 83e900d883a8d844c41d74ff14937fdf70250414..b5826e91a6d9b60f1dff6c1a6145f947ceed2809 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8d1fb43f05566b729446266d35f238e7a2aa9c05..e01987909e156791646e5254838d746151b7578a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0b477a70f826f8a97c84c7683817dd4f5fc4d33c..7dd8c7e002fc3c15426f77a96101c441e11ebddf 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9cf8da7f17dc0039db0726d9fc5f06b60c91d5a7..1c74b8d588c8540417ae1aabebf564dcf0b67cf8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5cbd89143beea6b4837fe98d7b1f1f630c050bdc..1dd6e930ac4bc5204a5f7b23059bcd101a673878 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ef67690da17cf8b3c299b00a051e216a5eff694a..58310ed6e9f39c295c52a28cc289532642303900 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 475bd0de2ebfbf95a4509d1c48c42082d57aadbb..653d22045bbec9f62844a69e470733c8c18d25fa 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 30b20393c162c4d0c9b41f40e9471994e3dfd6c7..6afc1da10dcb924cb7882412164c7eca56c1c0e1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2879693882b04101e34962c47a1a45e713c9085a..4da18191407f219107057738642ced384105f3a9 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 79767348e3e341994f2f2de7d58cf1e28b077086..e49bbac2e5f4258dd4aee420a967f8ffb61a6d65 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 42c89d352f2a5ac603d465d3b1a8ee46051774d9..e6a1eb5adf5f004572c1f7c63c39763373e6133f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 12810bb924043e3b105725f6b087ce8dc3d1091e..4fe0e8b4b406ae97ac8ddc679cf6aab45bae89a6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 88daf50ab95e53e048695ca62e4d6834515d5f89..20778aa0e10b7ecdff48c09fc8375aa63b148ad7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f9bee31dd4654f4108eb5a83dd7ed7a3812ea9f7..b4f6f6ed37f837282b629466c87920a0a1cdb594 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ad626c0057e7169e4a60a3a70bf7ad78b96d5c53..4a3bb985414913dbd2e19812071a13f6447e502b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0ca1071861892f6048adcd9570080cd8b27455c8..c5f51b2a3c9f849d2db9cd04ea6d1e6ae6694fe6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 693e50b7bc11dbf9bbf1aeaa0fa1aa689aaf8a60..8eb2ff7c6e3b25afa5808a4d218c1e93ad648d55 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2d19da27389841c3d590cd9b663bd5e7ee52b374..ba78eabc147dd99457d6d9c62fae91a650f3540d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6047a210e5e0ed88042eda6a143809a7fd76abec..816fb0658e10a7ab0d77be77fd129ced17e6cfb7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b303065b364be79d3456841dca6af3dd33a2ff62..46b6789d0f82ba63d07cabd26450a0c0c998e9d7 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index b0e443706af77424c21d49facd4ecaf824ba021b..e98cd54e7cd4c6bfc85ba94aa64c2d1503ead32e 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 39c51d7dbcc0e27782ca27c185d463ca10169802..da0ffe254f83abf4e3e7b7b8b9611d566e852cc1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ad54c969d00bb11f439b46f359775bd7f5eae0a4..e0b2bf81f50cd7e83ad8f9984d272a4b0e43957b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5215557add6dedd951ed26c231487116391744fe..6ee11b92cc6b2877b7434ab71f2b592bdd4059e5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4b83e7881afbf19c31171c948e9b5af9aeda51a0..8577504a725d826443fe4a4ee7e5810cc7a7f09d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f649f9efc3bba203fe1d9eee1941519d4f57057b..bd27033248581f8d8cbb6f1e40e5cd8edffdd6b3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9f4b8607d0882d796a0904aaa9b8af56b4136517..c7e296f4809e6d69e589b378026a208854f51f95 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ada2491e6256eb0c9baf6b11713f2f971fd68a40..8e4019f6127d6daacc791e81fc467d2958f66623 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 06c74ae045d7a7768ce8663da642b1d3b9ddd5b3..b59f529135e7c0dfea03d4f9f41474786e1ae01c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index aa47c33e1304870a6a6b4f056509f68b0f4a6f64..4d82d285ff7bce99f884c49bbfd9c6883816416d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4571bb47b1cd57b23bf7e44f51e10bce05547005..9d1f68c753ba2f6cac857cacd1c6677c03f7dd31 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7ecd1f8bf01c5adb3f4e75042fde3ee2467a0e09..a7d8ba6b7c30a47d144d4752d2535230379b3641 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6d7a32ce24caa20cffc5355d85ae04e187d54e77..916a426f98b9cca1af7999bd66c2b02716c46937 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6d90e4bc3fdefc348bd4f0f7233b4a1e5b6033d0..b18ad78868dfa9d60de94ddb9c961090b4c07da2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3c613ba186ea5967167aff6e0bab7b6cfe5042c6..792df619f5602fd5d5887c2d8b23d160822eb67d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e78f64fe2066176db0f34545b684972253cd65d5..1aee0a2a461892d280f8b2a66b2b9e3edf8472d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 717346e4e034d9bccfcf8a5822b283f068a80fe7..9de9ec5eb9cd3160d2e4c246bafc05a1e8ca9482 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 23be6127e3151a5d633030f63a722ba330befeeb..918ca00d31b02e9d334563f14cc374207b691b6c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7ce584f2681ec166d54b6cb084e769a9cef7bdde..ab10bf13a6a2c738d68dd4d06473d7c3900333ae 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2acc51f0d30c00bb0562b50a1e9c6cb49da3d46a..91fc815eb95cc30dede2d4b438cf2a8c8a80879b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 871377e7c6edcf575786a5472426032cdb1e5620..000f162e5ab6c7e9ac2a3bb38a987132e6b3830a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 21d3b42c73b944ff2b54fb757a79eb285e787fad..7968153ad289d9fe0d9debd4f4210360b40e0bf4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1a3896f55f16587735a5f614566956f9e4dffb00..0ef8028af40687a07d6edb96b24c4f2fcba73095 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f0ab96d8cca492da47d64916525249423cc28e9e..856cdcf4c402e84a2c434dec8c72e6630ead1253 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9357db41d516e20d32f3ce67a88cb173fc302b65..588b6f8df584ff0b4ee8f59982708cb09cbb5982 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9651f24d0f6f56911064947fb38578c21d170cc8..5063904fc4c8ab8fc4b1ea930644b8e7d767932b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 74ec0da5dee2f4d50572b280794b2d6ba44367a1..442dbe534c75654b1bb00df9ee3b2ac409dcaa03 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 71264b6dfb42217985c9d977c5069e9d3c4d1f71..af5f06ce9fc58f2ab2cd60cc1cbb338f32a2ad88 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9b7d6ab3086992cff2ee5212376a27c1a3517c99..d8826ebc4c3be24b0e2803a44d9fa874a49419f6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 54da992329461abf7c2270aff6b0e34917044b6f..dbc4233bab4e7ee24a02641c0ad95baf2425fd33 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c398c9bcb1b06b7d417af8fc3d58b6ceedf07cb2..687c4094d08fba8940b70f9945e1417f51a9d321 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 23150ff9f7bd237d22b8ff43e09e0923cd6c8c1d..d87389ece8b61defe6b04f34c1f36606317b0022 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ea20c2fc2e93ed78984f64fd04f02cd1afe2a607..7b075a0d995739e00f2c481035dcc3da4255d6f3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3dc407d48ac48a6ed94ed0d233613df5354c4dcb..e513192246fac1371e35dadbdb8e2d569e8c8fa4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fc7828b810bc777e2183d0d2646017a829dcb2cd..7d5675fe64bfaf2f95a4868e598b9f386173efbf 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f30220d3a4ad7661304d240b0e9799abc592f6c5..b853dbb36fcd74dcd80c23071c0c9f4a185a6376 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 749c2d2a2d38461bd028c98316c0b7f94bf385f5..0f86dd0cecace1154cc1430113f074bbc8153e8f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 394bb6b640d23aabd9f6a619f04557e330308704..2734c4e0e3985cc2b213d031fbcaa14aef1e9781 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 266c39f48af68a8ab571da08ceac4cf1275d5d0f..fe9acd420ea0ce8fc4f49511c565995894a5b5d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3c196b0ab6537be776b6dc8b2d91b075f4d2f589..a684ca78d2ba295a8754e069054179539a53f1d0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0cbcb5af79dd1ac3853044c0260761fe60e8c69d..8dc346dbfc3a9ee1603010de9c6fdc4093e845ce 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 252b1591458f7b97ce27047e3a7a0e4d9bf00df2..e30a9a32e529f7846a4ff66aba96eb52df7da0fe 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4baeef1bd2fd5162e0cb0b5b177f09a9213722ea..4a12d9bfcd9a0633a6603e8e0b5e342258c0b48f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d0f83e3ec28df8416acc98f8c439e7284a0eb87b..842529dee516271cc1d5a06d1c44a7f4056d73ed 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8dd3f47cc2258c5b5457e0d93138f2a1abf6ab6b..14358d2bfa1e466908f72fc13a8b5b30a98b7a4f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1f7284057b96c6a7d9c8d51b6518d7954b9bb01e..253c6bb3cc7dacae3890d9993b3e4a8519d4f156 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e0b9d7fb3e2bb8a1b96a7e05279ef795641476c0..841f3fee2adda4574c47c50a6975e730b03d3a29 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1f6a7ac7bea7feb1b76455725567a904c7ddbdee..dfb2cc25fadc58116fa67a4b320668c682fe5f62 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 24c5d765af43fc11d91132cf6fb42497cbbd9f14..68547df14a83b079fc71a78e31d25aa9ebe798de 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 600e013bb6e7c63a10169024a31732007a570fe5..8f82dffa6c51fea46f1565cbe5ff4d1d80870043 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 330f92f5246675b4b1a1585a68d2c14783e28cea..1b9235331ce2f79eaec6f2ab4b0983e1e67b7618 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 48826eaad2ef7a8f9a54b4698dcf477e78c1982b..a176fb62b9dadee8a47409c1a6d869197b38e4e9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1bbe463d5a73ba47a067553b7f95b4846d9fb87f..2c9ae3a70859f67f803b563da8eff14106b86c4a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a8d3cc365420a97df389b23390c4456cfdf2ee0b..ada5bbf82062a91d811e1744422b0dce5bcdf356 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cb84fb158a32b7cec0e99007ca48dc11983a072c..6408c37292bf62fabcfbb87b658d927d82b3a773 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ce2bffe49aee79c4a08895087ca68ace4bd2c51a..e617a04db3d43ffdaccad95fa59a169f7ec729d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8b7a3995e18b53be1a3f9f41f9963cde1652a6ac..4501599fe6243b0232c958ecb939bac11732a050 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8484ef54b0d9bcc8e1a8df6b4bf7f379bbaf7191..519eb154234dd98a0c5ff5c14b7ebdf53a1b2caa 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9f656b22de188a76d423616687c57fce9db15de6..1cd8296147049f510e3626ae9843212b68078878 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 793ed93c915eff5ca4bf89f7f549da3d1e27a097..fe5c0f43892d7f052c096a0b8fa1ba09ffb725fc 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5fb56ebd9c301aab4298cf9ff42aee78ba71e7dd..d184c149e9c85fc1575d88b188dc2eadcf214f20 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8a6637dc2bfb025f174e6d911a19256addaf0194..4f52dc440bf2939d38150f49f2b7233d944f4f31 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bb8ce2733a455de829a238edc2091cf58c81b2b1..c6a5029f08f9670833f86fb24d7d52ac1c682051 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 914b91952614a79e989ae6a39dce677476317256..ffb3531903303ae5c46b2b0f766680069beeed6c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e9e296de924575bd5562797bb91d53485e0a6aa4..9f2f629718b58af18718596a622319a469c34066 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a698468627302a1d2d0e6cded58985bcda709775..d5adf026b0f10b6ca6e3f5af98ea55ef5c81deff 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6c3c6802cc31ea507c27b5329e520d8431711935..e7890ecee313874b3143c8a7c5e7f547c07e5c20 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f246b4a2060280ba0eb798a105d969d619d084e5..be78e8450b5f3361ba2cc03af40a2f9f9198a57d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f1579e0a018b022717de779c20308883deb6261f..90416293561295276484af4bc7c4f78f455d7f4c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9c9ba64ef37dc51f4593eb6cde47fc9d53ff542c..c06d6897292645cd649517e41dadee741347160f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ff7ee16c58b27d514f39afc645138ca9c079d852..15cb8a43329ed5b59d90cdf81249c9729ba8f032 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1f83f70f3c7585ea94dde4aecf22dceb3d24542e..265f0e40f040115567e53b6cc3ad179ea72da29b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c8f2181590bb048cc0e2c613086c9f0377170159..e24e1fe5e2ecfdd012a1c6a42021a769df7f53d6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c5ab9591fda4eedb9f993b0ba8a2c17fe8cef5df..c0b3d9aed0da083ee35cf0e8e3377546a29773a1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 06407db004d2b37224a8c87df8428d8e67289c9e..72cc5e9298fc8dcd4cf040733cee40a81526f12c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6c1de09b892ac9d550dc0ade1ea6e6b096c9748d..fd6088ec744cba971db5231e1a9a4aeba100289a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 83ff196db1ee14a5c144b40da62e900ff04708b6..a85d9ab7a95314c3603c2c501e8c555b2bc07be2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6c47c071a569587d3dfc403e2b04bdea1a1ae4f5..c9e6629eff6ce8f55559b46fd6b7fd62e400335c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 07249b7dc7c7db06005a32e270035d06910a20d2..3529b6e22f61871cea8a6ea37508ae6128722827 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 218eb655e54a784910aad2f5ed9a1c1d84d2d0f2..441b5c6d0de57e4faa4afadde2494aff6567b350 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f7c5e8305adbefcc05a8195eedd066bd6b30e530..bfcb2cf4a99a0dd3db62695f016d001a7bf5df83 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 817590400c234d971b163dffc38b6b52232a8bb6..d2eeb73c5da5337d410ed81468dc87a07b11a345 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fbe566095b7b41a5d553bf549cd0c0c7054f7814..a0c0a90e2ef0e16dcfb678de1e79dfa712a6e80c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 308f978e91ec82770935505eb5579daeae05ff03..085f136551d949078b7daa97a608c3a2af4db66d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4ac6c92d2bd5b698fd5326a0ec9c4c0890b7985c..457ca21eec63435842ac8849e4c88b2c2dd7b37a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c92bf6791f2cb37f54e99109750a93d2814ad837..d1b5b74a00740db8448e96774ad3d1f002f26957 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cd1e12d688c471eb1e33ace177f83af9bb7ca079..476bb5649afc38705196ba119981818187a16627 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 00d8e48c3bebcc0f80ce42b3d7adf33a1537248e..7d53a869c48baecb4c0f887ec8739a2b048281cb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b69d661b61875be1866a46642b0066704f17ad42..11b4f1f200d6732bd16608586cb33a434af706cf 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 62ef5c22076146e5f5d7e07f87bdfccd049a1102..22c97b97f9e52957dda0cc7d9b3e8176f9109f6c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 92d4cd388b06f626adc6b633c709453325be2027..a1d7d1ed97940401862b775176c9de349c4c0879 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index bb5a20a5c799d08b9ff76e773849b3464b56b635..7a9328b76be5ce09395e1493a8563cbc3deb55c5 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8e451b3381f9d398b20484c4246fddeaf7894784..2e2d861cb9ec469ead4c0cb52f1813bdc63692a3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cd9a106822998ee835d31a1d6a74924b192fe338..bc29759d9a113189543d004b9b168513fcbd9ce4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bcc14e75434574f7d3969d5fff0253a948bb9291..5be002385dcf17aea77e66ea313d29579555a433 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 157a311eba44a64ecaa849709a10c3e9d5786209..fd8cff5596b52e96b00633223f07a9308c89f1a4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0f6758d32e2db2b4209bf6e8b6d7574077880743..48de91e411c06656ae2d426cda5ac6a1cf048381 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 57293d52c1525538150160b16e7f8440c55500dd..8d0fe0d7359e2aa2c5c282cc770320b963b87dd9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b7cdcee9761b5325e52fc3e404a79d20175171db..942891ded802b8064504430e773f42025ad91e45 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bc744b85a4a1c16ed490998722f5bb2250881a13..a5bdbf79c239bad46291536b3dcf1f3ee1e05138 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index dbea07c4ff7539025ad667542c7dea585e7fcc40..557829dbadff047e264ac91140f0279638d89fe6 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 75d0e18dab68f1af6b2baef717545fc34f21b7d3..ad7594ed4abb015cab31eb1678feb5465b6a0055 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1f7910e0eeb7393606497f403c0cfedc70a311cc..58878c3de34669ec426872210387d7a050c51237 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 16471f2583b51bc89605909d33fe67707419b129..b270afc598598c17e9fa29d6c2a14bd83ce6e0e9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 72cda9c42a6b5cc48e890bba0b22755633e9e712..c481784f102685e213408658ec4122b012a56f43 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d1b3faa343344ad19133e9b5fb7e49b6ae0f1a10..6dc19fa216e79153c109fb54a2201ad8a44df4ee 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 48b71fca66f58bd18e8ca84ae67815b2516ec708..fc35b7c4c20493480962700b9fffbd1f7be7d5e0 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 06b6981053f1ca0916d686ef40b21ab8caa53f52..0b60cf2f0bf97e957674370753f2d0c804999871 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c8cd725e874a5eb20605123741da2df0680684b0..5d61d03c7ab7fc2d21f23cfee9f25a05623d0da4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d44135f8f8cde0e04eac04a7df5f5df5c0caa8a5..721bf4a83a3801bf4de82561024177f7ebc29b75 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 950f561671b4ac7ebd1eb703343fbb530ba0cb31..5e3231fd9edcf2f6a203776016bbf894ad4e4815 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 08960c0acdc9873c444cf351a915b4db8399bdc0..e8703c663536b8644549280949f022ba30da7f72 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6bac418cea84a3062dc16431991f1f8443ff67b0..cf997ecd8daa9ec5f8ff34412bfe477dc6c963f3 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 54d7bdeafc959f7f2e79cf508fd9be609b28a572..237b807a63ebf02f6d359e0f97c9ef2e3571396e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d32a8400600327b2e5edf83622c503a309e9e33e..1bd6145c58a5f4dba2283d5e8e035139e7ab2373 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6e86718c0a1ab289c0735e92da1e95d6d43868fb..d45b9ee51ab7d48361ebb4225f3b73c705a0eb08 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e98b8ade0ff87beeacb3fd40a812b07e592ee19b..1cb16e1dadb55d6a4e46a1cfa247e8e37f9cafbe 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ba1551bb95ff831202d47ac5cee7a6cac9681654..df9ad617ae8140c8b84eeeabfb77691a7d3cf4e6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 270e086b6b0f3fe6a0a965e1abb910a6038c144e..2491561de8eacf101be8f5e3d0ee4b752ec4d53a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e5ba889464095e24cfaa15d093c31d1d814c24bd..0e1a04ba11f0145486d7c983f131a85bd4bdcfae 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 568fc0a0ce4b9dcf66570e1db03ff06a1832c250..37a60222253f4991a17e96468392a5842e25906b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 45e69bb56e0da94f1b95a117a3f8c823669d011d..70060ee39386663bbf343e7b4ac500754896ea96 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 26d4fe47a92cb2b685246f47210ebd093227cde6..898b24b9162a22a13a6c1561b967a8c7b30468ef 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c0c8105e17d3cd61d6e50002ad678f188db23636..92c5d06433e6ffbb36bf3b12394c6aa07cf49a50 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 440703b6a3d88b1611c8d969980c094afe9348bf..7396a119c020ba3dbec8f0b337b6c806085ccd6f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2f4d4e0f4871535499524dc45ea94c5fdf1a7cc6..6d9ccbb32a9afc76dde191d942fd6c21a3cdfa45 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 2e5a07a018e6f8a97da6679def33f873312e3dae..4d5be8085e0637434942ea0bc3c8b692d3c63830 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index fa3ddaa833230ecd540f779a6234bed1102456dd..c1dcd9e5746d6d7557ae1d06aad90bc14270dcc8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 43b3150d73558f54d18c9d5a1e0ce906d16663e0..c1b363fc61c232f5eaaa82f09e68db21ae02ab19 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f5eac28687a8507e5e7c9185db54eac155033879..67f5568b683958ca9b64e3a9b8bacd237a1c6cb3 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 78b79b6a744d9a4c5aa7a23c7cd2581b7027e4fb..3ac3ed186d577c7a54bf85ff123accea989552e7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 644f97e10cf4fb91ffce2dc87e3eee5ee88ea981..83ab6315fd909e30c19bf88484c084fa85a658a2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 46d2cf57fa16e92da00267c5d397fe2f55685989..9947e83fc8f29a071cb473aa5f0fa7f5d7ea405a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 03a4f0503b2180d71c3179bc2df54a61402f5907..1d2cf2612df3191db355f83bc49051c1a63b6080 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a3245de343fe9345b1aad04c22d4e2b2ea865acc..a040fd05d1bc20203246ee7b00f40ea234ede955 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0da348b0eb944721b08bd02a2b09d5c2a0141b9e..f5ae7d5b7cc224f57d1c88f50367284a40919d0b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9f013bb780bf82562f0384379d89699a4529739d..39448e6bb2b9772b6b488487569d7ee9668a5296 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7529fe074282ace3353f59be68bf00c88c17e8a5..dec9e06639783f1c277d372717a6c68275ef2e39 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bbb56564b8fdf8105c04ef8bb925eadcecec9899..7fccf963895d792c4c46cac1cdf2789d7a5d7adb 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 140c3c8bee893c035025b6830100a37b6855acf7..89f246ebb5fbabf25646560df956928ada18849d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8db34885eba7abdfbc4f72f182ea58277ef3c6c0..ea7bf41d152d06ab5862bfcb1540ce3768cae93f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0d8ce992a57f4169813bac45134d55c0358cf5df..6f75bd1748a8dcc1cac282e66f77c8a40d27927b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 19e51a7feacb7bdceaa1b22e76dae6b26e476d13..2f2c8a3023085c57b2bc7163a80a228c0b7e555c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8c861825000674504292aed31a94b08453b59643..fcd5e9e6ed80c8d18461df738c2ee65db3722350 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8e469cfdab916f83e0abe069e5d01256e6c65924..fb3097f90c96f0369f04b5146be4843d01021307 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2b98ae709c757b711c48af1c8ec1a6e4436c3665..0cfb9a42959968506695789ad72f433f166eae37 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4d36c2a274c8eb71bd1fb18a717c4ad9e16402e7..3bcf68753bcc63de0c5a405911745713930f7a5b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f0fa2af021e2e0789f311e10fe04ee8f2174a82d..ce7c4375d05a0f0795af382aaa13e9467df8736d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index e5bd170f8ce3f753731cdf87c2efd34e39bb5fd6..7d3c091b9e84c3572ae76fe4f4d431d7a5e68c10 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b094468ca44602ef0fbbf59747aa8247f13d2e97..5031949597498aa0d6c05530c8da312c580614a7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 75a34b552cb4c59318acfe510ed09daa9c122a4a..dd9e3cfe5e32de93518c51d9f43507de60a40915 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 4709b890dee91f55f3e6deba5870ad3c5c1d83da..eafc53b772924aa14c750274b48c1d622ebfa84d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 697b9dff1dac652e39cff1d569c9722ea86c5634..5fd9c9a088a24302f47e8a447d199c3682a6778c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8bf990002c0c4ab83dd98806ad28f04adb0dfa27..31d35d17723b474cefabdf5cf84167cd9da313c6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3ba0467c43a29229068260b17b5a2c1e1a72cce1..409f59745a3e62663dd93dd1a657b350a653f9a2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f3396747b9f87425c8064a3886f8372f367f7254..db02ba8728f12ed507bf5be9423ae35088044d44 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9db645eb3b27136e86ecc7c3e986ae9c6dd140c7..f42421f802c046a475da949e150a45184b4f6873 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6050b74c8adf28c3f9f31d34cecf89be38115a15..9f49484ad68755043d42be199e57e10133077e8f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1a46dd9cc772c8f30865562ba76dba927cb7a438..fb8f501e255d3d47c4969fe9a62eb3d41d7aa42e 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 73c34c503bbd15337fd3bbd4dfe9a92a9e691851..dd0bfb7faae6d3e5b9dfb26ee1a9aa4a7e4f7ac7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2cc0df237072548976284eef232418a545e1b0ea..844e758c358d4179ecec2d5d4af08508d8d32b25 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 925c1ed96394cb816ebdbcfd4f9a9034ed48175f..8059aa8c945741c285538a9d7129b1a30031bc0c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7556be3c814ab647233a0f8044d5be4476fb262e..9d99e68c5a246ab30166a78c9e7d0554e76bab64 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index eac1103d007e26d4fcffa51925bf82cac67d7c18..3f2e565e1984247fbf6057b125877e6359f7dddf 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 818522936c4a0c2a65b733aa3feb7e78471ecb11..60fdd8fae5e6949ef17757081c8edd509be7cf94 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 22466c77c4728f52bafaede2e50c43942b5d4e13..2edcf9aee202f005b890e5a6cc35d67918dab4c7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f7d10f9326a48b6f38f9079158125403f13afad2..bb267dc34c687d5dea7e51ef3475f6da08cf3de1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f13eeafb52dd9971e34f117d3e924ca65c6b8379..12458b6b3a2a7916fbd72bba8562ea0d0625e431 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 01db66dab79b2af9b9cdf77d5dabf57438b14f25..604e924d34fb6ba7488aae2900849cbfaf8128c9 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ae07806cd3dc972f494d77e6c49faeb38fd0f8a6..6b38410ab45073c1ab1b9ac902612670e6903162 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2429ec7b41e8daf4aa4de1f4c0c8ddcc2a259b7e..e680e3a16b510025ff4e548c1c3900f0a20c55f1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2cbacdd638284fc42978cf32dfefb52d5d446f07..960786333d0979c1ce8c9c7cece5f82583fbaa39 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 571e91d26c23a9925b0cbf78845106f2c64b65a5..2388f4d878357a9351b676a813fbe556d0ea4a48 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ce4ca4d5cdccbc31d63c61b56f96977dcdec8f1f..e3a12974feb827f3353ce0ea1ec7f6ee5d3fb5e0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0ede9e500fbd6e6ad6982ffbd6bbdf329833e50a..aaf2a63ee73c3de78d4d4f992f23ddb23ff29b29 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d215e88ca573e3b2ee3e14d9ea00c7dd48c38577..5fc9d7bf1cc25e3b138447c94e0bbbe204ea1334 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 2d6b205c1ec5ba0ad325eea09bef521d034e44d8..b8418c43eb80443e0cbe378072bb8fba7d2486bc 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index dde35d8c0e8438e0bdcb52e4d9fbe699633ad887..3427c3455c718fcf62ff07f43c8a135e08769980 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9a52fc556aa6aa1f91154dd6f406ab6fa6f37950..e4457339a366746f117a63d0178ad0ce07f0a79f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9b752530f62b7ea7977fc2199387190a0e6b685e..7897902fc0c41449eba3638f5cf98cb62fd97376 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 53d8fef3dd24fac7df383dc10084ef9afd4ff627..2fe1aba080878d56732e6e31bab747f864cebe96 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 264b09f25c04e001105518bb2f29cb86dd034565..f1d3229d2999c134ac19d4de5af3240ef714f1d2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b542ac72b97b154cc609f69566cc3ba8ed738709..3b00dcefcd612d1f30e422cec686ecc8600b1cab 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7cc9ed69aae5979a3a5617f85c68ed0f2558a16f..a0ef0f7994210167fb8f0b8dfef06b56ba9606d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index f0d35f53c55999b0206de5db3e03993cde168464..d3dc407e683f175fad4787d587c8f4fefc661f20 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b4f3eb2e80905d2f9cf6c4b6659a90c66650c8a1..3efaa572fe67527711ec814b90a6b39b221a6022 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index d1cc9589593a5090276a164e44b3451fc0ebbf7f..28517895bb5f7be9eb2b21e7ef2ff57cebce1dec 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 3732b0eebc2c4428bc0de910411744a23e7e3154..d0a3cec2271d7c9c1e67c25eaf3da4089a484524 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cf739844048f152fdf57de58c2c448008ffb95cf..21de33af6ea8e58dfd654918ed94cf5cf8ea2f05 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ae9a28babec5e10da940f5e57dd0201e6307778a..b2a7641ec9c2ee068f5d1301336d1c2f81551f3f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a3c87c347588a3e4efa7bab6349e2c42a8608d3e..c475bc3b53ad3456cb1b6b178715a6c82223936a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0a30d20db9cc4766025cd7416ad78fd8b404797f..1eee77e5945d0bf873bf239f73786ccfd28e47c0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 96f2259bf4b62189811fe319dfba714756b81f6e..b83f625c15af0b14a73177378565ec5ef3fc741d 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cc2bb8795514ee57a5cbc1984fa4f56d0c69363d..c312b983f95e18be70a3530d9ee14ea7c16c015a 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 37ca69f25c6ba7341abe69571314b712229b49b8..af34958841263b7900b33d62134a9bddedfa2502 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index eca8d80a594a53351d4554373a398bb15b34118c..f19bc7a3e3e97d00298414bc961a7800c71bf9b0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0cc45473719b67ef1c64675b82cad8f047f4730c..a1d9ece20d99df20c97bf9f353483d031dcb2b2f 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5976c420ca720294362c39657b2bd021f5e6691c..8fd28bd00eecf623ddb1423168b0082a1b872de7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9e9f4085049b3965b1653e8510e8d627f6e46f92..b1d1bbd068a2be0da381cfcccb44efc9bf9c43c4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 491ca6443280ba4b9c89fb46d97b0ff68fac60d2..93f6571e0c2e59aa8f3b3ea576dfda7fcc431829 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 1288f5e5b1a33fd4099ae04b162632a6d6faf265..3b5f974427600a9291c48d8b1c021df28d944ba1 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7a78dbbfe1b9cb05e40c1ce9f9f9fb6cb34c0eb2..6427f93b56167fb10faf3c056686163cb8e76dd5 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 74c8710a86cbe6dfb5bb40275576b40d5f3e3268..220469f68eb86d74017181d6c58e02dd8fc23501 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 9af64276bcfaa3d8646b2c6e36a196731c5dbfad..441070b4cac82592ab7aa9d8a1719aeeb58890df 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index a299fbd36797e273406fb7a28d4d9b9838742843..a209d542852e004516cf40ae4bd47bb60119b1f7 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 224de1263b17cd8c626acdb12e3ada43955be122..f319857c402d5eabea700fb05eb5348f90c5c917 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c9bfa1cf0647cace4468b59a5a6e9193b446c624..0d605778c2e8aa0fb6ca17bec2f2274476c14768 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ccaf447bc691b489cb64acfb60dffa6f2517b2e0..da79fea4f59d10be2ddef47592c47d0e737e3e07 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 7cbeef979416138e7cdce2d5eeaeab0ad9555a3a..1b93819841e493652788cf1cfe63d3a485e98eaa 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 39d31380640ff6b0b9d431068cb06a3c7d14479c..d911d3ef1cd84ab6c6c654aa71e56ef1ab653121 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 88b61861db6713d474fc8d9e604a43368964faa1..1748f1f198446d44eb553ccaa863b6f20519d1d4 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 5e51ce216dbbeb166d1f4ad8406c1a951e2a1787..8d79d12fc477cbfb995faf222dfc56279729ee83 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index dd61db2beeb39201d468d12b21e92cbd7962c4b9..e885f1320c7620c01aa5fba4d9a52125effba03b 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 0e4276baa22004bc07ac264d90fae79acbc17553..d47b7a3c68beff2d1cfa3bf4dad5bf59e83a35a6 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index b02725d8b67cb34a26033eb747b1792a86349554..6df47ad6623311501c4e5bc6c176f698345fc046 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 23d1d939f047219056033eaf7fbf810638e3027b..716988d00a7e4356774f8d6834f8f4f64771f020 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 8548b2003d713610634d84ea4d060376d2dd504e..2513465a65a30b7a378e6d62de832ca4db424bb2 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 74b3e444f53e3805f5b1998599956da8d69ec85a..ed334c55eaec42da77854311955f0ef60d972bb0 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index bbd6361f6647d41d0a3ff13221c7d8926f1739b8..1b5b58a4259ee00b7994bee1b6efd95882ed91ee 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 392846dc2cdef2a214d7a245ed89659f399b5930..78c4589ab8c09d104cdb6f3382a3f54b246530a6 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 62d884a604680a2342dae297c6fc0b42f2debe22..c9803576ccee63c405e70f12c94af9aaa8768c04 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index c3c6fc04d570ba8126f54c8daef97d52620522f0..c07246b8888e5c0c7c2085690a0bc87cf8a676e8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index ae3a98683db5da68fa1a12046e17160d654cc0c0..8f1125216d1e5274e5e79187ae9dd47da02352e8 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 99da0c26e2213d38e9cbefe57d21fe24cc03a7a5..80d44b3c341632caffc404d9e887642b3e48ff5c 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 52887b1db4b39471210899fdc9f7cd1ed39e10ff..af968c46d56b3dc05f3146af82528d20d44b3e99 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index cf5fe4eb80cd9012db7b48afa04f399cca339910..cc39dc20c906168e99c561bb0199fc077d164182 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index 6c1b3136f4f17245949379656e96f65df0160253..a92d8eb06e35b306fade06fe71f08241d3e30bca 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 // ---------------------------------------------------------------------
 
index c21a9125a5505862520b3b9a69e34da401d8f2a4..e7dca9c723cb898dbb4a0aa6bca7cdfbe0515521 100644 (file)
@@ -8,8 +8,8 @@
 ## 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.
+## The full text of the license can be found in the file LICENSE.md at
+## the top level directory of deal.II.
 ##
 ## ---------------------------------------------------------------------
 
index 528d6e6d9a447a2add3da0a400aab05bf464c1bf..4cca4567c8281ac4756f9a27bfce5bf0e7f3c860 100644 (file)
@@ -8,8 +8,8 @@
 //    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.
+//    The full text of the license can be found in the file LICENSE.md at
+//    the top level directory of deal.II.
 //
 //-----------------------------------------------------------
 
index 52ec8dd0da9bf94aa50ef6ac877cd29a5ace5fd5..701001789dc1a740f57777fb053f42757a204f47 100644 (file)
@@ -8,8 +8,8 @@
 // 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.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
 //
 //-----------------------------------------------------------
 
index 9d9be70f2fc5bc20d53a3bab4c62407fa822e71e..4da0b8c1c6e6156378913e07073a5f33933de153 100644 (file)
@@ -8,8 +8,8 @@
 //    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.
+//    The full text of the license can be found in the file LICENSE.md at
+//    the top level directory of deal.II.
 //
 //-----------------------------------------------------------
 
index 62029ed2300818354553746c53d35197b0d63f7b..c5cf473c3fcb6b8d4d9fc7975638ca6d16621552 100644 (file)
@@ -8,8 +8,8 @@
 //    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.
+//    The full text of the license can be found in the file LICENSE.md at
+//    the top level directory of deal.II.
 //
 //-----------------------------------------------------------
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.